From: Daniel Arndt Date: Tue, 22 Mar 2016 14:59:54 +0000 (+0100) Subject: Test new functions in tria_accessor.h X-Git-Tag: v8.5.0-rc1~1151^2~5 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=19b7456a7aa8a746cecb1f94bc49609b2d7cc0e6;p=dealii.git Test new functions in tria_accessor.h --- diff --git a/include/deal.II/grid/tria_accessor.h b/include/deal.II/grid/tria_accessor.h index 96c18fb221..1e863e86bc 100644 --- a/include/deal.II/grid/tria_accessor.h +++ b/include/deal.II/grid/tria_accessor.h @@ -2497,7 +2497,7 @@ public: * @} */ /** - * @name Dealing with periodic neighbor + * @name Dealing with periodic neighbors */ /** * @{ @@ -2510,13 +2510,13 @@ public: /** * For a cell with its @c ith face at a periodic boundary, - * (see @ref GlossPeriodicConstraints "the entry for periodic baoundaries") + * (see @ref GlossPeriodicConstraints "the entry for periodic boundaries") * this function returns an iterator to the cell on the other side * of the periodic boundary. If there is no periodic boundary at the @c ith * face, an exception will be thrown. - * In order to check if a cell has periodic neighbor on its @c ith face, - * one should first call the function @c has_periodic_neighbor(). - * The behavior of @c periodic_neighbor() is similar to @c neighbor(), in + * In order to avoid running into an exception, check the result of + * has_periodic_neighbor() for the @c ith face prior to using this function. + * The behavior of periodic_neighbor() is similar to neighbor(), in * the sense that the returned cell has at most the same level of refinement * as the current cell. On distributed meshes, by calling * Triangulation::add_periodicity(), @@ -2529,15 +2529,15 @@ public: /** * Returns an iterator to the periodic neighbor of the cell at a given * face and subface number. The general guidelines for using this function - * is similar to the function @c neighbor_child_on_subface. The + * is similar to the function neighbor_child_on_subface(). The * implementation of this function is consistent with - * @c periodic_neighbor_of_coarser_periodic_neighbor. For instance, - * assume that we are sitting on a cell named @c cell1, which has a 1 level - * coarser neighbor at its @c ith face. Let us name this coarser neighbor + * periodic_neighbor_of_coarser_periodic_neighbor(). For instance, + * assume that we are sitting on a cell named @c cell1, whose neighbor behind + * the @c ith face is one level coarser. Let us name this coarser neighbor * @c cell2. Then, by calling - * @c periodic_neighbor_of_coarser_periodic_neighbor, from @c cell1, we get + * periodic_neighbor_of_coarser_periodic_neighbor(), from @c cell1, we get * a @c face_num and a @c subface_num. Now, if we call - * @c periodic_neighbor_child_on_subface from cell2, with the above face_num + * periodic_neighbor_child_on_subface() from cell2, with the above face_num * and subface_num, we get an iterator to @c cell1. */ TriaIterator > @@ -2546,15 +2546,15 @@ public: /** * This function is a generalization of - * @c periodic_neighbor_of_periodic_neighbor + * periodic_neighbor_of_periodic_neighbor() * for those cells which have a coarser periodic neighbor. The returned - * pair of numbers can be used in @c periodic_neighbor_child_on_subface + * pair of numbers can be used in periodic_neighbor_child_on_subface() * to get back to the current cell. In other words, the following * assertion should be true, for a cell with coarser periodic neighbor: * cell->periodic_neighbor(i)->periodic_neighbor_child_on_subface(face_no, subface_no)==cell */ std::pair - periodic_neighbor_of_coarser_periodic_neighbor (const unsigned i) const; + periodic_neighbor_of_coarser_periodic_neighbor (const unsigned face_no) const; /** * This function returns the index of the periodic neighbor. If there is @@ -2572,7 +2572,7 @@ public: /** * For a cell with a periodic neighbor at its @c ith face, this function - * returns the face number of that periodic neighbor such that, the + * returns the face number of that periodic neighbor such that the * current cell is the periodic neighbor of that neighbor. In other words * the following assertion holds for those cells which have a periodic * neighbor with the same or a higher level of refinement as the current @@ -2580,8 +2580,8 @@ public: * @c {cell->periodic_neighbor(i)-> * periodic_neighbor(cell->periodic_neighbor_of_periodic_neighbor(i))==cell} * For the cells with a coarser periodic neighbor, one should use - * @c periodic_neighbor_of_coarser_periodic_neighbor and - * @c periodic_neighbor_child_on_subface + * periodic_neighbor_of_coarser_periodic_neighbor() and + * periodic_neighbor_child_on_subface() * to get back to the current cell. */ unsigned int @@ -2596,8 +2596,8 @@ public: /** * This function returns true if the element on the other side of the - * periodic boundary is coarser and returns false, otherwise. The - * implementation allows this function to work, in the case of + * periodic boundary is coarser and returns false otherwise. The + * implementation allows this function to work in the case of * anisotropic refinement. */ bool diff --git a/source/grid/tria_accessor.cc b/source/grid/tria_accessor.cc index cb3abc3d0c..0cf66d063b 100644 --- a/source/grid/tria_accessor.cc +++ b/source/grid/tria_accessor.cc @@ -1876,11 +1876,11 @@ CellAccessor::has_periodic_neighbor (const unsigned int i_face) c * Implementation note: In all of the functions corresponding to periodic faces * we mainly use the Triangulation::periodic_face_map to find the * information about periodically connected faces. So, we actually search in - * this std::map and return the cell_face on the other side of periodic boundary. - * For this search process, we have three options: + * this std::map and return the cell_face on the other side of the periodic + * boundary. For this search process, we have two options: * * 1- Using the [] operator of std::map: This option results in a more readalbe - * code, but requires an extra iteration in the map. Becasue when we call [] on + * code, but requires an extra iteration in the map. Because when we call [] on * std::map, with a key which does not exist in the std::map, that key will be * created and the default value will be returned by []. This is not desirable. * So, one has to first check if the key exists in the std::map and if it exists, @@ -1889,7 +1889,7 @@ CellAccessor::has_periodic_neighbor (const unsigned int i_face) c * through the map. First, existence check, then returning the value. * * 2- Using std::map::find(): This option is less readble, but theoretically - * faster. Because, it results in one iteration through std::map object. + * faster, because it results in one iteration through std::map object. * * We decided to use the 2nd option. */ @@ -2035,7 +2035,7 @@ periodic_neighbor_of_coarser_periodic_neighbor (const unsigned int i_face) const return (std::pair(face_num_of_nb, i_subface)); /* * Obviously, if the execution reaches to this point, some of our assumptions should have - * been false. The most important one is, the user has called this funciton on a face + * been false. The most important one is, the user has called this function on a face * which does not have a coarser periodic neighbor. */ Assert (false, TriaAccessorExceptions::ExcNeighborIsNotCoarser()); @@ -2049,24 +2049,7 @@ template int CellAccessor:: periodic_neighbor_index(const unsigned int i_face) const { - /* - * To know, why we are using std::map::find() instead of [] operator, refer - * to the implementation note in has_periodic_neighbor() function. - * - * my_it : the iterator to the current cell. - * my_face_pair : the pair reported by periodic_face_map as its first pair being - * the current cell_face. - */ - AssertIndexRange (i_face, GeometryInfo::faces_per_cell); - typedef TriaIterator > cell_iterator; - typedef std::pair cell_face_pair; - typedef std::pair > oriented_cell_face_pair; - cell_iterator my_it(*this); - typename std::map::const_iterator my_face_pair = - this->tria->periodic_face_map.find(std::pair(my_it, i_face)); - Assert (my_face_pair != this->tria->periodic_face_map.end(), - TriaAccessorExceptions::ExcNoPeriodicNeighbor()); - return my_face_pair->second.first.first->index(); + return periodic_neighbor(i_face)->index(); } @@ -2075,24 +2058,7 @@ template int CellAccessor:: periodic_neighbor_level(const unsigned int i_face) const { - /* - * To know, why we are using std::map::find() instead of [] operator, refer - * to the implementation note in has_periodic_neighbor() function. - * - * my_it : the iterator to the current cell. - * my_face_pair : the pair reported by periodic_face_map as its first pair being - * the current cell_face. - */ - AssertIndexRange (i_face, GeometryInfo::faces_per_cell); - typedef TriaIterator > cell_iterator; - typedef std::pair cell_face_pair; - typedef std::pair > oriented_cell_face_pair; - cell_iterator my_it(*this); - typename std::map::const_iterator my_face_pair = - this->tria->periodic_face_map.find(std::pair(my_it, i_face)); - Assert (my_face_pair != this->tria->periodic_face_map.end(), - TriaAccessorExceptions::ExcNoPeriodicNeighbor()); - return my_face_pair->second.first.first->level(); + return periodic_neighbor(i_face)->level(); } diff --git a/tests/mpi/periodic_neighbor_01.cc b/tests/mpi/periodic_neighbor_01.cc new file mode 100755 index 0000000000..8241e0f507 --- /dev/null +++ b/tests/mpi/periodic_neighbor_01.cc @@ -0,0 +1,363 @@ +// --------------------------------------------------------------------- +// +// Copyright (C) 2001 - 2016 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- +// +/* + * ==================== + * [ Test objectives: ] + * ==================== + * + * 1. To control if periodic faces have at most one level of refinement + * difference. + * + * 2. To test the following functions: + * - cell->has_periodic_neighbor(i_face) + * - cell->periodic_neighbor(i_face) + * - cell->periodic_neighbor_is_coarser(i_face) + * - cell->periodic_face_no(i_face) + * - cell->periodic_neighbor_of_periodic_neighbor(i_face) + * - cell->periodic_neighbor_of_coarser_periodic_neighbor(i_face) + * - cell->periodic_neighbor_child_on_subface(i_face, i_subface) + * + * + * =============== + * [ Test Setup: ] + * =============== + * + * We start with a 4x4 mesh (in 2D) and 4x4x4 mesh (in 3D) and refine on of the + * top middle elements twice, to get the following mesh: + * + * + * Top periodic boundary + * ------------------------------------------------- + * | | | | | | | | + * | | |-----| | | | + * | | | | | | | | + * | ------------------------- | + * | | | | | | | + * | | | | | | | + * | | | | | | | + * ------------------------------------------------- + * | | | | | + * | | | | | + * | | | | | + * | | | | | + * | | | | | + * | | | | | + * | | | | | + * ------------------------------------------------- + * | | | | | + * | | | | | + * | | | | | + * | | | | | + * | | | | | + * | | | | | + * | | | | | + * ------------------------------------------------- + * | | | | | | | + * | | | | | | | + * | | | | | | | + * | ------------------------- | + * | | | | | | | + * | | | | | | | + * | | | | | | | + * ------------------------------------------------- + * Bottom periodic boundary + * + * + * ===================== + * [ Passing criteria: ] + * ===================== + * + * The test will be passed if the main three assertions are passed. + */ + +#include "../tests.h" +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include + +#include +#include + + +using namespace dealii; + +template +struct periodicity_tests +{ + typedef TriaIterator > cell_iterator; + typedef typename Triangulation::active_cell_iterator active_cell_iterator; + periodicity_tests(); + + unsigned refn_cycle; + MPI_Comm mpi_comm; + int comm_rank, comm_size; + parallel::distributed::Triangulation the_grid; + + void refine_grid(const unsigned); + void write_grid(); + void check_periodicity(); +}; + +template +periodicity_tests::periodicity_tests() + : refn_cycle(0), mpi_comm(MPI_COMM_WORLD), the_grid(mpi_comm) +{ + Assert(dim == 2 || dim == 3, ExcMessage("Only implemented for the 2D and 3D case!")); + comm_rank = Utilities::MPI::this_mpi_process(mpi_comm); + comm_size = Utilities::MPI::n_mpi_processes(mpi_comm); + std::vector repeats(dim, 2); + Point p1, p2, periodic_transfer; + if (dim == 2) + { + p2 = Point( 16., 16. ); + periodic_transfer = Point( 0.0, 16. ); + } + if (dim == 3) + { + p2 = Point( 16., 16., 16. ); + periodic_transfer = Point( 0.0, 16., 0.0 ); + } + GridGenerator::subdivided_hyper_rectangle(the_grid, repeats, p1, p2, true); + std::vector > periodic_faces; + GridTools::collect_periodic_faces(the_grid, 2, 3, 0, periodic_faces, periodic_transfer); + the_grid.add_periodicity(periodic_faces); +} + +template +void periodicity_tests::refine_grid(const unsigned n) +{ + if (n != 0 && refn_cycle == 0) + { + the_grid.refine_global(n); + refn_cycle += n; + } + else if (n != 0) + { + Point refn_point; + if (dim == 2) + refn_point = Point( 6.5, 15.5 ); + if (dim == 3) + refn_point = Point( 6.5, 15.5, 6.5 ); + for (unsigned i_refn = 0; i_refn < n; ++i_refn) + { + active_cell_iterator cell_it = the_grid.begin_active(); + for (; cell_it != the_grid.end(); ++cell_it) + { + if (cell_it->is_locally_owned() && cell_it->point_inside(refn_point)) + { + cell_it->set_refine_flag(); + break; + } + } + the_grid.execute_coarsening_and_refinement(); + ++refn_cycle; + } + } +} + +template +void periodicity_tests::write_grid() +{ + GridOut Grid1_Out; + GridOutFlags::Svg svg_flags( + 1, // line_thickness = 2, + 2, // boundary_line_thickness = 4, + false, // margin = true, + dealii::GridOutFlags::Svg::transparent, // background = white, + 0, // azimuth_angle = 0, + 0, // polar_angle = 0, + dealii::GridOutFlags::Svg::subdomain_id, // coloring = level_number, + false, // convert_level_number_to_height = false, + false, // label_level_number = true, + true, // label_cell_index = true, + false, // label_material_id = false, + false, // label_subdomain_id = false, + true, // draw_colorbar = true, + true); // draw_legend = true + Grid1_Out.set_flags(svg_flags); + if (dim == 2) + { + std::ofstream Grid1_OutFile("Grid1" + std::to_string(refn_cycle) + + std::to_string(comm_rank) + ".svg"); + Grid1_Out.write_svg(the_grid, Grid1_OutFile); + } + else + { + std::ofstream Grid1_OutFile("Grid1" + std::to_string(refn_cycle) + + std::to_string(comm_rank) + ".msh"); + Grid1_Out.write_msh(the_grid, Grid1_OutFile); + } +} + +template +void periodicity_tests::check_periodicity() +{ + typedef std::pair cell_face_pair; + typedef typename std::map::iterator cell_face_map_it; + + for (int rank_i = 0; rank_i < comm_size; ++rank_i) + { + if (comm_rank == rank_i) + { + deallog << "All of the cells with periodic neighbors on rank " + << comm_rank << std::endl; + active_cell_iterator cell_it = the_grid.begin_active(); + for (; cell_it != the_grid.end(); ++cell_it) + { + for (unsigned i_face = 0; i_face < GeometryInfo::faces_per_cell; ++i_face) + { + if (cell_it->has_periodic_neighbor(i_face)) + { + const cell_iterator &nb_it = cell_it->periodic_neighbor(i_face); + unsigned nb_i_face = cell_it->periodic_neighbor_face_no(i_face); + const cell_iterator &nb_of_nb_it = nb_it->periodic_neighbor(nb_i_face); + unsigned nb_of_nb_i_face = nb_it->periodic_neighbor_face_no(nb_i_face); + deallog << nb_it->face(nb_i_face)->center() + << " is a periodic neighbor of " + << cell_it->face(i_face)->center(); + if (cell_it->periodic_neighbor_is_coarser(i_face)) + { + deallog << ". And periodic neighbor is coarser." << std::endl; + /* + * Now, we want to do the standard test of: + * + * cell->neighbor(i_face) + * ->periodic_neighbor_child_on_subface(face_no, subface_no) + * == cell + * + * The other important test for coarser neighbors is: + * cell->periodic_neighbor(i_face) + * ->face(face_no)->child(subface_no) + * == cell->face(i_face) + * But, this is not the case for periodic neighbors. Because, we + * are not talking about the exact same faces. + */ + std::pair face_subface = + cell_it->periodic_neighbor_of_coarser_periodic_neighbor(i_face); + Assert(nb_it->periodic_neighbor_child_on_subface( + face_subface.first, face_subface.second) == cell_it, + ExcInternalError()); + } + else if (nb_it->face(nb_i_face)->has_children()) + { + deallog << ". And periodic neighbor is refined." << std::endl; + } + else + deallog << ". And periodic neighbor has the same level." << std::endl; + deallog << "If the periodic neighbor is not coarser, " + << nb_of_nb_it->face(nb_of_nb_i_face)->center() + << " should be equal to " + << cell_it->face(i_face)->center() << std::endl; + deallog + << "-------------------------------------------------------" + << std::endl; + Assert((cell_it->face(i_face)->center() - + nb_of_nb_it->face(nb_of_nb_i_face)->center()) + .norm() < 1e-10 || + cell_it->periodic_neighbor_is_coarser(i_face), ExcInternalError()); + + Assert(cell_it == nb_of_nb_it || + cell_it->periodic_neighbor_is_coarser(i_face), ExcInternalError()); + } + } + } + } + MPI_Barrier(mpi_comm); + } +} + +int main(int argc, char *argv[]) +{ + try + { + Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv ,1); + MPILogInitAll log; + + periodicity_tests<2> test_2D; + /* + * Let us first check the periodicity of the simple case of uniformly refined + * mesh. + */ + if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0) + deallog << "First, we check the periodic faces on a uniformly refined mesh." + << std::endl; + test_2D.refine_grid(1); + // test_2D.write_grid(); + test_2D.check_periodicity(); + + /* Next, we want to check the case of nonuniform mesh */ + if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0) + deallog << "Next, we check the periodic faces on an adaptively refined mesh." + << std::endl; + test_2D.refine_grid(2); + // test_2D.write_grid(); + test_2D.check_periodicity(); + + periodicity_tests<3> test_3D; + /* + * Let us first check the periodicity of the simple case of uniformly refined + * mesh. + */ + if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0) + deallog << "First, we check the periodic faces on a uniformly refined mesh." + << std::endl; + test_3D.refine_grid(1); + // test_3D.write_grid(); + test_3D.check_periodicity(); + + /* Next, we want to check the case of nonuniform mesh */ + if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0) + deallog << "Next, we check the periodic faces on an adaptively refined mesh." + << std::endl; + test_3D.refine_grid(2); + // test_3D.write_grid(); + test_3D.check_periodicity(); + } + catch (std::exception &exc) + { + std::cerr << std::endl << std::endl + << "----------------------------------------------------" + << std::endl; + std::cerr << "Exception on processing: " << std::endl + << exc.what() << std::endl + << "Aborting!" << std::endl + << "----------------------------------------------------" + << std::endl; + + return 1; + } + catch (...) + { + std::cerr << std::endl << std::endl + << "----------------------------------------------------" + << std::endl; + std::cerr << "Unknown exception!" << std::endl + << "Aborting!" << std::endl + << "----------------------------------------------------" + << std::endl; + return 1; + } + return 0; +} + diff --git a/tests/mpi/periodic_neighbor_01.mpirun=1.output b/tests/mpi/periodic_neighbor_01.mpirun=1.output new file mode 100644 index 0000000000..9764632cfb --- /dev/null +++ b/tests/mpi/periodic_neighbor_01.mpirun=1.output @@ -0,0 +1,345 @@ +JobId water.ices.utexas.edu Wed Mar 23 14:13:30 2016 +DEAL:0::First, we check the periodic faces on a uniformly refined mesh. +DEAL:0::All of the cells with periodic neighbors on rank 0 +DEAL:0::2.00000 16.0000 is a periodic neighbor of 2.00000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 should be equal to 2.00000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 is a periodic neighbor of 6.00000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 should be equal to 6.00000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 is a periodic neighbor of 10.0000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 should be equal to 10.0000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 is a periodic neighbor of 14.0000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 should be equal to 14.0000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 is a periodic neighbor of 2.00000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 should be equal to 2.00000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 is a periodic neighbor of 6.00000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 should be equal to 6.00000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 is a periodic neighbor of 10.0000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 should be equal to 10.0000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 is a periodic neighbor of 14.0000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 should be equal to 14.0000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::Next, we check the periodic faces on an adaptively refined mesh. +DEAL:0::All of the cells with periodic neighbors on rank 0 +DEAL:0::2.00000 16.0000 is a periodic neighbor of 2.00000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 should be equal to 2.00000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 is a periodic neighbor of 14.0000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 should be equal to 14.0000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 is a periodic neighbor of 2.00000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 should be equal to 2.00000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 is a periodic neighbor of 14.0000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 should be equal to 14.0000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 0.00000 is a periodic neighbor of 5.00000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 16.0000 should be equal to 5.00000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 16.0000 is a periodic neighbor of 5.00000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 0.00000 should be equal to 5.00000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 16.0000 is a periodic neighbor of 7.00000 0.00000. And periodic neighbor is refined. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 0.00000 should be equal to 7.00000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 16.0000 is a periodic neighbor of 9.00000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 0.00000 should be equal to 9.00000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 16.0000 is a periodic neighbor of 11.0000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 0.00000 should be equal to 11.0000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 0.00000 is a periodic neighbor of 9.00000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 16.0000 should be equal to 9.00000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 0.00000 is a periodic neighbor of 11.0000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 16.0000 should be equal to 11.0000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 is a periodic neighbor of 6.50000 16.0000. And periodic neighbor is coarser. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 should be equal to 6.50000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 is a periodic neighbor of 7.50000 16.0000. And periodic neighbor is coarser. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 should be equal to 7.50000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::First, we check the periodic faces on a uniformly refined mesh. +DEAL:0::All of the cells with periodic neighbors on rank 0 +DEAL:0::2.00000 16.0000 2.00000 is a periodic neighbor of 2.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 2.00000 should be equal to 2.00000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 2.00000 is a periodic neighbor of 6.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 2.00000 should be equal to 6.00000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 16.0000 6.00000 is a periodic neighbor of 2.00000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 6.00000 should be equal to 2.00000 0.00000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 6.00000 is a periodic neighbor of 6.00000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 6.00000 should be equal to 6.00000 0.00000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 2.00000 is a periodic neighbor of 10.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 2.00000 should be equal to 10.0000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 2.00000 is a periodic neighbor of 14.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 2.00000 should be equal to 14.0000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 6.00000 is a periodic neighbor of 10.0000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 6.00000 should be equal to 10.0000 0.00000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 6.00000 is a periodic neighbor of 14.0000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 6.00000 should be equal to 14.0000 0.00000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 2.00000 is a periodic neighbor of 2.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 2.00000 should be equal to 2.00000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 2.00000 is a periodic neighbor of 6.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 2.00000 should be equal to 6.00000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 6.00000 is a periodic neighbor of 2.00000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 6.00000 should be equal to 2.00000 16.0000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 6.00000 is a periodic neighbor of 6.00000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 6.00000 should be equal to 6.00000 16.0000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 2.00000 is a periodic neighbor of 10.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 2.00000 should be equal to 10.0000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 2.00000 is a periodic neighbor of 14.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 2.00000 should be equal to 14.0000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 6.00000 is a periodic neighbor of 10.0000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 6.00000 should be equal to 10.0000 16.0000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 6.00000 is a periodic neighbor of 14.0000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 6.00000 should be equal to 14.0000 16.0000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 16.0000 10.0000 is a periodic neighbor of 2.00000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 10.0000 should be equal to 2.00000 0.00000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 10.0000 is a periodic neighbor of 6.00000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 10.0000 should be equal to 6.00000 0.00000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 16.0000 14.0000 is a periodic neighbor of 2.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 14.0000 should be equal to 2.00000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 14.0000 is a periodic neighbor of 6.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 14.0000 should be equal to 6.00000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 10.0000 is a periodic neighbor of 10.0000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 10.0000 should be equal to 10.0000 0.00000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 10.0000 is a periodic neighbor of 14.0000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 10.0000 should be equal to 14.0000 0.00000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 14.0000 is a periodic neighbor of 10.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 14.0000 should be equal to 10.0000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 14.0000 is a periodic neighbor of 14.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 14.0000 should be equal to 14.0000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 10.0000 is a periodic neighbor of 2.00000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 10.0000 should be equal to 2.00000 16.0000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 10.0000 is a periodic neighbor of 6.00000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 10.0000 should be equal to 6.00000 16.0000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 14.0000 is a periodic neighbor of 2.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 14.0000 should be equal to 2.00000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 14.0000 is a periodic neighbor of 6.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 14.0000 should be equal to 6.00000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 10.0000 is a periodic neighbor of 10.0000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 10.0000 should be equal to 10.0000 16.0000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 10.0000 is a periodic neighbor of 14.0000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 10.0000 should be equal to 14.0000 16.0000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 14.0000 is a periodic neighbor of 10.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 14.0000 should be equal to 10.0000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 14.0000 is a periodic neighbor of 14.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 14.0000 should be equal to 14.0000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::Next, we check the periodic faces on an adaptively refined mesh. +DEAL:0::All of the cells with periodic neighbors on rank 0 +DEAL:0::2.00000 16.0000 2.00000 is a periodic neighbor of 2.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 2.00000 should be equal to 2.00000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 2.00000 is a periodic neighbor of 6.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 2.00000 should be equal to 6.00000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 16.0000 6.00000 is a periodic neighbor of 2.00000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 6.00000 should be equal to 2.00000 0.00000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 2.00000 is a periodic neighbor of 10.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 2.00000 should be equal to 10.0000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 2.00000 is a periodic neighbor of 14.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 2.00000 should be equal to 14.0000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 6.00000 is a periodic neighbor of 14.0000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 6.00000 should be equal to 14.0000 0.00000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 2.00000 is a periodic neighbor of 2.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 2.00000 should be equal to 2.00000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 2.00000 is a periodic neighbor of 6.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 2.00000 should be equal to 6.00000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 6.00000 is a periodic neighbor of 2.00000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 6.00000 should be equal to 2.00000 16.0000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 2.00000 is a periodic neighbor of 10.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 2.00000 should be equal to 10.0000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 2.00000 is a periodic neighbor of 14.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 2.00000 should be equal to 14.0000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 6.00000 is a periodic neighbor of 14.0000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 6.00000 should be equal to 14.0000 16.0000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 16.0000 10.0000 is a periodic neighbor of 2.00000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 10.0000 should be equal to 2.00000 0.00000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 16.0000 14.0000 is a periodic neighbor of 2.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 14.0000 should be equal to 2.00000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 14.0000 is a periodic neighbor of 6.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 14.0000 should be equal to 6.00000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 10.0000 is a periodic neighbor of 14.0000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 10.0000 should be equal to 14.0000 0.00000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 14.0000 is a periodic neighbor of 10.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 14.0000 should be equal to 10.0000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 14.0000 is a periodic neighbor of 14.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 14.0000 should be equal to 14.0000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 10.0000 is a periodic neighbor of 2.00000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 10.0000 should be equal to 2.00000 16.0000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 14.0000 is a periodic neighbor of 2.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 14.0000 should be equal to 2.00000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 14.0000 is a periodic neighbor of 6.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 14.0000 should be equal to 6.00000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 10.0000 is a periodic neighbor of 14.0000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 10.0000 should be equal to 14.0000 16.0000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 14.0000 is a periodic neighbor of 10.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 14.0000 should be equal to 10.0000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 14.0000 is a periodic neighbor of 14.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 14.0000 should be equal to 14.0000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 0.00000 5.00000 is a periodic neighbor of 5.00000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 16.0000 5.00000 should be equal to 5.00000 16.0000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 5.00000 is a periodic neighbor of 7.00000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 5.00000 should be equal to 7.00000 16.0000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 0.00000 7.00000 is a periodic neighbor of 5.00000 16.0000 7.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 16.0000 7.00000 should be equal to 5.00000 16.0000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 16.0000 5.00000 is a periodic neighbor of 5.00000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 0.00000 5.00000 should be equal to 5.00000 0.00000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 16.0000 5.00000 is a periodic neighbor of 7.00000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 0.00000 5.00000 should be equal to 7.00000 0.00000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 16.0000 7.00000 is a periodic neighbor of 5.00000 0.00000 7.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 0.00000 7.00000 should be equal to 5.00000 0.00000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 16.0000 7.00000 is a periodic neighbor of 7.00000 0.00000 7.00000. And periodic neighbor is refined. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 0.00000 7.00000 should be equal to 7.00000 0.00000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 16.0000 5.00000 is a periodic neighbor of 9.00000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 0.00000 5.00000 should be equal to 9.00000 0.00000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 16.0000 5.00000 is a periodic neighbor of 11.0000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 0.00000 5.00000 should be equal to 11.0000 0.00000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 16.0000 7.00000 is a periodic neighbor of 9.00000 0.00000 7.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 0.00000 7.00000 should be equal to 9.00000 0.00000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 16.0000 7.00000 is a periodic neighbor of 11.0000 0.00000 7.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 0.00000 7.00000 should be equal to 11.0000 0.00000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 0.00000 5.00000 is a periodic neighbor of 9.00000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 16.0000 5.00000 should be equal to 9.00000 16.0000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 0.00000 5.00000 is a periodic neighbor of 11.0000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 16.0000 5.00000 should be equal to 11.0000 16.0000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 0.00000 7.00000 is a periodic neighbor of 9.00000 16.0000 7.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 16.0000 7.00000 should be equal to 9.00000 16.0000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 0.00000 7.00000 is a periodic neighbor of 11.0000 16.0000 7.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 16.0000 7.00000 should be equal to 11.0000 16.0000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 16.0000 9.00000 is a periodic neighbor of 5.00000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 0.00000 9.00000 should be equal to 5.00000 0.00000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 16.0000 9.00000 is a periodic neighbor of 7.00000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 0.00000 9.00000 should be equal to 7.00000 0.00000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 16.0000 11.0000 is a periodic neighbor of 5.00000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 0.00000 11.0000 should be equal to 5.00000 0.00000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 16.0000 11.0000 is a periodic neighbor of 7.00000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 0.00000 11.0000 should be equal to 7.00000 0.00000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 16.0000 9.00000 is a periodic neighbor of 9.00000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 0.00000 9.00000 should be equal to 9.00000 0.00000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 16.0000 9.00000 is a periodic neighbor of 11.0000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 0.00000 9.00000 should be equal to 11.0000 0.00000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 16.0000 11.0000 is a periodic neighbor of 9.00000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 0.00000 11.0000 should be equal to 9.00000 0.00000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 16.0000 11.0000 is a periodic neighbor of 11.0000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 0.00000 11.0000 should be equal to 11.0000 0.00000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 0.00000 9.00000 is a periodic neighbor of 5.00000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 16.0000 9.00000 should be equal to 5.00000 16.0000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 9.00000 is a periodic neighbor of 7.00000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 9.00000 should be equal to 7.00000 16.0000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 0.00000 11.0000 is a periodic neighbor of 5.00000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 16.0000 11.0000 should be equal to 5.00000 16.0000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 11.0000 is a periodic neighbor of 7.00000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 11.0000 should be equal to 7.00000 16.0000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 0.00000 9.00000 is a periodic neighbor of 9.00000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 16.0000 9.00000 should be equal to 9.00000 16.0000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 0.00000 9.00000 is a periodic neighbor of 11.0000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 16.0000 9.00000 should be equal to 11.0000 16.0000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 0.00000 11.0000 is a periodic neighbor of 9.00000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 16.0000 11.0000 should be equal to 9.00000 16.0000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 0.00000 11.0000 is a periodic neighbor of 11.0000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 16.0000 11.0000 should be equal to 11.0000 16.0000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 7.00000 is a periodic neighbor of 6.50000 16.0000 6.50000. And periodic neighbor is coarser. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 6.50000 16.0000 6.50000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 7.00000 is a periodic neighbor of 7.50000 16.0000 6.50000. And periodic neighbor is coarser. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 7.50000 16.0000 6.50000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 7.00000 is a periodic neighbor of 6.50000 16.0000 7.50000. And periodic neighbor is coarser. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 6.50000 16.0000 7.50000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 7.00000 is a periodic neighbor of 7.50000 16.0000 7.50000. And periodic neighbor is coarser. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 7.50000 16.0000 7.50000 +DEAL:0::------------------------------------------------------- diff --git a/tests/mpi/periodic_neighbor_01.mpirun=3.output b/tests/mpi/periodic_neighbor_01.mpirun=3.output new file mode 100644 index 0000000000..b04bdc5381 --- /dev/null +++ b/tests/mpi/periodic_neighbor_01.mpirun=3.output @@ -0,0 +1,1029 @@ +JobId water.ices.utexas.edu Wed Mar 23 14:12:03 2016 +DEAL:0::First, we check the periodic faces on a uniformly refined mesh. +DEAL:0::All of the cells with periodic neighbors on rank 0 +DEAL:0::2.00000 16.0000 is a periodic neighbor of 2.00000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 should be equal to 2.00000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 is a periodic neighbor of 6.00000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 should be equal to 6.00000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 is a periodic neighbor of 10.0000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 should be equal to 10.0000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 is a periodic neighbor of 14.0000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 should be equal to 14.0000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 is a periodic neighbor of 2.00000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 should be equal to 2.00000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 is a periodic neighbor of 6.00000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 should be equal to 6.00000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 is a periodic neighbor of 10.0000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 should be equal to 10.0000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 is a periodic neighbor of 14.0000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 should be equal to 14.0000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::Next, we check the periodic faces on an adaptively refined mesh. +DEAL:0::All of the cells with periodic neighbors on rank 0 +DEAL:0::2.00000 16.0000 is a periodic neighbor of 2.00000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 should be equal to 2.00000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 is a periodic neighbor of 14.0000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 should be equal to 14.0000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 is a periodic neighbor of 2.00000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 should be equal to 2.00000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 is a periodic neighbor of 14.0000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 should be equal to 14.0000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 0.00000 is a periodic neighbor of 5.00000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 16.0000 should be equal to 5.00000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 16.0000 is a periodic neighbor of 5.00000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 0.00000 should be equal to 5.00000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 16.0000 is a periodic neighbor of 7.00000 0.00000. And periodic neighbor is refined. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 0.00000 should be equal to 7.00000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 16.0000 is a periodic neighbor of 9.00000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 0.00000 should be equal to 9.00000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 16.0000 is a periodic neighbor of 11.0000 0.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 0.00000 should be equal to 11.0000 0.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 0.00000 is a periodic neighbor of 9.00000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 16.0000 should be equal to 9.00000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 0.00000 is a periodic neighbor of 11.0000 16.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 16.0000 should be equal to 11.0000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 is a periodic neighbor of 6.50000 16.0000. And periodic neighbor is coarser. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 should be equal to 6.50000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 is a periodic neighbor of 7.50000 16.0000. And periodic neighbor is coarser. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 should be equal to 7.50000 16.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::First, we check the periodic faces on a uniformly refined mesh. +DEAL:0::All of the cells with periodic neighbors on rank 0 +DEAL:0::2.00000 16.0000 2.00000 is a periodic neighbor of 2.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 2.00000 should be equal to 2.00000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 2.00000 is a periodic neighbor of 6.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 2.00000 should be equal to 6.00000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 16.0000 6.00000 is a periodic neighbor of 2.00000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 6.00000 should be equal to 2.00000 0.00000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 6.00000 is a periodic neighbor of 6.00000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 6.00000 should be equal to 6.00000 0.00000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 2.00000 is a periodic neighbor of 10.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 2.00000 should be equal to 10.0000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 2.00000 is a periodic neighbor of 14.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 2.00000 should be equal to 14.0000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 6.00000 is a periodic neighbor of 10.0000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 6.00000 should be equal to 10.0000 0.00000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 6.00000 is a periodic neighbor of 14.0000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 6.00000 should be equal to 14.0000 0.00000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 2.00000 is a periodic neighbor of 2.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 2.00000 should be equal to 2.00000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 2.00000 is a periodic neighbor of 6.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 2.00000 should be equal to 6.00000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 6.00000 is a periodic neighbor of 2.00000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 6.00000 should be equal to 2.00000 16.0000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 6.00000 is a periodic neighbor of 6.00000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 6.00000 should be equal to 6.00000 16.0000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 2.00000 is a periodic neighbor of 10.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 2.00000 should be equal to 10.0000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 2.00000 is a periodic neighbor of 14.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 2.00000 should be equal to 14.0000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 6.00000 is a periodic neighbor of 10.0000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 6.00000 should be equal to 10.0000 16.0000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 6.00000 is a periodic neighbor of 14.0000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 6.00000 should be equal to 14.0000 16.0000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 16.0000 10.0000 is a periodic neighbor of 2.00000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 10.0000 should be equal to 2.00000 0.00000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 10.0000 is a periodic neighbor of 6.00000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 10.0000 should be equal to 6.00000 0.00000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 16.0000 14.0000 is a periodic neighbor of 2.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 14.0000 should be equal to 2.00000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 14.0000 is a periodic neighbor of 6.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 14.0000 should be equal to 6.00000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 10.0000 is a periodic neighbor of 10.0000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 10.0000 should be equal to 10.0000 0.00000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 10.0000 is a periodic neighbor of 14.0000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 10.0000 should be equal to 14.0000 0.00000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 14.0000 is a periodic neighbor of 10.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 14.0000 should be equal to 10.0000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 14.0000 is a periodic neighbor of 14.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 14.0000 should be equal to 14.0000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 10.0000 is a periodic neighbor of 2.00000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 10.0000 should be equal to 2.00000 16.0000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 10.0000 is a periodic neighbor of 6.00000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 10.0000 should be equal to 6.00000 16.0000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 14.0000 is a periodic neighbor of 2.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 14.0000 should be equal to 2.00000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 14.0000 is a periodic neighbor of 6.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 14.0000 should be equal to 6.00000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 10.0000 is a periodic neighbor of 10.0000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 10.0000 should be equal to 10.0000 16.0000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 10.0000 is a periodic neighbor of 14.0000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 10.0000 should be equal to 14.0000 16.0000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 14.0000 is a periodic neighbor of 10.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 14.0000 should be equal to 10.0000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 14.0000 is a periodic neighbor of 14.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 14.0000 should be equal to 14.0000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::Next, we check the periodic faces on an adaptively refined mesh. +DEAL:0::All of the cells with periodic neighbors on rank 0 +DEAL:0::2.00000 16.0000 2.00000 is a periodic neighbor of 2.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 2.00000 should be equal to 2.00000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 2.00000 is a periodic neighbor of 6.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 2.00000 should be equal to 6.00000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 16.0000 6.00000 is a periodic neighbor of 2.00000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 6.00000 should be equal to 2.00000 0.00000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 2.00000 is a periodic neighbor of 10.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 2.00000 should be equal to 10.0000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 2.00000 is a periodic neighbor of 14.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 2.00000 should be equal to 14.0000 0.00000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 6.00000 is a periodic neighbor of 14.0000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 6.00000 should be equal to 14.0000 0.00000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 2.00000 is a periodic neighbor of 2.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 2.00000 should be equal to 2.00000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 2.00000 is a periodic neighbor of 6.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 2.00000 should be equal to 6.00000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 6.00000 is a periodic neighbor of 2.00000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 6.00000 should be equal to 2.00000 16.0000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 2.00000 is a periodic neighbor of 10.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 2.00000 should be equal to 10.0000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 2.00000 is a periodic neighbor of 14.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 2.00000 should be equal to 14.0000 16.0000 2.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 6.00000 is a periodic neighbor of 14.0000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 6.00000 should be equal to 14.0000 16.0000 6.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 16.0000 10.0000 is a periodic neighbor of 2.00000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 10.0000 should be equal to 2.00000 0.00000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 16.0000 14.0000 is a periodic neighbor of 2.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 0.00000 14.0000 should be equal to 2.00000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 16.0000 14.0000 is a periodic neighbor of 6.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 0.00000 14.0000 should be equal to 6.00000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 10.0000 is a periodic neighbor of 14.0000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 10.0000 should be equal to 14.0000 0.00000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 16.0000 14.0000 is a periodic neighbor of 10.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 0.00000 14.0000 should be equal to 10.0000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 16.0000 14.0000 is a periodic neighbor of 14.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 0.00000 14.0000 should be equal to 14.0000 0.00000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 10.0000 is a periodic neighbor of 2.00000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 10.0000 should be equal to 2.00000 16.0000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::2.00000 0.00000 14.0000 is a periodic neighbor of 2.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 2.00000 16.0000 14.0000 should be equal to 2.00000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::6.00000 0.00000 14.0000 is a periodic neighbor of 6.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 6.00000 16.0000 14.0000 should be equal to 6.00000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 10.0000 is a periodic neighbor of 14.0000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 10.0000 should be equal to 14.0000 16.0000 10.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::10.0000 0.00000 14.0000 is a periodic neighbor of 10.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 10.0000 16.0000 14.0000 should be equal to 10.0000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::14.0000 0.00000 14.0000 is a periodic neighbor of 14.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 14.0000 16.0000 14.0000 should be equal to 14.0000 16.0000 14.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 0.00000 5.00000 is a periodic neighbor of 5.00000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 16.0000 5.00000 should be equal to 5.00000 16.0000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 5.00000 is a periodic neighbor of 7.00000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 5.00000 should be equal to 7.00000 16.0000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 0.00000 7.00000 is a periodic neighbor of 5.00000 16.0000 7.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 16.0000 7.00000 should be equal to 5.00000 16.0000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 16.0000 5.00000 is a periodic neighbor of 5.00000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 0.00000 5.00000 should be equal to 5.00000 0.00000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 16.0000 5.00000 is a periodic neighbor of 7.00000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 0.00000 5.00000 should be equal to 7.00000 0.00000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 16.0000 7.00000 is a periodic neighbor of 5.00000 0.00000 7.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 0.00000 7.00000 should be equal to 5.00000 0.00000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 16.0000 7.00000 is a periodic neighbor of 7.00000 0.00000 7.00000. And periodic neighbor is refined. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 0.00000 7.00000 should be equal to 7.00000 0.00000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 16.0000 5.00000 is a periodic neighbor of 9.00000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 0.00000 5.00000 should be equal to 9.00000 0.00000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 16.0000 5.00000 is a periodic neighbor of 11.0000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 0.00000 5.00000 should be equal to 11.0000 0.00000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 16.0000 7.00000 is a periodic neighbor of 9.00000 0.00000 7.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 0.00000 7.00000 should be equal to 9.00000 0.00000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 16.0000 7.00000 is a periodic neighbor of 11.0000 0.00000 7.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 0.00000 7.00000 should be equal to 11.0000 0.00000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 0.00000 5.00000 is a periodic neighbor of 9.00000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 16.0000 5.00000 should be equal to 9.00000 16.0000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 0.00000 5.00000 is a periodic neighbor of 11.0000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 16.0000 5.00000 should be equal to 11.0000 16.0000 5.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 0.00000 7.00000 is a periodic neighbor of 9.00000 16.0000 7.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 16.0000 7.00000 should be equal to 9.00000 16.0000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 0.00000 7.00000 is a periodic neighbor of 11.0000 16.0000 7.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 16.0000 7.00000 should be equal to 11.0000 16.0000 7.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 16.0000 9.00000 is a periodic neighbor of 5.00000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 0.00000 9.00000 should be equal to 5.00000 0.00000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 16.0000 9.00000 is a periodic neighbor of 7.00000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 0.00000 9.00000 should be equal to 7.00000 0.00000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 16.0000 11.0000 is a periodic neighbor of 5.00000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 0.00000 11.0000 should be equal to 5.00000 0.00000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 16.0000 11.0000 is a periodic neighbor of 7.00000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 0.00000 11.0000 should be equal to 7.00000 0.00000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 16.0000 9.00000 is a periodic neighbor of 9.00000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 0.00000 9.00000 should be equal to 9.00000 0.00000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 16.0000 9.00000 is a periodic neighbor of 11.0000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 0.00000 9.00000 should be equal to 11.0000 0.00000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 16.0000 11.0000 is a periodic neighbor of 9.00000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 0.00000 11.0000 should be equal to 9.00000 0.00000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 16.0000 11.0000 is a periodic neighbor of 11.0000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 0.00000 11.0000 should be equal to 11.0000 0.00000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 0.00000 9.00000 is a periodic neighbor of 5.00000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 16.0000 9.00000 should be equal to 5.00000 16.0000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 9.00000 is a periodic neighbor of 7.00000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 9.00000 should be equal to 7.00000 16.0000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::5.00000 0.00000 11.0000 is a periodic neighbor of 5.00000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 5.00000 16.0000 11.0000 should be equal to 5.00000 16.0000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 11.0000 is a periodic neighbor of 7.00000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 11.0000 should be equal to 7.00000 16.0000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 0.00000 9.00000 is a periodic neighbor of 9.00000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 16.0000 9.00000 should be equal to 9.00000 16.0000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 0.00000 9.00000 is a periodic neighbor of 11.0000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 16.0000 9.00000 should be equal to 11.0000 16.0000 9.00000 +DEAL:0::------------------------------------------------------- +DEAL:0::9.00000 0.00000 11.0000 is a periodic neighbor of 9.00000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 9.00000 16.0000 11.0000 should be equal to 9.00000 16.0000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::11.0000 0.00000 11.0000 is a periodic neighbor of 11.0000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:0::If the periodic neighbor is not coarser, 11.0000 16.0000 11.0000 should be equal to 11.0000 16.0000 11.0000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 7.00000 is a periodic neighbor of 6.50000 16.0000 6.50000. And periodic neighbor is coarser. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 6.50000 16.0000 6.50000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 7.00000 is a periodic neighbor of 7.50000 16.0000 6.50000. And periodic neighbor is coarser. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 7.50000 16.0000 6.50000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 7.00000 is a periodic neighbor of 6.50000 16.0000 7.50000. And periodic neighbor is coarser. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 6.50000 16.0000 7.50000 +DEAL:0::------------------------------------------------------- +DEAL:0::7.00000 0.00000 7.00000 is a periodic neighbor of 7.50000 16.0000 7.50000. And periodic neighbor is coarser. +DEAL:0::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 7.50000 16.0000 7.50000 +DEAL:0::------------------------------------------------------- +JobId water.ices.utexas.edu Wed Mar 23 14:12:03 2016 +DEAL:1::All of the cells with periodic neighbors on rank 1 +DEAL:1::2.00000 16.0000 is a periodic neighbor of 2.00000 0.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 0.00000 should be equal to 2.00000 0.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 16.0000 is a periodic neighbor of 6.00000 0.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 0.00000 should be equal to 6.00000 0.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 16.0000 is a periodic neighbor of 10.0000 0.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 0.00000 should be equal to 10.0000 0.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 16.0000 is a periodic neighbor of 14.0000 0.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 0.00000 should be equal to 14.0000 0.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 0.00000 is a periodic neighbor of 2.00000 16.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 16.0000 should be equal to 2.00000 16.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 0.00000 is a periodic neighbor of 6.00000 16.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 16.0000 should be equal to 6.00000 16.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 0.00000 is a periodic neighbor of 10.0000 16.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 16.0000 should be equal to 10.0000 16.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 0.00000 is a periodic neighbor of 14.0000 16.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 16.0000 should be equal to 14.0000 16.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::All of the cells with periodic neighbors on rank 1 +DEAL:1::2.00000 16.0000 is a periodic neighbor of 2.00000 0.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 0.00000 should be equal to 2.00000 0.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 16.0000 is a periodic neighbor of 14.0000 0.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 0.00000 should be equal to 14.0000 0.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 0.00000 is a periodic neighbor of 2.00000 16.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 16.0000 should be equal to 2.00000 16.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 0.00000 is a periodic neighbor of 14.0000 16.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 16.0000 should be equal to 14.0000 16.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::5.00000 0.00000 is a periodic neighbor of 5.00000 16.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 5.00000 16.0000 should be equal to 5.00000 16.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::5.00000 16.0000 is a periodic neighbor of 5.00000 0.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 5.00000 0.00000 should be equal to 5.00000 0.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 16.0000 is a periodic neighbor of 7.00000 0.00000. And periodic neighbor is refined. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 0.00000 should be equal to 7.00000 0.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::9.00000 16.0000 is a periodic neighbor of 9.00000 0.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 9.00000 0.00000 should be equal to 9.00000 0.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::11.0000 16.0000 is a periodic neighbor of 11.0000 0.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 11.0000 0.00000 should be equal to 11.0000 0.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::9.00000 0.00000 is a periodic neighbor of 9.00000 16.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 9.00000 16.0000 should be equal to 9.00000 16.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::11.0000 0.00000 is a periodic neighbor of 11.0000 16.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 11.0000 16.0000 should be equal to 11.0000 16.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 0.00000 is a periodic neighbor of 6.50000 16.0000. And periodic neighbor is coarser. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 16.0000 should be equal to 6.50000 16.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 0.00000 is a periodic neighbor of 7.50000 16.0000. And periodic neighbor is coarser. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 16.0000 should be equal to 7.50000 16.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::All of the cells with periodic neighbors on rank 1 +DEAL:1::2.00000 16.0000 2.00000 is a periodic neighbor of 2.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 0.00000 2.00000 should be equal to 2.00000 0.00000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 16.0000 2.00000 is a periodic neighbor of 6.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 0.00000 2.00000 should be equal to 6.00000 0.00000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 16.0000 6.00000 is a periodic neighbor of 2.00000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 0.00000 6.00000 should be equal to 2.00000 0.00000 6.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 16.0000 6.00000 is a periodic neighbor of 6.00000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 0.00000 6.00000 should be equal to 6.00000 0.00000 6.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 16.0000 2.00000 is a periodic neighbor of 10.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 0.00000 2.00000 should be equal to 10.0000 0.00000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 16.0000 2.00000 is a periodic neighbor of 14.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 0.00000 2.00000 should be equal to 14.0000 0.00000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 16.0000 6.00000 is a periodic neighbor of 10.0000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 0.00000 6.00000 should be equal to 10.0000 0.00000 6.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 16.0000 6.00000 is a periodic neighbor of 14.0000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 0.00000 6.00000 should be equal to 14.0000 0.00000 6.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 0.00000 2.00000 is a periodic neighbor of 2.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 16.0000 2.00000 should be equal to 2.00000 16.0000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 0.00000 2.00000 is a periodic neighbor of 6.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 16.0000 2.00000 should be equal to 6.00000 16.0000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 0.00000 6.00000 is a periodic neighbor of 2.00000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 16.0000 6.00000 should be equal to 2.00000 16.0000 6.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 0.00000 6.00000 is a periodic neighbor of 6.00000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 16.0000 6.00000 should be equal to 6.00000 16.0000 6.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 0.00000 2.00000 is a periodic neighbor of 10.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 16.0000 2.00000 should be equal to 10.0000 16.0000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 0.00000 2.00000 is a periodic neighbor of 14.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 16.0000 2.00000 should be equal to 14.0000 16.0000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 0.00000 6.00000 is a periodic neighbor of 10.0000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 16.0000 6.00000 should be equal to 10.0000 16.0000 6.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 0.00000 6.00000 is a periodic neighbor of 14.0000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 16.0000 6.00000 should be equal to 14.0000 16.0000 6.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 16.0000 10.0000 is a periodic neighbor of 2.00000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 0.00000 10.0000 should be equal to 2.00000 0.00000 10.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 16.0000 10.0000 is a periodic neighbor of 6.00000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 0.00000 10.0000 should be equal to 6.00000 0.00000 10.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 16.0000 14.0000 is a periodic neighbor of 2.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 0.00000 14.0000 should be equal to 2.00000 0.00000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 16.0000 14.0000 is a periodic neighbor of 6.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 0.00000 14.0000 should be equal to 6.00000 0.00000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 16.0000 10.0000 is a periodic neighbor of 10.0000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 0.00000 10.0000 should be equal to 10.0000 0.00000 10.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 16.0000 10.0000 is a periodic neighbor of 14.0000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 0.00000 10.0000 should be equal to 14.0000 0.00000 10.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 16.0000 14.0000 is a periodic neighbor of 10.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 0.00000 14.0000 should be equal to 10.0000 0.00000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 16.0000 14.0000 is a periodic neighbor of 14.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 0.00000 14.0000 should be equal to 14.0000 0.00000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 0.00000 10.0000 is a periodic neighbor of 2.00000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 16.0000 10.0000 should be equal to 2.00000 16.0000 10.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 0.00000 10.0000 is a periodic neighbor of 6.00000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 16.0000 10.0000 should be equal to 6.00000 16.0000 10.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 0.00000 14.0000 is a periodic neighbor of 2.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 16.0000 14.0000 should be equal to 2.00000 16.0000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 0.00000 14.0000 is a periodic neighbor of 6.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 16.0000 14.0000 should be equal to 6.00000 16.0000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 0.00000 10.0000 is a periodic neighbor of 10.0000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 16.0000 10.0000 should be equal to 10.0000 16.0000 10.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 0.00000 10.0000 is a periodic neighbor of 14.0000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 16.0000 10.0000 should be equal to 14.0000 16.0000 10.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 0.00000 14.0000 is a periodic neighbor of 10.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 16.0000 14.0000 should be equal to 10.0000 16.0000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 0.00000 14.0000 is a periodic neighbor of 14.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 16.0000 14.0000 should be equal to 14.0000 16.0000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::All of the cells with periodic neighbors on rank 1 +DEAL:1::2.00000 16.0000 2.00000 is a periodic neighbor of 2.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 0.00000 2.00000 should be equal to 2.00000 0.00000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 16.0000 2.00000 is a periodic neighbor of 6.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 0.00000 2.00000 should be equal to 6.00000 0.00000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 16.0000 6.00000 is a periodic neighbor of 2.00000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 0.00000 6.00000 should be equal to 2.00000 0.00000 6.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 16.0000 2.00000 is a periodic neighbor of 10.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 0.00000 2.00000 should be equal to 10.0000 0.00000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 16.0000 2.00000 is a periodic neighbor of 14.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 0.00000 2.00000 should be equal to 14.0000 0.00000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 16.0000 6.00000 is a periodic neighbor of 14.0000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 0.00000 6.00000 should be equal to 14.0000 0.00000 6.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 0.00000 2.00000 is a periodic neighbor of 2.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 16.0000 2.00000 should be equal to 2.00000 16.0000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 0.00000 2.00000 is a periodic neighbor of 6.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 16.0000 2.00000 should be equal to 6.00000 16.0000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 0.00000 6.00000 is a periodic neighbor of 2.00000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 16.0000 6.00000 should be equal to 2.00000 16.0000 6.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 0.00000 2.00000 is a periodic neighbor of 10.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 16.0000 2.00000 should be equal to 10.0000 16.0000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 0.00000 2.00000 is a periodic neighbor of 14.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 16.0000 2.00000 should be equal to 14.0000 16.0000 2.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 0.00000 6.00000 is a periodic neighbor of 14.0000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 16.0000 6.00000 should be equal to 14.0000 16.0000 6.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 16.0000 10.0000 is a periodic neighbor of 2.00000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 0.00000 10.0000 should be equal to 2.00000 0.00000 10.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 16.0000 14.0000 is a periodic neighbor of 2.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 0.00000 14.0000 should be equal to 2.00000 0.00000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 16.0000 14.0000 is a periodic neighbor of 6.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 0.00000 14.0000 should be equal to 6.00000 0.00000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 16.0000 10.0000 is a periodic neighbor of 14.0000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 0.00000 10.0000 should be equal to 14.0000 0.00000 10.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 16.0000 14.0000 is a periodic neighbor of 10.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 0.00000 14.0000 should be equal to 10.0000 0.00000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 16.0000 14.0000 is a periodic neighbor of 14.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 0.00000 14.0000 should be equal to 14.0000 0.00000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 0.00000 10.0000 is a periodic neighbor of 2.00000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 16.0000 10.0000 should be equal to 2.00000 16.0000 10.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::2.00000 0.00000 14.0000 is a periodic neighbor of 2.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 2.00000 16.0000 14.0000 should be equal to 2.00000 16.0000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::6.00000 0.00000 14.0000 is a periodic neighbor of 6.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 6.00000 16.0000 14.0000 should be equal to 6.00000 16.0000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 0.00000 10.0000 is a periodic neighbor of 14.0000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 16.0000 10.0000 should be equal to 14.0000 16.0000 10.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::10.0000 0.00000 14.0000 is a periodic neighbor of 10.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 10.0000 16.0000 14.0000 should be equal to 10.0000 16.0000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::14.0000 0.00000 14.0000 is a periodic neighbor of 14.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 14.0000 16.0000 14.0000 should be equal to 14.0000 16.0000 14.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::5.00000 0.00000 5.00000 is a periodic neighbor of 5.00000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 5.00000 16.0000 5.00000 should be equal to 5.00000 16.0000 5.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 0.00000 5.00000 is a periodic neighbor of 7.00000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 16.0000 5.00000 should be equal to 7.00000 16.0000 5.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::5.00000 0.00000 7.00000 is a periodic neighbor of 5.00000 16.0000 7.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 5.00000 16.0000 7.00000 should be equal to 5.00000 16.0000 7.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::5.00000 16.0000 5.00000 is a periodic neighbor of 5.00000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 5.00000 0.00000 5.00000 should be equal to 5.00000 0.00000 5.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 16.0000 5.00000 is a periodic neighbor of 7.00000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 0.00000 5.00000 should be equal to 7.00000 0.00000 5.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::5.00000 16.0000 7.00000 is a periodic neighbor of 5.00000 0.00000 7.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 5.00000 0.00000 7.00000 should be equal to 5.00000 0.00000 7.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 16.0000 7.00000 is a periodic neighbor of 7.00000 0.00000 7.00000. And periodic neighbor is refined. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 0.00000 7.00000 should be equal to 7.00000 0.00000 7.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::9.00000 16.0000 5.00000 is a periodic neighbor of 9.00000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 9.00000 0.00000 5.00000 should be equal to 9.00000 0.00000 5.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::11.0000 16.0000 5.00000 is a periodic neighbor of 11.0000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 11.0000 0.00000 5.00000 should be equal to 11.0000 0.00000 5.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::9.00000 16.0000 7.00000 is a periodic neighbor of 9.00000 0.00000 7.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 9.00000 0.00000 7.00000 should be equal to 9.00000 0.00000 7.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::11.0000 16.0000 7.00000 is a periodic neighbor of 11.0000 0.00000 7.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 11.0000 0.00000 7.00000 should be equal to 11.0000 0.00000 7.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::9.00000 0.00000 5.00000 is a periodic neighbor of 9.00000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 9.00000 16.0000 5.00000 should be equal to 9.00000 16.0000 5.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::11.0000 0.00000 5.00000 is a periodic neighbor of 11.0000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 11.0000 16.0000 5.00000 should be equal to 11.0000 16.0000 5.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::9.00000 0.00000 7.00000 is a periodic neighbor of 9.00000 16.0000 7.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 9.00000 16.0000 7.00000 should be equal to 9.00000 16.0000 7.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::11.0000 0.00000 7.00000 is a periodic neighbor of 11.0000 16.0000 7.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 11.0000 16.0000 7.00000 should be equal to 11.0000 16.0000 7.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::5.00000 16.0000 9.00000 is a periodic neighbor of 5.00000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 5.00000 0.00000 9.00000 should be equal to 5.00000 0.00000 9.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 16.0000 9.00000 is a periodic neighbor of 7.00000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 0.00000 9.00000 should be equal to 7.00000 0.00000 9.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::5.00000 16.0000 11.0000 is a periodic neighbor of 5.00000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 5.00000 0.00000 11.0000 should be equal to 5.00000 0.00000 11.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 16.0000 11.0000 is a periodic neighbor of 7.00000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 0.00000 11.0000 should be equal to 7.00000 0.00000 11.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::9.00000 16.0000 9.00000 is a periodic neighbor of 9.00000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 9.00000 0.00000 9.00000 should be equal to 9.00000 0.00000 9.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::11.0000 16.0000 9.00000 is a periodic neighbor of 11.0000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 11.0000 0.00000 9.00000 should be equal to 11.0000 0.00000 9.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::9.00000 16.0000 11.0000 is a periodic neighbor of 9.00000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 9.00000 0.00000 11.0000 should be equal to 9.00000 0.00000 11.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::11.0000 16.0000 11.0000 is a periodic neighbor of 11.0000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 11.0000 0.00000 11.0000 should be equal to 11.0000 0.00000 11.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::5.00000 0.00000 9.00000 is a periodic neighbor of 5.00000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 5.00000 16.0000 9.00000 should be equal to 5.00000 16.0000 9.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 0.00000 9.00000 is a periodic neighbor of 7.00000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 16.0000 9.00000 should be equal to 7.00000 16.0000 9.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::5.00000 0.00000 11.0000 is a periodic neighbor of 5.00000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 5.00000 16.0000 11.0000 should be equal to 5.00000 16.0000 11.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 0.00000 11.0000 is a periodic neighbor of 7.00000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 16.0000 11.0000 should be equal to 7.00000 16.0000 11.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::9.00000 0.00000 9.00000 is a periodic neighbor of 9.00000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 9.00000 16.0000 9.00000 should be equal to 9.00000 16.0000 9.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::11.0000 0.00000 9.00000 is a periodic neighbor of 11.0000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 11.0000 16.0000 9.00000 should be equal to 11.0000 16.0000 9.00000 +DEAL:1::------------------------------------------------------- +DEAL:1::9.00000 0.00000 11.0000 is a periodic neighbor of 9.00000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 9.00000 16.0000 11.0000 should be equal to 9.00000 16.0000 11.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::11.0000 0.00000 11.0000 is a periodic neighbor of 11.0000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:1::If the periodic neighbor is not coarser, 11.0000 16.0000 11.0000 should be equal to 11.0000 16.0000 11.0000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 0.00000 7.00000 is a periodic neighbor of 6.50000 16.0000 6.50000. And periodic neighbor is coarser. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 6.50000 16.0000 6.50000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 0.00000 7.00000 is a periodic neighbor of 7.50000 16.0000 6.50000. And periodic neighbor is coarser. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 7.50000 16.0000 6.50000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 0.00000 7.00000 is a periodic neighbor of 6.50000 16.0000 7.50000. And periodic neighbor is coarser. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 6.50000 16.0000 7.50000 +DEAL:1::------------------------------------------------------- +DEAL:1::7.00000 0.00000 7.00000 is a periodic neighbor of 7.50000 16.0000 7.50000. And periodic neighbor is coarser. +DEAL:1::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 7.50000 16.0000 7.50000 +DEAL:1::------------------------------------------------------- + +JobId water.ices.utexas.edu Wed Mar 23 14:12:03 2016 +DEAL:2::All of the cells with periodic neighbors on rank 2 +DEAL:2::2.00000 16.0000 is a periodic neighbor of 2.00000 0.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 0.00000 should be equal to 2.00000 0.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 16.0000 is a periodic neighbor of 6.00000 0.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 0.00000 should be equal to 6.00000 0.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 16.0000 is a periodic neighbor of 10.0000 0.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 0.00000 should be equal to 10.0000 0.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 16.0000 is a periodic neighbor of 14.0000 0.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 0.00000 should be equal to 14.0000 0.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 0.00000 is a periodic neighbor of 2.00000 16.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 16.0000 should be equal to 2.00000 16.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 0.00000 is a periodic neighbor of 6.00000 16.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 16.0000 should be equal to 6.00000 16.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 0.00000 is a periodic neighbor of 10.0000 16.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 16.0000 should be equal to 10.0000 16.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 0.00000 is a periodic neighbor of 14.0000 16.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 16.0000 should be equal to 14.0000 16.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::All of the cells with periodic neighbors on rank 2 +DEAL:2::2.00000 16.0000 is a periodic neighbor of 2.00000 0.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 0.00000 should be equal to 2.00000 0.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 16.0000 is a periodic neighbor of 14.0000 0.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 0.00000 should be equal to 14.0000 0.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 0.00000 is a periodic neighbor of 2.00000 16.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 16.0000 should be equal to 2.00000 16.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 0.00000 is a periodic neighbor of 14.0000 16.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 16.0000 should be equal to 14.0000 16.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::5.00000 0.00000 is a periodic neighbor of 5.00000 16.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 5.00000 16.0000 should be equal to 5.00000 16.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::5.00000 16.0000 is a periodic neighbor of 5.00000 0.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 5.00000 0.00000 should be equal to 5.00000 0.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 16.0000 is a periodic neighbor of 7.00000 0.00000. And periodic neighbor is refined. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 0.00000 should be equal to 7.00000 0.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::9.00000 16.0000 is a periodic neighbor of 9.00000 0.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 9.00000 0.00000 should be equal to 9.00000 0.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::11.0000 16.0000 is a periodic neighbor of 11.0000 0.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 11.0000 0.00000 should be equal to 11.0000 0.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::9.00000 0.00000 is a periodic neighbor of 9.00000 16.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 9.00000 16.0000 should be equal to 9.00000 16.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::11.0000 0.00000 is a periodic neighbor of 11.0000 16.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 11.0000 16.0000 should be equal to 11.0000 16.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 0.00000 is a periodic neighbor of 6.50000 16.0000. And periodic neighbor is coarser. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 16.0000 should be equal to 6.50000 16.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 0.00000 is a periodic neighbor of 7.50000 16.0000. And periodic neighbor is coarser. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 16.0000 should be equal to 7.50000 16.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::All of the cells with periodic neighbors on rank 2 +DEAL:2::2.00000 16.0000 2.00000 is a periodic neighbor of 2.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 0.00000 2.00000 should be equal to 2.00000 0.00000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 16.0000 2.00000 is a periodic neighbor of 6.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 0.00000 2.00000 should be equal to 6.00000 0.00000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 16.0000 6.00000 is a periodic neighbor of 2.00000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 0.00000 6.00000 should be equal to 2.00000 0.00000 6.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 16.0000 6.00000 is a periodic neighbor of 6.00000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 0.00000 6.00000 should be equal to 6.00000 0.00000 6.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 16.0000 2.00000 is a periodic neighbor of 10.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 0.00000 2.00000 should be equal to 10.0000 0.00000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 16.0000 2.00000 is a periodic neighbor of 14.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 0.00000 2.00000 should be equal to 14.0000 0.00000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 16.0000 6.00000 is a periodic neighbor of 10.0000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 0.00000 6.00000 should be equal to 10.0000 0.00000 6.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 16.0000 6.00000 is a periodic neighbor of 14.0000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 0.00000 6.00000 should be equal to 14.0000 0.00000 6.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 0.00000 2.00000 is a periodic neighbor of 2.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 16.0000 2.00000 should be equal to 2.00000 16.0000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 0.00000 2.00000 is a periodic neighbor of 6.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 16.0000 2.00000 should be equal to 6.00000 16.0000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 0.00000 6.00000 is a periodic neighbor of 2.00000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 16.0000 6.00000 should be equal to 2.00000 16.0000 6.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 0.00000 6.00000 is a periodic neighbor of 6.00000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 16.0000 6.00000 should be equal to 6.00000 16.0000 6.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 0.00000 2.00000 is a periodic neighbor of 10.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 16.0000 2.00000 should be equal to 10.0000 16.0000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 0.00000 2.00000 is a periodic neighbor of 14.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 16.0000 2.00000 should be equal to 14.0000 16.0000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 0.00000 6.00000 is a periodic neighbor of 10.0000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 16.0000 6.00000 should be equal to 10.0000 16.0000 6.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 0.00000 6.00000 is a periodic neighbor of 14.0000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 16.0000 6.00000 should be equal to 14.0000 16.0000 6.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 16.0000 10.0000 is a periodic neighbor of 2.00000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 0.00000 10.0000 should be equal to 2.00000 0.00000 10.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 16.0000 10.0000 is a periodic neighbor of 6.00000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 0.00000 10.0000 should be equal to 6.00000 0.00000 10.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 16.0000 14.0000 is a periodic neighbor of 2.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 0.00000 14.0000 should be equal to 2.00000 0.00000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 16.0000 14.0000 is a periodic neighbor of 6.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 0.00000 14.0000 should be equal to 6.00000 0.00000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 16.0000 10.0000 is a periodic neighbor of 10.0000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 0.00000 10.0000 should be equal to 10.0000 0.00000 10.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 16.0000 10.0000 is a periodic neighbor of 14.0000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 0.00000 10.0000 should be equal to 14.0000 0.00000 10.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 16.0000 14.0000 is a periodic neighbor of 10.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 0.00000 14.0000 should be equal to 10.0000 0.00000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 16.0000 14.0000 is a periodic neighbor of 14.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 0.00000 14.0000 should be equal to 14.0000 0.00000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 0.00000 10.0000 is a periodic neighbor of 2.00000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 16.0000 10.0000 should be equal to 2.00000 16.0000 10.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 0.00000 10.0000 is a periodic neighbor of 6.00000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 16.0000 10.0000 should be equal to 6.00000 16.0000 10.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 0.00000 14.0000 is a periodic neighbor of 2.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 16.0000 14.0000 should be equal to 2.00000 16.0000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 0.00000 14.0000 is a periodic neighbor of 6.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 16.0000 14.0000 should be equal to 6.00000 16.0000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 0.00000 10.0000 is a periodic neighbor of 10.0000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 16.0000 10.0000 should be equal to 10.0000 16.0000 10.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 0.00000 10.0000 is a periodic neighbor of 14.0000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 16.0000 10.0000 should be equal to 14.0000 16.0000 10.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 0.00000 14.0000 is a periodic neighbor of 10.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 16.0000 14.0000 should be equal to 10.0000 16.0000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 0.00000 14.0000 is a periodic neighbor of 14.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 16.0000 14.0000 should be equal to 14.0000 16.0000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::All of the cells with periodic neighbors on rank 2 +DEAL:2::2.00000 16.0000 2.00000 is a periodic neighbor of 2.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 0.00000 2.00000 should be equal to 2.00000 0.00000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 16.0000 2.00000 is a periodic neighbor of 6.00000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 0.00000 2.00000 should be equal to 6.00000 0.00000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 16.0000 6.00000 is a periodic neighbor of 2.00000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 0.00000 6.00000 should be equal to 2.00000 0.00000 6.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 16.0000 2.00000 is a periodic neighbor of 10.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 0.00000 2.00000 should be equal to 10.0000 0.00000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 16.0000 2.00000 is a periodic neighbor of 14.0000 0.00000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 0.00000 2.00000 should be equal to 14.0000 0.00000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 16.0000 6.00000 is a periodic neighbor of 14.0000 0.00000 6.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 0.00000 6.00000 should be equal to 14.0000 0.00000 6.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 0.00000 2.00000 is a periodic neighbor of 2.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 16.0000 2.00000 should be equal to 2.00000 16.0000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 0.00000 2.00000 is a periodic neighbor of 6.00000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 16.0000 2.00000 should be equal to 6.00000 16.0000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 0.00000 6.00000 is a periodic neighbor of 2.00000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 16.0000 6.00000 should be equal to 2.00000 16.0000 6.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 0.00000 2.00000 is a periodic neighbor of 10.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 16.0000 2.00000 should be equal to 10.0000 16.0000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 0.00000 2.00000 is a periodic neighbor of 14.0000 16.0000 2.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 16.0000 2.00000 should be equal to 14.0000 16.0000 2.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 0.00000 6.00000 is a periodic neighbor of 14.0000 16.0000 6.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 16.0000 6.00000 should be equal to 14.0000 16.0000 6.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 16.0000 10.0000 is a periodic neighbor of 2.00000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 0.00000 10.0000 should be equal to 2.00000 0.00000 10.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 16.0000 14.0000 is a periodic neighbor of 2.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 0.00000 14.0000 should be equal to 2.00000 0.00000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 16.0000 14.0000 is a periodic neighbor of 6.00000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 0.00000 14.0000 should be equal to 6.00000 0.00000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 16.0000 10.0000 is a periodic neighbor of 14.0000 0.00000 10.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 0.00000 10.0000 should be equal to 14.0000 0.00000 10.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 16.0000 14.0000 is a periodic neighbor of 10.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 0.00000 14.0000 should be equal to 10.0000 0.00000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 16.0000 14.0000 is a periodic neighbor of 14.0000 0.00000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 0.00000 14.0000 should be equal to 14.0000 0.00000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 0.00000 10.0000 is a periodic neighbor of 2.00000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 16.0000 10.0000 should be equal to 2.00000 16.0000 10.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::2.00000 0.00000 14.0000 is a periodic neighbor of 2.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 2.00000 16.0000 14.0000 should be equal to 2.00000 16.0000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::6.00000 0.00000 14.0000 is a periodic neighbor of 6.00000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 6.00000 16.0000 14.0000 should be equal to 6.00000 16.0000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 0.00000 10.0000 is a periodic neighbor of 14.0000 16.0000 10.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 16.0000 10.0000 should be equal to 14.0000 16.0000 10.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::10.0000 0.00000 14.0000 is a periodic neighbor of 10.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 10.0000 16.0000 14.0000 should be equal to 10.0000 16.0000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::14.0000 0.00000 14.0000 is a periodic neighbor of 14.0000 16.0000 14.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 14.0000 16.0000 14.0000 should be equal to 14.0000 16.0000 14.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::5.00000 0.00000 5.00000 is a periodic neighbor of 5.00000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 5.00000 16.0000 5.00000 should be equal to 5.00000 16.0000 5.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 0.00000 5.00000 is a periodic neighbor of 7.00000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 16.0000 5.00000 should be equal to 7.00000 16.0000 5.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::5.00000 0.00000 7.00000 is a periodic neighbor of 5.00000 16.0000 7.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 5.00000 16.0000 7.00000 should be equal to 5.00000 16.0000 7.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::5.00000 16.0000 5.00000 is a periodic neighbor of 5.00000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 5.00000 0.00000 5.00000 should be equal to 5.00000 0.00000 5.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 16.0000 5.00000 is a periodic neighbor of 7.00000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 0.00000 5.00000 should be equal to 7.00000 0.00000 5.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::5.00000 16.0000 7.00000 is a periodic neighbor of 5.00000 0.00000 7.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 5.00000 0.00000 7.00000 should be equal to 5.00000 0.00000 7.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 16.0000 7.00000 is a periodic neighbor of 7.00000 0.00000 7.00000. And periodic neighbor is refined. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 0.00000 7.00000 should be equal to 7.00000 0.00000 7.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::9.00000 16.0000 5.00000 is a periodic neighbor of 9.00000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 9.00000 0.00000 5.00000 should be equal to 9.00000 0.00000 5.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::11.0000 16.0000 5.00000 is a periodic neighbor of 11.0000 0.00000 5.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 11.0000 0.00000 5.00000 should be equal to 11.0000 0.00000 5.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::9.00000 16.0000 7.00000 is a periodic neighbor of 9.00000 0.00000 7.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 9.00000 0.00000 7.00000 should be equal to 9.00000 0.00000 7.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::11.0000 16.0000 7.00000 is a periodic neighbor of 11.0000 0.00000 7.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 11.0000 0.00000 7.00000 should be equal to 11.0000 0.00000 7.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::9.00000 0.00000 5.00000 is a periodic neighbor of 9.00000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 9.00000 16.0000 5.00000 should be equal to 9.00000 16.0000 5.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::11.0000 0.00000 5.00000 is a periodic neighbor of 11.0000 16.0000 5.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 11.0000 16.0000 5.00000 should be equal to 11.0000 16.0000 5.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::9.00000 0.00000 7.00000 is a periodic neighbor of 9.00000 16.0000 7.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 9.00000 16.0000 7.00000 should be equal to 9.00000 16.0000 7.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::11.0000 0.00000 7.00000 is a periodic neighbor of 11.0000 16.0000 7.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 11.0000 16.0000 7.00000 should be equal to 11.0000 16.0000 7.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::5.00000 16.0000 9.00000 is a periodic neighbor of 5.00000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 5.00000 0.00000 9.00000 should be equal to 5.00000 0.00000 9.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 16.0000 9.00000 is a periodic neighbor of 7.00000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 0.00000 9.00000 should be equal to 7.00000 0.00000 9.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::5.00000 16.0000 11.0000 is a periodic neighbor of 5.00000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 5.00000 0.00000 11.0000 should be equal to 5.00000 0.00000 11.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 16.0000 11.0000 is a periodic neighbor of 7.00000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 0.00000 11.0000 should be equal to 7.00000 0.00000 11.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::9.00000 16.0000 9.00000 is a periodic neighbor of 9.00000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 9.00000 0.00000 9.00000 should be equal to 9.00000 0.00000 9.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::11.0000 16.0000 9.00000 is a periodic neighbor of 11.0000 0.00000 9.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 11.0000 0.00000 9.00000 should be equal to 11.0000 0.00000 9.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::9.00000 16.0000 11.0000 is a periodic neighbor of 9.00000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 9.00000 0.00000 11.0000 should be equal to 9.00000 0.00000 11.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::11.0000 16.0000 11.0000 is a periodic neighbor of 11.0000 0.00000 11.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 11.0000 0.00000 11.0000 should be equal to 11.0000 0.00000 11.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::5.00000 0.00000 9.00000 is a periodic neighbor of 5.00000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 5.00000 16.0000 9.00000 should be equal to 5.00000 16.0000 9.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 0.00000 9.00000 is a periodic neighbor of 7.00000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 16.0000 9.00000 should be equal to 7.00000 16.0000 9.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::5.00000 0.00000 11.0000 is a periodic neighbor of 5.00000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 5.00000 16.0000 11.0000 should be equal to 5.00000 16.0000 11.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 0.00000 11.0000 is a periodic neighbor of 7.00000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 16.0000 11.0000 should be equal to 7.00000 16.0000 11.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::9.00000 0.00000 9.00000 is a periodic neighbor of 9.00000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 9.00000 16.0000 9.00000 should be equal to 9.00000 16.0000 9.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::11.0000 0.00000 9.00000 is a periodic neighbor of 11.0000 16.0000 9.00000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 11.0000 16.0000 9.00000 should be equal to 11.0000 16.0000 9.00000 +DEAL:2::------------------------------------------------------- +DEAL:2::9.00000 0.00000 11.0000 is a periodic neighbor of 9.00000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 9.00000 16.0000 11.0000 should be equal to 9.00000 16.0000 11.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::11.0000 0.00000 11.0000 is a periodic neighbor of 11.0000 16.0000 11.0000. And periodic neighbor has the same level. +DEAL:2::If the periodic neighbor is not coarser, 11.0000 16.0000 11.0000 should be equal to 11.0000 16.0000 11.0000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 0.00000 7.00000 is a periodic neighbor of 6.50000 16.0000 6.50000. And periodic neighbor is coarser. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 6.50000 16.0000 6.50000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 0.00000 7.00000 is a periodic neighbor of 7.50000 16.0000 6.50000. And periodic neighbor is coarser. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 7.50000 16.0000 6.50000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 0.00000 7.00000 is a periodic neighbor of 6.50000 16.0000 7.50000. And periodic neighbor is coarser. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 6.50000 16.0000 7.50000 +DEAL:2::------------------------------------------------------- +DEAL:2::7.00000 0.00000 7.00000 is a periodic neighbor of 7.50000 16.0000 7.50000. And periodic neighbor is coarser. +DEAL:2::If the periodic neighbor is not coarser, 7.00000 16.0000 7.00000 should be equal to 7.50000 16.0000 7.50000 +DEAL:2::------------------------------------------------------- +