int main(int argc, char* argv[]) { if (MPI_Init(&argc, &argv) != MPI_SUCCESS) { cerr << "Coudln't initialize MPI." << endl; abort(); } MPI_Comm comm = MPI_COMM_WORLD; int rank = 0, comm_size = 0; MPI_Comm_rank(comm, &rank); MPI_Comm_size(comm, &comm_size); float zoltan_version; if (Zoltan_Initialize(argc, argv, &zoltan_version) != ZOLTAN_OK) { cout << "Zoltan_Initialize failed" << endl; abort(); } Dccrg<std::array<int, 2>> grid; const std::array<uint64_t, 3> grid_length = {{18, 18, 1}}; grid .set_initial_length(grid_length) .set_neighborhood_length(2) .set_maximum_refinement_level(0) .set_periodic(true, true, true) .set_load_balancing_method("RANDOM") .initialize(comm); /* Use a neighborhood like this in the z plane: O.O.O ..... O.X.O ..... O.O.O and play 4 interlaced games simultaneously. */ typedef dccrg::Types<3>::neighborhood_item_t neigh_t; const std::vector<neigh_t> neighborhood{ {-2, -2, 0}, {-2, 0, 0}, {-2, 2, 0}, { 0, -2, 0}, { 0, 2, 0}, { 2, -2, 0}, { 2, 0, 0}, { 2, 2, 0} }; const int neighborhood_id = 1; if (!grid.add_neighborhood(neighborhood_id, neighborhood)) { std::cerr << __FILE__ << ":" << __LINE__ << " Couldn't set neighborhood" << std::endl; abort(); } // initial condition const std::unordered_set<uint64_t> live_cells = get_live_cells(grid_length[0], 0); for (const uint64_t cell: live_cells) { auto* const cell_data = grid[cell]; if (cell_data != nullptr) { (*cell_data)[0] = 1; } } // every process outputs the game state into its own file ostringstream basename, suffix(".vtk"); basename << "tests/user_neighborhood/general_neighborhood_" << rank << "_"; ofstream outfile, visit_file; // visualize the game with visit -o game_of_life_test.visit if (rank == 0) { visit_file.open("tests/user_neighborhood/general_neighborhood.visit"); visit_file << "!NBLOCKS " << comm_size << endl; } #define TIME_STEPS 36 for (int step = 0; step < TIME_STEPS; step++) { grid.balance_load(); grid.update_copies_of_remote_neighbors(neighborhood_id); // check that the result is correct if (step % 4 == 0) { const std::unordered_set<uint64_t> live_cells = get_live_cells(grid_length[0], step); for (const auto& cell: grid.local_cells(neighborhood_id)) { if ((*cell.data)[0] == 0) { if (live_cells.count(cell.id) > 0) { std::cerr << __FILE__ << ":" << __LINE__ << " Cell " << cell.id << " shouldn't be alive on step " << step << endl; abort(); } } else { if (live_cells.count(cell.id) == 0) { std::cerr << __FILE__ << ":" << __LINE__ << " Cell " << cell.id << " should be alive on step " << step << endl; abort(); } } } } // write the game state into a file named according to the current time step string current_output_name(""); ostringstream step_string; step_string.fill('0'); step_string.width(5); step_string << step; current_output_name += basename.str(); current_output_name += step_string.str(); current_output_name += suffix.str(); // visualize the game with visit -o game_of_life_test.visit if (rank == 0) { for (int process = 0; process < comm_size; process++) { visit_file << "general_neighborhood_" << process << "_" << step_string.str() << suffix.str() << endl; } } // write the grid into a file vector<uint64_t> cells = grid.get_cells(); sort(cells.begin(), cells.end()); grid.write_vtk_file(current_output_name.c_str()); // prepare to write the game data into the same file outfile.open(current_output_name.c_str(), ofstream::app); outfile << "CELL_DATA " << cells.size() << endl; // go through the grids cells and write their state into the file outfile << "SCALARS is_alive float 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (const uint64_t cell: cells) { const auto* const cell_data = grid[cell]; if ((*cell_data)[0] == 1) { // color live cells of interlaced games differently const Types<3>::indices_t indices = grid.mapping.get_indices(cell); outfile << 1 + indices[0] % 2 + (indices[1] % 2) * 2; } else { outfile << 0; } outfile << endl; } // write each cells live neighbor count outfile << "SCALARS live_neighbor_count float 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (const uint64_t cell: cells) { const auto* const cell_data = grid[cell]; outfile << (*cell_data)[1] << endl; } // write each cells neighbor count outfile << "SCALARS neighbors int 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (const uint64_t cell: cells) { const auto* const neighbors = grid.get_neighbors_of(cell); outfile << neighbors->size() << endl; } // write each cells process outfile << "SCALARS process int 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (size_t i = 0; i < cells.size(); i++) { outfile << rank << endl; } // write each cells id outfile << "SCALARS id int 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (const uint64_t cell: cells) { outfile << cell << endl; } outfile.close(); // get live neighbor counts for (const auto& cell: grid.local_cells(neighborhood_id)) { (*cell.data)[1] = 0; for (const auto& neighbor: cell.neighbors_of) { if ((*neighbor.data)[0] == 1) { (*cell.data)[1]++; } } } // calculate the next turn for (const auto& cell: grid.local_cells(neighborhood_id)) { if ((*cell.data)[1] == 3) { (*cell.data)[0] = 1; } else if ((*cell.data)[1] != 2) { (*cell.data)[0] = 0; } } } MPI_Finalize(); return EXIT_SUCCESS; }
int main(int argc, char* argv[]) { environment env(argc, argv); communicator comm; clock_t before, after; float zoltan_version; if (Zoltan_Initialize(argc, argv, &zoltan_version) != ZOLTAN_OK) { cout << "Zoltan_Initialize failed" << endl; exit(EXIT_FAILURE); } if (comm.rank() == 0) { cout << "Using Zoltan version " << zoltan_version << endl; } Dccrg<int, ArbitraryGeometry> grid; #define GRID_SIZE 2 #define CELL_SIZE (1.0 / GRID_SIZE) vector<double> x_coordinates, y_coordinates, z_coordinates; for (int i = 0; i <= GRID_SIZE; i++) { x_coordinates.push_back(i * CELL_SIZE); } y_coordinates.push_back(0); y_coordinates.push_back(1); z_coordinates.push_back(0); z_coordinates.push_back(1); grid.set_geometry(x_coordinates, y_coordinates, z_coordinates); #define NEIGHBORHOOD_SIZE 1 grid.initialize(comm, "RANDOM", NEIGHBORHOOD_SIZE, 5); if (comm.rank() == 0) { cout << "Maximum refinement level of the grid: " << grid.get_maximum_refinement_level() << endl; cout << "Number of cells: " << (x_coordinates.size() - 1) * (y_coordinates.size() - 1) * (z_coordinates.size() - 1) << endl << endl; } // every process outputs the game state into its own file ostringstream basename, suffix(".vtk"); basename << "unrefine_simple_" << comm.rank() << "_"; ofstream outfile, visit_file; // visualize the game with visit -o game_of_life_test.visit if (comm.rank() == 0) { visit_file.open("unrefine_simple.visit"); visit_file << "!NBLOCKS " << comm.size() << endl; } #define TIME_STEPS 8 for (int step = 0; step < TIME_STEPS; step++) { if (comm.rank() == 0) { cout << "step " << step << endl; } grid.balance_load(); vector<uint64_t> cells = grid.get_cells(); sort(cells.begin(), cells.end()); // write the game state into a file named according to the current time step string current_output_name(""); ostringstream step_string; step_string.fill('0'); step_string.width(5); step_string << step; current_output_name += basename.str(); current_output_name += step_string.str(); current_output_name += suffix.str(); // visualize the game with visit -o game_of_life_test.visit if (comm.rank() == 0) { for (int process = 0; process < comm.size(); process++) { visit_file << "unrefine_simple_" << process << "_" << step_string.str() << suffix.str() << endl; } } // write the grid into a file grid.write_vtk_file(current_output_name.c_str()); // prepare to write the game data into the same file outfile.open(current_output_name.c_str(), ofstream::app); outfile << "CELL_DATA " << cells.size() << endl; // write each cells neighbor count outfile << "SCALARS neighbors int 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (vector<uint64_t>::const_iterator cell = cells.begin(); cell != cells.end(); cell++) { const vector<uint64_t>* neighbors = grid.get_neighbors(*cell); outfile << neighbors->size() << endl; } // write each cells process outfile << "SCALARS process int 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (vector<uint64_t>::const_iterator cell = cells.begin(); cell != cells.end(); cell++) { outfile << comm.rank() << endl; } // write each cells id outfile << "SCALARS id int 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (vector<uint64_t>::const_iterator cell = cells.begin(); cell != cells.end(); cell++) { outfile << *cell << endl; } outfile.close(); before = clock(); // refine / unrefine the smallest cell that is closest to the grid starting corner if (step < 4) { /*// unrefine all cells in the grid for (vector<uint64_t>::const_iterator cell = cells.begin(); cell != cells.end(); cell++) { grid.unrefine_completely(*cell); } cout << "unrefined 1" << endl;*/ grid.refine_completely_at(0.0001 * CELL_SIZE, 0.0001 * CELL_SIZE, 0.0001 * CELL_SIZE); /*for (vector<uint64_t>::const_iterator cell = cells.begin(); cell != cells.end(); cell++) { grid.unrefine_completely(*cell); } cout << "unrefined 2" << endl;*/ } else { grid.unrefine_completely_at(0.0001 * CELL_SIZE, 0.0001 * CELL_SIZE, 0.0001 * CELL_SIZE); } vector<uint64_t> new_cells = grid.stop_refining(); after = clock(); cout << "Process " << comm.rank() <<": Refining / unrefining took " << double(after - before) / CLOCKS_PER_SEC << " seconds, " << new_cells.size() << " new cells created" << endl; } if (comm.rank() == 0) { visit_file.close(); } return EXIT_SUCCESS; }
int main(int argc, char* argv[]) { if (MPI_Init(&argc, &argv) != MPI_SUCCESS) { cerr << "Coudln't initialize MPI." << endl; abort(); } MPI_Comm comm = MPI_COMM_WORLD; int rank = 0, comm_size = 0; MPI_Comm_rank(comm, &rank); MPI_Comm_size(comm, &comm_size); float zoltan_version; if (Zoltan_Initialize(argc, argv, &zoltan_version) != ZOLTAN_OK) { cout << "Zoltan_Initialize failed" << endl; exit(EXIT_FAILURE); } Dccrg<Cell, Stretched_Cartesian_Geometry> grid; constexpr size_t GRID_SIZE = 2; constexpr unsigned int NEIGHBORHOOD_SIZE = 1; grid .set_initial_length({GRID_SIZE, 1, 1}) .set_neighborhood_length(NEIGHBORHOOD_SIZE) .set_maximum_refinement_level(-1) .set_load_balancing_method("RANDOM") .initialize(comm); constexpr double CELL_SIZE = 1.0 / GRID_SIZE; Stretched_Cartesian_Geometry::Parameters geom_params; for (size_t i = 0; i <= GRID_SIZE; i++) { geom_params.coordinates[0].push_back(i * CELL_SIZE); } geom_params.coordinates[1].push_back(0); geom_params.coordinates[1].push_back(0.5); geom_params.coordinates[2].push_back(0); geom_params.coordinates[2].push_back(0.5); grid.set_geometry(geom_params); // every process outputs the game state into its own file ostringstream basename, suffix(".vtk"); basename << "refine_simple_" << rank << "_"; ofstream outfile, visit_file; // visualize the game with visit -o game_of_life_test.visit if (rank == 0) { visit_file.open("tests/refine/refine_simple.visit"); visit_file << "!NBLOCKS " << comm_size << endl; } constexpr size_t TIME_STEPS = 3; for (size_t step = 0; step < TIME_STEPS; step++) { // refine the smallest cell that is closest to the starting corner const std::array<double, 3> refine_coord{ 0.000001 * CELL_SIZE, 0.000001 * CELL_SIZE, 0.000001 * CELL_SIZE }; grid.refine_completely_at(refine_coord); grid.stop_refining(); grid.balance_load(); auto cells = grid.get_cells(); sort(cells.begin(), cells.end()); for (const auto& cell: cells) { const auto ref_lvl = grid.get_refinement_level(cell); for (const auto& neighbor: *grid.get_neighbors_of(cell)) { if (neighbor.first == error_cell) { continue; } const auto neigh_ref_lvl = grid.get_refinement_level(neighbor.first); if (abs(ref_lvl - neigh_ref_lvl) > 1) { std::cerr << "Refinement level difference between " << cell << " and " << neighbor.first << " too large" << std::endl; abort(); } } } // write the game state into a file named according to the current time step string current_output_name("tests/refine/"); ostringstream step_string; step_string.fill('0'); step_string.width(5); step_string << step; current_output_name += basename.str(); current_output_name += step_string.str(); current_output_name += suffix.str(); // visualize the game with visit -o game_of_life_test.visit if (rank == 0) { for (int process = 0; process < comm_size; process++) { visit_file << "refine_simple_" << process << "_" << step_string.str() << suffix.str() << endl; } } // write the grid into a file grid.write_vtk_file(current_output_name.c_str()); // prepare to write the game data into the same file outfile.open(current_output_name.c_str(), ofstream::app); outfile << "CELL_DATA " << cells.size() << endl; // write each cells neighbor count outfile << "SCALARS neighbors int 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (const auto& cell: cells) { const auto* const neighbors = grid.get_neighbors_of(cell); outfile << neighbors->size() << endl; } // write each cells process outfile << "SCALARS process int 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (size_t i = 0; i < cells.size(); i++) { outfile << rank << endl; } // write each cells id outfile << "SCALARS id int 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (const auto& cell: cells) { outfile << cell << endl; } outfile.close(); } if (rank == 0) { visit_file.close(); } MPI_Finalize(); return EXIT_SUCCESS; }
int main(int argc, char* argv[]) { environment env(argc, argv); communicator comm; float zoltan_version; if (Zoltan_Initialize(argc, argv, &zoltan_version) != ZOLTAN_OK) { cout << "Zoltan_Initialize failed" << endl; exit(EXIT_FAILURE); } if (comm.rank() == 0) { cout << "Using Zoltan version " << zoltan_version << endl; } /* Options */ uint64_t x_length, y_length, z_length; unsigned int neighborhood_size, refine_n, iterations; string load_balancing_method; vector<string> hier_lb_methods; vector<int> hier_lb_procs_per_level; bool save; boost::program_options::options_description options("Usage: program_name [options], where options are:"); options.add_options() ("help", "print this help message") ("x_length", boost::program_options::value<uint64_t>(&x_length)->default_value(10), "Create a grid with arg number of unrefined cells in the x direction") ("y_length", boost::program_options::value<uint64_t>(&y_length)->default_value(10), "Create a grid with arg number of unrefined cells in the y direction") ("z_length", boost::program_options::value<uint64_t>(&z_length)->default_value(10), "Create a grid with arg number of unrefined cells in the z direction") ("load_balancing_method", boost::program_options::value<string>(&load_balancing_method)->default_value("HYPERGRAPH"), "Use arg as the load balancing method (supported values: NONE, BLOCK, RANDOM, RCB, RIB, HSFC, GRAPH, HYPERGRAPH, HIER)") ("iterations", boost::program_options::value<unsigned int>(&iterations)->default_value(10), "First randomize processes of cells then balance the load using given options arg times") ("hier_lb_methods", boost::program_options::value<vector<string> >(&hier_lb_methods)->composing(), "Load balancing method used by HIER is specified here, once per number of hierarchies, default HYPERGRAPH, number of these must equal number of hier_lb_procs_per_level (for example --hier_... RCB --hier_... RIB --hier_... RANDOM for three hierarhies)") ("hier_lb_procs_per_level", boost::program_options::value<vector<int> >(&hier_lb_procs_per_level)->composing(), "Number of processes per hierarchy with HIER load balancing method, default 1, number of these must equal number of hier_lb_methods (for example --hier_... 12 --hier_... 4 --hier_... 2 for three hierarchies)") ("refine_n", boost::program_options::value<unsigned int>(&refine_n)->default_value(0), "Refine cells arg times") ("save", boost::program_options::value<bool>(&save)->default_value(false), "Save the grid after every iteration") ("neighborhood_size", boost::program_options::value<unsigned int>(&neighborhood_size)->default_value(1), "Size of a cell's neighborhood in cells of equal size (0 means only face neighbors are neighbors)"); // read options from command line boost::program_options::variables_map option_variables; boost::program_options::store(boost::program_options::parse_command_line(argc, argv, options), option_variables); boost::program_options::notify(option_variables); // print a help message if asked if (option_variables.count("help") > 0) { if (comm.rank() == 0) { cout << options << endl; } comm.barrier(); return EXIT_SUCCESS; } // check for invalid options if (load_balancing_method == "HIER") { if (hier_lb_methods.size() == 0) { if (comm.rank() == 0) { cerr << "At least one load balancing method for HIER partitioning must be given" << endl; } return EXIT_FAILURE; } if (hier_lb_methods.size() != hier_lb_procs_per_level.size()) { if (comm.rank() == 0) { cerr << "Number of load balancing methods for HIER must equal the number of processes per partition options" << endl; } return EXIT_FAILURE; } for (unsigned int i = 0; i < hier_lb_procs_per_level.size(); i++) { if (hier_lb_procs_per_level[i] <= 0) { if (comm.rank() == 0) { cerr << "Processes per partition must be a positive number" << endl; } return EXIT_FAILURE; } } } Dccrg<int> grid; if (!grid.set_geometry( x_length, y_length, z_length, -0.5, -0.5, -0.5, 1.0 / x_length, 1.0 / y_length, 1.0 / z_length )) { if (comm.rank() == 0) { cerr << "Couldn't set grid geometry" << endl; } return EXIT_FAILURE; } grid.initialize( comm, load_balancing_method.c_str(), neighborhood_size ); // set load balancing options if (load_balancing_method == "HIER") { for (unsigned int i = 0; i < hier_lb_methods.size(); i++) { grid.add_partitioning_level(hier_lb_procs_per_level[i]); grid.add_partitioning_option(i, "LB_METHOD", hier_lb_methods[i]); } } vector<uint64_t> cells = grid.get_cells(); for (unsigned int i = 0; i < refine_n; i++) { for (vector<uint64_t>::const_iterator cell = cells.begin(); cell != cells.end(); cell++) { double x = grid.get_cell_x(*cell); double y = grid.get_cell_y(*cell); double z = grid.get_cell_z(*cell); if (sqrt(x * x + y * y + z * z) < 0.1) { grid.refine_completely(*cell); } } grid.stop_refining(); cells = grid.get_cells(); } if (comm.rank() == 0) { cout << "Total cells after refining: " << all_reduce(comm, cells.size(), plus<uint64_t>()) << endl; } else { all_reduce(comm, cells.size(), plus<uint64_t>()); } // every process outputs the game state into its own file ostringstream basename, suffix(".vtk"); basename << "load_balancing_test_" << comm.rank() << "_"; ofstream outfile, visit_file; // visualize the game with visit -o game_of_life_test.visit if (comm.rank() == 0) { visit_file.open("load_balancing_test.visit"); visit_file << "!NBLOCKS " << comm.size() << endl; } for (unsigned int step = 0; step < iterations; step++) { // scatter cells to random processes cells = grid.get_cells(); for (vector<uint64_t>::const_iterator cell = cells.begin(); cell != cells.end(); cell++ ) { grid.pin(*cell, rand() % comm.size()); } grid.migrate_cells(); grid.unpin_all_cells(); // balance the load using given options grid.balance_load(); /*grid.start_remote_neighbor_data_update(); grid.wait_neighbor_data_update();*/ cells = grid.get_cells(); // the library writes the grid into a file in ascending cell order, do the same for the grid data at every time step sort(cells.begin(), cells.end()); // write the game state into a file named according to the current time step string current_output_name(""); ostringstream step_string; step_string.fill('0'); step_string.width(5); step_string << step; current_output_name += basename.str(); current_output_name += step_string.str(); current_output_name += suffix.str(); // visualize the game with visit -o game_of_life_test.visit if (comm.rank() == 0) { for (int process = 0; process < comm.size(); process++) { visit_file << "load_balancing_test_" << process << "_" << step_string.str() << suffix.str() << endl; } } // write the grid into a file grid.write_vtk_file(current_output_name.c_str()); // prepare to write the game data into the same file outfile.open(current_output_name.c_str(), ofstream::app); outfile << "CELL_DATA " << cells.size() << endl; // write each cells neighbor count outfile << "SCALARS neighbors int 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (vector<uint64_t>::const_iterator cell = cells.begin(); cell != cells.end(); cell++) { const vector<uint64_t>* neighbors = grid.get_neighbors(*cell); outfile << neighbors->size() << endl; } // write each cells process outfile << "SCALARS process int 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (vector<uint64_t>::const_iterator cell = cells.begin(); cell != cells.end(); cell++) { outfile << comm.rank() << endl; } // write each cells id outfile << "SCALARS id int 1" << endl; outfile << "LOOKUP_TABLE default" << endl; for (vector<uint64_t>::const_iterator cell = cells.begin(); cell != cells.end(); cell++) { outfile << *cell << endl; } outfile.close(); } if (comm.rank() == 0) { cout << "Passed" << endl; } return EXIT_SUCCESS; }