]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Add test
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Sun, 18 Oct 2015 13:44:02 +0000 (15:44 +0200)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Mon, 19 Oct 2015 13:41:41 +0000 (15:41 +0200)
tests/mpi/mg_ghost_dofs_periodic_01.cc [new file with mode: 0644]
tests/mpi/mg_ghost_dofs_periodic_01.with_p4est=true.mpirun=3.output [new file with mode: 0644]
tests/mpi/mg_ghost_dofs_periodic_01.with_p4est=true.mpirun=7.output [new file with mode: 0644]

diff --git a/tests/mpi/mg_ghost_dofs_periodic_01.cc b/tests/mpi/mg_ghost_dofs_periodic_01.cc
new file mode 100644 (file)
index 0000000..257040a
--- /dev/null
@@ -0,0 +1,132 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2015 - 2015 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 distribute_mg_dofs and the ghost layer for periodic boundary
+// conditions
+
+#include "../tests.h"
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_tools.h>
+#include <deal.II/distributed/grid_refinement.h>
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/fe/fe_q.h>
+
+
+template <int dim>
+void test()
+{
+  parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
+                                                 Triangulation<dim>::none,
+                                                 parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
+  std::vector<unsigned int> subdivisions(dim);
+  Point<dim> p1, p2;
+  for (unsigned int d=0; d<dim; ++d)
+    {
+      if (dim == 2)
+        {
+          p2[d] = dim-d;
+          subdivisions[d] = 2-d;
+        }
+      else
+        {
+          p2[d] = 1;
+          subdivisions[d] = 1;
+        }
+    }
+  GridGenerator::subdivided_hyper_rectangle(tria, subdivisions, p1, p2);
+  for (typename Triangulation<dim>::cell_iterator cell=tria.begin();
+       cell != tria.end(); ++cell)
+    for (unsigned int face=0; face<GeometryInfo<dim>::faces_per_cell; ++face)
+      if (cell->at_boundary(face))
+        {
+          if (face >= 2)
+            cell->face(face)->set_all_boundary_ids(face);
+          else
+            cell->face(face)->set_all_boundary_ids(0);
+        }
+
+  std::vector<GridTools::PeriodicFacePair<typename Triangulation<dim>::cell_iterator> >
+  periodic_faces;
+  for (unsigned int d=1; d<dim; ++d)
+    GridTools::collect_periodic_faces(tria, 2*d, 2*d+1, d, periodic_faces);
+  tria.add_periodicity(periodic_faces);
+
+  tria.refine_global(5-dim);
+
+  FE_Q<dim> fe(1);
+  DoFHandler<dim> dof_handler(tria);
+  dof_handler.distribute_dofs(fe);
+  dof_handler.distribute_mg_dofs(fe);
+
+  std::vector<types::global_dof_index> dof_indices(fe.dofs_per_cell);
+  for (unsigned int level=0; level<tria.n_global_levels(); ++level)
+    {
+      deallog << "Level " << level << std::endl;
+      for (typename DoFHandler<dim>::cell_iterator cell=dof_handler.begin(level);
+           cell != dof_handler.end(level); ++cell)
+        if (cell->level_subdomain_id() != numbers::artificial_subdomain_id)
+          {
+            deallog << "Cell with center: " << cell->center() << ", owned by "
+                    << cell->level_subdomain_id() << ": ";
+            cell->get_mg_dof_indices(dof_indices);
+            for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
+              deallog << dof_indices[i] << " ";
+            deallog << std::endl;
+          }
+    }
+}
+
+
+
+int main(int argc, char *argv[])
+{
+  using namespace dealii;
+
+  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
+  MPILogInitAll log;
+  deallog << std::setprecision(4);
+
+  try
+    {
+      test<2>();
+      test<3>();
+    }
+  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/mg_ghost_dofs_periodic_01.with_p4est=true.mpirun=3.output b/tests/mpi/mg_ghost_dofs_periodic_01.with_p4est=true.mpirun=3.output
new file mode 100644 (file)
index 0000000..b1edf21
--- /dev/null
@@ -0,0 +1,548 @@
+
+DEAL:0::Level 0
+DEAL:0::Cell with center: 0.5000 0.5000, owned by 0: 0 1 2 3 
+DEAL:0::Cell with center: 1.500 0.5000, owned by 1: 1 4 3 5 
+DEAL:0::Level 1
+DEAL:0::Cell with center: 0.2500 0.2500, owned by 0: 0 1 2 3 
+DEAL:0::Cell with center: 0.7500 0.2500, owned by 0: 1 4 3 5 
+DEAL:0::Cell with center: 0.2500 0.7500, owned by 0: 2 3 6 7 
+DEAL:0::Cell with center: 0.7500 0.7500, owned by 1: 3 5 7 8 
+DEAL:0::Cell with center: 1.250 0.2500, owned by 1: 4 9 5 10 
+DEAL:0::Cell with center: 1.250 0.7500, owned by 2: 5 10 8 13 
+DEAL:0::Level 2
+DEAL:0::Cell with center: 0.1250 0.1250, owned by 0: 0 1 2 3 
+DEAL:0::Cell with center: 0.3750 0.1250, owned by 0: 1 4 3 5 
+DEAL:0::Cell with center: 0.1250 0.3750, owned by 0: 2 3 6 7 
+DEAL:0::Cell with center: 0.3750 0.3750, owned by 0: 3 5 7 8 
+DEAL:0::Cell with center: 0.6250 0.1250, owned by 0: 4 9 5 10 
+DEAL:0::Cell with center: 0.8750 0.1250, owned by 0: 9 11 10 12 
+DEAL:0::Cell with center: 0.6250 0.3750, owned by 0: 5 10 8 13 
+DEAL:0::Cell with center: 0.8750 0.3750, owned by 0: 10 12 13 14 
+DEAL:0::Cell with center: 0.1250 0.6250, owned by 0: 6 7 15 16 
+DEAL:0::Cell with center: 0.3750 0.6250, owned by 0: 7 8 16 17 
+DEAL:0::Cell with center: 0.1250 0.8750, owned by 0: 15 16 18 19 
+DEAL:0::Cell with center: 0.3750 0.8750, owned by 1: 16 17 19 20 
+DEAL:0::Cell with center: 0.6250 0.6250, owned by 1: 8 13 17 21 
+DEAL:0::Cell with center: 0.8750 0.6250, owned by 1: 13 14 21 22 
+DEAL:0::Cell with center: 0.6250 0.8750, owned by 1: 17 21 20 23 
+DEAL:0::Cell with center: 0.8750 0.8750, owned by 1: 21 22 23 24 
+DEAL:0::Cell with center: 1.125 0.1250, owned by 1: 11 25 12 26 
+DEAL:0::Cell with center: 1.125 0.3750, owned by 1: 12 26 14 29 
+DEAL:0::Cell with center: 1.125 0.6250, owned by 2: 14 29 22 37 
+DEAL:0::Cell with center: 1.125 0.8750, owned by 2: 22 37 24 39 
+DEAL:0::Level 3
+DEAL:0::Cell with center: 0.06250 0.06250, owned by 0: 0 1 2 3 
+DEAL:0::Cell with center: 0.1875 0.06250, owned by 0: 1 4 3 5 
+DEAL:0::Cell with center: 0.06250 0.1875, owned by 0: 2 3 6 7 
+DEAL:0::Cell with center: 0.1875 0.1875, owned by 0: 3 5 7 8 
+DEAL:0::Cell with center: 0.3125 0.06250, owned by 0: 4 9 5 10 
+DEAL:0::Cell with center: 0.4375 0.06250, owned by 0: 9 11 10 12 
+DEAL:0::Cell with center: 0.3125 0.1875, owned by 0: 5 10 8 13 
+DEAL:0::Cell with center: 0.4375 0.1875, owned by 0: 10 12 13 14 
+DEAL:0::Cell with center: 0.06250 0.3125, owned by 0: 6 7 15 16 
+DEAL:0::Cell with center: 0.1875 0.3125, owned by 0: 7 8 16 17 
+DEAL:0::Cell with center: 0.06250 0.4375, owned by 0: 15 16 18 19 
+DEAL:0::Cell with center: 0.1875 0.4375, owned by 0: 16 17 19 20 
+DEAL:0::Cell with center: 0.3125 0.3125, owned by 0: 8 13 17 21 
+DEAL:0::Cell with center: 0.4375 0.3125, owned by 0: 13 14 21 22 
+DEAL:0::Cell with center: 0.3125 0.4375, owned by 0: 17 21 20 23 
+DEAL:0::Cell with center: 0.4375 0.4375, owned by 0: 21 22 23 24 
+DEAL:0::Cell with center: 0.5625 0.06250, owned by 0: 11 25 12 26 
+DEAL:0::Cell with center: 0.6875 0.06250, owned by 0: 25 27 26 28 
+DEAL:0::Cell with center: 0.5625 0.1875, owned by 0: 12 26 14 29 
+DEAL:0::Cell with center: 0.6875 0.1875, owned by 0: 26 28 29 30 
+DEAL:0::Cell with center: 0.8125 0.06250, owned by 0: 27 31 28 32 
+DEAL:0::Cell with center: 0.9375 0.06250, owned by 0: 31 33 32 34 
+DEAL:0::Cell with center: 0.8125 0.1875, owned by 0: 28 32 30 35 
+DEAL:0::Cell with center: 0.9375 0.1875, owned by 0: 32 34 35 36 
+DEAL:0::Cell with center: 0.5625 0.3125, owned by 0: 14 29 22 37 
+DEAL:0::Cell with center: 0.6875 0.3125, owned by 0: 29 30 37 38 
+DEAL:0::Cell with center: 0.5625 0.4375, owned by 0: 22 37 24 39 
+DEAL:0::Cell with center: 0.6875 0.4375, owned by 0: 37 38 39 40 
+DEAL:0::Cell with center: 0.8125 0.3125, owned by 0: 30 35 38 41 
+DEAL:0::Cell with center: 0.9375 0.3125, owned by 0: 35 36 41 42 
+DEAL:0::Cell with center: 0.8125 0.4375, owned by 0: 38 41 40 43 
+DEAL:0::Cell with center: 0.9375 0.4375, owned by 0: 41 42 43 44 
+DEAL:0::Cell with center: 0.06250 0.5625, owned by 0: 18 19 45 46 
+DEAL:0::Cell with center: 0.1875 0.5625, owned by 0: 19 20 46 47 
+DEAL:0::Cell with center: 0.06250 0.6875, owned by 0: 45 46 48 49 
+DEAL:0::Cell with center: 0.1875 0.6875, owned by 0: 46 47 49 50 
+DEAL:0::Cell with center: 0.3125 0.5625, owned by 0: 20 23 47 51 
+DEAL:0::Cell with center: 0.4375 0.5625, owned by 0: 23 24 51 52 
+DEAL:0::Cell with center: 0.3125 0.6875, owned by 0: 47 51 50 53 
+DEAL:0::Cell with center: 0.4375 0.6875, owned by 0: 51 52 53 54 
+DEAL:0::Cell with center: 0.06250 0.8125, owned by 0: 48 49 55 56 
+DEAL:0::Cell with center: 0.1875 0.8125, owned by 0: 49 50 56 57 
+DEAL:0::Cell with center: 0.06250 0.9375, owned by 0: 55 56 58 59 
+DEAL:0::Cell with center: 0.1875 0.9375, owned by 0: 56 57 59 60 
+DEAL:0::Cell with center: 0.3125 0.8125, owned by 1: 50 53 57 61 
+DEAL:0::Cell with center: 0.4375 0.8125, owned by 1: 53 54 61 62 
+DEAL:0::Cell with center: 0.3125 0.9375, owned by 1: 57 61 60 63 
+DEAL:0::Cell with center: 0.4375 0.9375, owned by 1: 61 62 63 64 
+DEAL:0::Cell with center: 0.5625 0.5625, owned by 1: 24 39 52 65 
+DEAL:0::Cell with center: 0.6875 0.5625, owned by 1: 39 40 65 66 
+DEAL:0::Cell with center: 0.5625 0.6875, owned by 1: 52 65 54 67 
+DEAL:0::Cell with center: 0.8125 0.5625, owned by 1: 40 43 66 69 
+DEAL:0::Cell with center: 0.9375 0.5625, owned by 1: 43 44 69 70 
+DEAL:0::Cell with center: 0.5625 0.8125, owned by 1: 54 67 62 73 
+DEAL:0::Cell with center: 0.5625 0.9375, owned by 1: 62 73 64 75 
+DEAL:0::Cell with center: 0.6875 0.9375, owned by 1: 73 74 75 76 
+DEAL:0::Cell with center: 0.8125 0.9375, owned by 1: 74 77 76 79 
+DEAL:0::Cell with center: 0.9375 0.9375, owned by 1: 77 78 79 80 
+DEAL:0::Cell with center: 1.062 0.06250, owned by 1: 33 81 34 82 
+DEAL:0::Cell with center: 1.062 0.1875, owned by 1: 34 82 36 85 
+DEAL:0::Cell with center: 1.062 0.3125, owned by 1: 36 85 42 93 
+DEAL:0::Cell with center: 1.062 0.4375, owned by 1: 42 93 44 95 
+DEAL:0::Cell with center: 1.062 0.5625, owned by 2: 44 95 70 121 
+DEAL:0::Cell with center: 1.062 0.9375, owned by 2: 78 129 80 131 
+DEAL:0::Level 0
+DEAL:0::Cell with center: 0.5000 0.5000 0.5000, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:0::Level 1
+DEAL:0::Cell with center: 0.2500 0.2500 0.2500, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:0::Cell with center: 0.7500 0.2500 0.2500, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:0::Cell with center: 0.2500 0.7500 0.2500, owned by 0: 2 3 12 13 6 7 14 15 
+DEAL:0::Cell with center: 0.7500 0.7500 0.2500, owned by 1: 3 9 13 16 7 11 15 17 
+DEAL:0::Cell with center: 0.2500 0.2500 0.7500, owned by 1: 4 5 6 7 18 19 20 21 
+DEAL:0::Cell with center: 0.7500 0.2500 0.7500, owned by 2: 5 10 7 11 19 22 21 23 
+DEAL:0::Cell with center: 0.2500 0.7500 0.7500, owned by 2: 6 7 14 15 20 21 24 25 
+DEAL:0::Cell with center: 0.7500 0.7500 0.7500, owned by 2: 7 11 15 17 21 23 25 26 
+DEAL:0::Level 2
+DEAL:0::Cell with center: 0.1250 0.1250 0.1250, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:0::Cell with center: 0.3750 0.1250 0.1250, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:0::Cell with center: 0.1250 0.3750 0.1250, owned by 0: 2 3 12 13 6 7 14 15 
+DEAL:0::Cell with center: 0.3750 0.3750 0.1250, owned by 0: 3 9 13 16 7 11 15 17 
+DEAL:0::Cell with center: 0.1250 0.1250 0.3750, owned by 0: 4 5 6 7 18 19 20 21 
+DEAL:0::Cell with center: 0.3750 0.1250 0.3750, owned by 0: 5 10 7 11 19 22 21 23 
+DEAL:0::Cell with center: 0.1250 0.3750 0.3750, owned by 0: 6 7 14 15 20 21 24 25 
+DEAL:0::Cell with center: 0.3750 0.3750 0.3750, owned by 0: 7 11 15 17 21 23 25 26 
+DEAL:0::Cell with center: 0.6250 0.1250 0.1250, owned by 0: 8 27 9 28 10 29 11 30 
+DEAL:0::Cell with center: 0.8750 0.1250 0.1250, owned by 0: 27 31 28 32 29 33 30 34 
+DEAL:0::Cell with center: 0.6250 0.3750 0.1250, owned by 0: 9 28 16 35 11 30 17 36 
+DEAL:0::Cell with center: 0.8750 0.3750 0.1250, owned by 0: 28 32 35 37 30 34 36 38 
+DEAL:0::Cell with center: 0.6250 0.1250 0.3750, owned by 0: 10 29 11 30 22 39 23 40 
+DEAL:0::Cell with center: 0.8750 0.1250 0.3750, owned by 0: 29 33 30 34 39 41 40 42 
+DEAL:0::Cell with center: 0.6250 0.3750 0.3750, owned by 0: 11 30 17 36 23 40 26 43 
+DEAL:0::Cell with center: 0.8750 0.3750 0.3750, owned by 0: 30 34 36 38 40 42 43 44 
+DEAL:0::Cell with center: 0.1250 0.6250 0.1250, owned by 0: 12 13 45 46 14 15 47 48 
+DEAL:0::Cell with center: 0.3750 0.6250 0.1250, owned by 0: 13 16 46 49 15 17 48 50 
+DEAL:0::Cell with center: 0.1250 0.8750 0.1250, owned by 0: 45 46 51 52 47 48 53 54 
+DEAL:0::Cell with center: 0.3750 0.8750 0.1250, owned by 0: 46 49 52 55 48 50 54 56 
+DEAL:0::Cell with center: 0.1250 0.6250 0.3750, owned by 0: 14 15 47 48 24 25 57 58 
+DEAL:0::Cell with center: 0.3750 0.6250 0.3750, owned by 0: 15 17 48 50 25 26 58 59 
+DEAL:0::Cell with center: 0.1250 0.8750 0.3750, owned by 0: 47 48 53 54 57 58 60 61 
+DEAL:0::Cell with center: 0.3750 0.8750 0.3750, owned by 0: 48 50 54 56 58 59 61 62 
+DEAL:0::Cell with center: 0.6250 0.6250 0.1250, owned by 1: 16 35 49 63 17 36 50 64 
+DEAL:0::Cell with center: 0.8750 0.6250 0.1250, owned by 1: 35 37 63 65 36 38 64 66 
+DEAL:0::Cell with center: 0.6250 0.8750 0.1250, owned by 1: 49 63 55 67 50 64 56 68 
+DEAL:0::Cell with center: 0.8750 0.8750 0.1250, owned by 1: 63 65 67 69 64 66 68 70 
+DEAL:0::Cell with center: 0.6250 0.6250 0.3750, owned by 1: 17 36 50 64 26 43 59 71 
+DEAL:0::Cell with center: 0.8750 0.6250 0.3750, owned by 1: 36 38 64 66 43 44 71 72 
+DEAL:0::Cell with center: 0.6250 0.8750 0.3750, owned by 1: 50 64 56 68 59 71 62 73 
+DEAL:0::Cell with center: 0.8750 0.8750 0.3750, owned by 1: 64 66 68 70 71 72 73 74 
+DEAL:0::Cell with center: 0.1250 0.1250 0.6250, owned by 1: 18 19 20 21 75 76 77 78 
+DEAL:0::Cell with center: 0.3750 0.1250 0.6250, owned by 1: 19 22 21 23 76 79 78 80 
+DEAL:0::Cell with center: 0.1250 0.3750 0.6250, owned by 1: 20 21 24 25 77 78 81 82 
+DEAL:0::Cell with center: 0.3750 0.3750 0.6250, owned by 1: 21 23 25 26 78 80 82 83 
+DEAL:0::Cell with center: 0.1250 0.1250 0.8750, owned by 1: 75 76 77 78 84 85 86 87 
+DEAL:0::Cell with center: 0.3750 0.1250 0.8750, owned by 1: 76 79 78 80 85 88 87 89 
+DEAL:0::Cell with center: 0.1250 0.3750 0.8750, owned by 1: 77 78 81 82 86 87 90 91 
+DEAL:0::Cell with center: 0.3750 0.3750 0.8750, owned by 1: 78 80 82 83 87 89 91 92 
+DEAL:0::Cell with center: 0.6250 0.1250 0.6250, owned by 2: 22 39 23 40 79 93 80 94 
+DEAL:0::Cell with center: 0.8750 0.1250 0.6250, owned by 2: 39 41 40 42 93 95 94 96 
+DEAL:0::Cell with center: 0.6250 0.3750 0.6250, owned by 2: 23 40 26 43 80 94 83 97 
+DEAL:0::Cell with center: 0.8750 0.3750 0.6250, owned by 2: 40 42 43 44 94 96 97 98 
+DEAL:0::Cell with center: 0.6250 0.1250 0.8750, owned by 2: 79 93 80 94 88 99 89 100 
+DEAL:0::Cell with center: 0.8750 0.1250 0.8750, owned by 2: 93 95 94 96 99 101 100 102 
+DEAL:0::Cell with center: 0.6250 0.3750 0.8750, owned by 2: 80 94 83 97 89 100 92 103 
+DEAL:0::Cell with center: 0.8750 0.3750 0.8750, owned by 2: 94 96 97 98 100 102 103 104 
+DEAL:0::Cell with center: 0.1250 0.6250 0.6250, owned by 2: 24 25 57 58 81 82 105 106 
+DEAL:0::Cell with center: 0.3750 0.6250 0.6250, owned by 2: 25 26 58 59 82 83 106 107 
+DEAL:0::Cell with center: 0.1250 0.8750 0.6250, owned by 2: 57 58 60 61 105 106 108 109 
+DEAL:0::Cell with center: 0.3750 0.8750 0.6250, owned by 2: 58 59 61 62 106 107 109 110 
+DEAL:0::Cell with center: 0.1250 0.6250 0.8750, owned by 2: 81 82 105 106 90 91 111 112 
+DEAL:0::Cell with center: 0.3750 0.6250 0.8750, owned by 2: 82 83 106 107 91 92 112 113 
+DEAL:0::Cell with center: 0.1250 0.8750 0.8750, owned by 2: 105 106 108 109 111 112 114 115 
+DEAL:0::Cell with center: 0.3750 0.8750 0.8750, owned by 2: 106 107 109 110 112 113 115 116 
+DEAL:0::Cell with center: 0.6250 0.6250 0.6250, owned by 2: 26 43 59 71 83 97 107 117 
+DEAL:0::Cell with center: 0.8750 0.6250 0.6250, owned by 2: 43 44 71 72 97 98 117 118 
+DEAL:0::Cell with center: 0.6250 0.8750 0.6250, owned by 2: 59 71 62 73 107 117 110 119 
+DEAL:0::Cell with center: 0.8750 0.8750 0.6250, owned by 2: 71 72 73 74 117 118 119 120 
+DEAL:0::Cell with center: 0.6250 0.6250 0.8750, owned by 2: 83 97 107 117 92 103 113 121 
+DEAL:0::Cell with center: 0.8750 0.6250 0.8750, owned by 2: 97 98 117 118 103 104 121 122 
+DEAL:0::Cell with center: 0.6250 0.8750 0.8750, owned by 2: 107 117 110 119 113 121 116 123 
+DEAL:0::Cell with center: 0.8750 0.8750 0.8750, owned by 2: 117 118 119 120 121 122 123 124 
+
+DEAL:1::Level 0
+DEAL:1::Cell with center: 0.5000 0.5000, owned by 0: 0 1 2 3 
+DEAL:1::Cell with center: 1.500 0.5000, owned by 1: 1 4 3 5 
+DEAL:1::Level 1
+DEAL:1::Cell with center: 0.2500 0.2500, owned by 0: 0 1 2 3 
+DEAL:1::Cell with center: 0.7500 0.2500, owned by 0: 1 4 3 5 
+DEAL:1::Cell with center: 0.2500 0.7500, owned by 0: 2 3 6 7 
+DEAL:1::Cell with center: 0.7500 0.7500, owned by 1: 3 5 7 8 
+DEAL:1::Cell with center: 1.250 0.2500, owned by 1: 4 9 5 10 
+DEAL:1::Cell with center: 1.750 0.2500, owned by 1: 9 11 10 12 
+DEAL:1::Cell with center: 1.250 0.7500, owned by 2: 5 10 8 13 
+DEAL:1::Cell with center: 1.750 0.7500, owned by 2: 10 12 13 14 
+DEAL:1::Level 2
+DEAL:1::Cell with center: 0.1250 0.1250, owned by 0: 0 1 2 3 
+DEAL:1::Cell with center: 0.3750 0.1250, owned by 0: 1 4 3 5 
+DEAL:1::Cell with center: 0.3750 0.3750, owned by 0: 3 5 7 8 
+DEAL:1::Cell with center: 0.6250 0.1250, owned by 0: 4 9 5 10 
+DEAL:1::Cell with center: 0.8750 0.1250, owned by 0: 9 11 10 12 
+DEAL:1::Cell with center: 0.6250 0.3750, owned by 0: 5 10 8 13 
+DEAL:1::Cell with center: 0.8750 0.3750, owned by 0: 10 12 13 14 
+DEAL:1::Cell with center: 0.1250 0.6250, owned by 0: 6 7 15 16 
+DEAL:1::Cell with center: 0.3750 0.6250, owned by 0: 7 8 16 17 
+DEAL:1::Cell with center: 0.1250 0.8750, owned by 0: 15 16 18 19 
+DEAL:1::Cell with center: 0.3750 0.8750, owned by 1: 16 17 19 20 
+DEAL:1::Cell with center: 0.6250 0.6250, owned by 1: 8 13 17 21 
+DEAL:1::Cell with center: 0.8750 0.6250, owned by 1: 13 14 21 22 
+DEAL:1::Cell with center: 0.6250 0.8750, owned by 1: 17 21 20 23 
+DEAL:1::Cell with center: 0.8750 0.8750, owned by 1: 21 22 23 24 
+DEAL:1::Cell with center: 1.125 0.1250, owned by 1: 11 25 12 26 
+DEAL:1::Cell with center: 1.375 0.1250, owned by 1: 25 27 26 28 
+DEAL:1::Cell with center: 1.125 0.3750, owned by 1: 12 26 14 29 
+DEAL:1::Cell with center: 1.375 0.3750, owned by 1: 26 28 29 30 
+DEAL:1::Cell with center: 1.625 0.1250, owned by 1: 27 31 28 32 
+DEAL:1::Cell with center: 1.875 0.1250, owned by 2: 31 33 32 34 
+DEAL:1::Cell with center: 1.625 0.3750, owned by 2: 28 32 30 35 
+DEAL:1::Cell with center: 1.875 0.3750, owned by 2: 32 34 35 36 
+DEAL:1::Cell with center: 1.125 0.6250, owned by 2: 14 29 22 37 
+DEAL:1::Cell with center: 1.375 0.6250, owned by 2: 29 30 37 38 
+DEAL:1::Cell with center: 1.125 0.8750, owned by 2: 22 37 24 39 
+DEAL:1::Cell with center: 1.375 0.8750, owned by 2: 37 38 39 40 
+DEAL:1::Cell with center: 1.625 0.6250, owned by 2: 30 35 38 41 
+DEAL:1::Cell with center: 1.625 0.8750, owned by 2: 38 41 40 43 
+DEAL:1::Cell with center: 1.875 0.8750, owned by 2: 41 42 43 44 
+DEAL:1::Level 3
+DEAL:1::Cell with center: 0.1875 0.06250, owned by 0: 1 4 3 5 
+DEAL:1::Cell with center: 0.3125 0.06250, owned by 0: 4 9 5 10 
+DEAL:1::Cell with center: 0.4375 0.06250, owned by 0: 9 11 10 12 
+DEAL:1::Cell with center: 0.4375 0.4375, owned by 0: 21 22 23 24 
+DEAL:1::Cell with center: 0.5625 0.06250, owned by 0: 11 25 12 26 
+DEAL:1::Cell with center: 0.6875 0.06250, owned by 0: 25 27 26 28 
+DEAL:1::Cell with center: 0.8125 0.06250, owned by 0: 27 31 28 32 
+DEAL:1::Cell with center: 0.9375 0.06250, owned by 0: 31 33 32 34 
+DEAL:1::Cell with center: 0.9375 0.1875, owned by 0: 32 34 35 36 
+DEAL:1::Cell with center: 0.5625 0.4375, owned by 0: 22 37 24 39 
+DEAL:1::Cell with center: 0.6875 0.4375, owned by 0: 37 38 39 40 
+DEAL:1::Cell with center: 0.9375 0.3125, owned by 0: 35 36 41 42 
+DEAL:1::Cell with center: 0.8125 0.4375, owned by 0: 38 41 40 43 
+DEAL:1::Cell with center: 0.9375 0.4375, owned by 0: 41 42 43 44 
+DEAL:1::Cell with center: 0.1875 0.6875, owned by 0: 46 47 49 50 
+DEAL:1::Cell with center: 0.4375 0.5625, owned by 0: 23 24 51 52 
+DEAL:1::Cell with center: 0.3125 0.6875, owned by 0: 47 51 50 53 
+DEAL:1::Cell with center: 0.4375 0.6875, owned by 0: 51 52 53 54 
+DEAL:1::Cell with center: 0.1875 0.8125, owned by 0: 49 50 56 57 
+DEAL:1::Cell with center: 0.1875 0.9375, owned by 0: 56 57 59 60 
+DEAL:1::Cell with center: 0.3125 0.8125, owned by 1: 50 53 57 61 
+DEAL:1::Cell with center: 0.4375 0.8125, owned by 1: 53 54 61 62 
+DEAL:1::Cell with center: 0.3125 0.9375, owned by 1: 57 61 60 63 
+DEAL:1::Cell with center: 0.4375 0.9375, owned by 1: 61 62 63 64 
+DEAL:1::Cell with center: 0.5625 0.5625, owned by 1: 24 39 52 65 
+DEAL:1::Cell with center: 0.6875 0.5625, owned by 1: 39 40 65 66 
+DEAL:1::Cell with center: 0.5625 0.6875, owned by 1: 52 65 54 67 
+DEAL:1::Cell with center: 0.6875 0.6875, owned by 1: 65 66 67 68 
+DEAL:1::Cell with center: 0.8125 0.5625, owned by 1: 40 43 66 69 
+DEAL:1::Cell with center: 0.9375 0.5625, owned by 1: 43 44 69 70 
+DEAL:1::Cell with center: 0.8125 0.6875, owned by 1: 66 69 68 71 
+DEAL:1::Cell with center: 0.9375 0.6875, owned by 1: 69 70 71 72 
+DEAL:1::Cell with center: 0.5625 0.8125, owned by 1: 54 67 62 73 
+DEAL:1::Cell with center: 0.6875 0.8125, owned by 1: 67 68 73 74 
+DEAL:1::Cell with center: 0.5625 0.9375, owned by 1: 62 73 64 75 
+DEAL:1::Cell with center: 0.6875 0.9375, owned by 1: 73 74 75 76 
+DEAL:1::Cell with center: 0.8125 0.8125, owned by 1: 68 71 74 77 
+DEAL:1::Cell with center: 0.9375 0.8125, owned by 1: 71 72 77 78 
+DEAL:1::Cell with center: 0.8125 0.9375, owned by 1: 74 77 76 79 
+DEAL:1::Cell with center: 0.9375 0.9375, owned by 1: 77 78 79 80 
+DEAL:1::Cell with center: 1.062 0.06250, owned by 1: 33 81 34 82 
+DEAL:1::Cell with center: 1.188 0.06250, owned by 1: 81 83 82 84 
+DEAL:1::Cell with center: 1.062 0.1875, owned by 1: 34 82 36 85 
+DEAL:1::Cell with center: 1.188 0.1875, owned by 1: 82 84 85 86 
+DEAL:1::Cell with center: 1.312 0.06250, owned by 1: 83 87 84 88 
+DEAL:1::Cell with center: 1.438 0.06250, owned by 1: 87 89 88 90 
+DEAL:1::Cell with center: 1.312 0.1875, owned by 1: 84 88 86 91 
+DEAL:1::Cell with center: 1.438 0.1875, owned by 1: 88 90 91 92 
+DEAL:1::Cell with center: 1.062 0.3125, owned by 1: 36 85 42 93 
+DEAL:1::Cell with center: 1.188 0.3125, owned by 1: 85 86 93 94 
+DEAL:1::Cell with center: 1.062 0.4375, owned by 1: 42 93 44 95 
+DEAL:1::Cell with center: 1.188 0.4375, owned by 1: 93 94 95 96 
+DEAL:1::Cell with center: 1.312 0.3125, owned by 1: 86 91 94 97 
+DEAL:1::Cell with center: 1.438 0.3125, owned by 1: 91 92 97 98 
+DEAL:1::Cell with center: 1.312 0.4375, owned by 1: 94 97 96 99 
+DEAL:1::Cell with center: 1.438 0.4375, owned by 1: 97 98 99 100 
+DEAL:1::Cell with center: 1.562 0.06250, owned by 1: 89 101 90 102 
+DEAL:1::Cell with center: 1.688 0.06250, owned by 1: 101 103 102 104 
+DEAL:1::Cell with center: 1.562 0.1875, owned by 1: 90 102 92 105 
+DEAL:1::Cell with center: 1.688 0.1875, owned by 1: 102 104 105 106 
+DEAL:1::Cell with center: 1.812 0.06250, owned by 2: 103 107 104 108 
+DEAL:1::Cell with center: 1.812 0.1875, owned by 2: 104 108 106 111 
+DEAL:1::Cell with center: 1.562 0.3125, owned by 2: 92 105 98 113 
+DEAL:1::Cell with center: 1.688 0.3125, owned by 2: 105 106 113 114 
+DEAL:1::Cell with center: 1.562 0.4375, owned by 2: 98 113 100 115 
+DEAL:1::Cell with center: 1.812 0.3125, owned by 2: 106 111 114 117 
+DEAL:1::Cell with center: 1.062 0.5625, owned by 2: 44 95 70 121 
+DEAL:1::Cell with center: 1.188 0.5625, owned by 2: 95 96 121 122 
+DEAL:1::Cell with center: 1.062 0.6875, owned by 2: 70 121 72 123 
+DEAL:1::Cell with center: 1.312 0.5625, owned by 2: 96 99 122 125 
+DEAL:1::Cell with center: 1.438 0.5625, owned by 2: 99 100 125 126 
+DEAL:1::Cell with center: 1.062 0.8125, owned by 2: 72 123 78 129 
+DEAL:1::Cell with center: 1.062 0.9375, owned by 2: 78 129 80 131 
+DEAL:1::Cell with center: 1.188 0.9375, owned by 2: 129 130 131 132 
+DEAL:1::Cell with center: 1.312 0.9375, owned by 2: 130 133 132 135 
+DEAL:1::Cell with center: 1.438 0.9375, owned by 2: 133 134 135 136 
+DEAL:1::Cell with center: 1.562 0.5625, owned by 2: 100 115 126 137 
+DEAL:1::Cell with center: 1.562 0.9375, owned by 2: 134 145 136 147 
+DEAL:1::Cell with center: 1.688 0.9375, owned by 2: 145 146 147 148 
+DEAL:1::Cell with center: 1.812 0.9375, owned by 2: 146 149 148 151 
+DEAL:1::Level 0
+DEAL:1::Cell with center: 0.5000 0.5000 0.5000, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:1::Level 1
+DEAL:1::Cell with center: 0.2500 0.2500 0.2500, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:1::Cell with center: 0.7500 0.2500 0.2500, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:1::Cell with center: 0.2500 0.7500 0.2500, owned by 0: 2 3 12 13 6 7 14 15 
+DEAL:1::Cell with center: 0.7500 0.7500 0.2500, owned by 1: 3 9 13 16 7 11 15 17 
+DEAL:1::Cell with center: 0.2500 0.2500 0.7500, owned by 1: 4 5 6 7 18 19 20 21 
+DEAL:1::Cell with center: 0.7500 0.2500 0.7500, owned by 2: 5 10 7 11 19 22 21 23 
+DEAL:1::Cell with center: 0.2500 0.7500 0.7500, owned by 2: 6 7 14 15 20 21 24 25 
+DEAL:1::Cell with center: 0.7500 0.7500 0.7500, owned by 2: 7 11 15 17 21 23 25 26 
+DEAL:1::Level 2
+DEAL:1::Cell with center: 0.1250 0.1250 0.1250, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:1::Cell with center: 0.3750 0.1250 0.1250, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:1::Cell with center: 0.1250 0.3750 0.1250, owned by 0: 2 3 12 13 6 7 14 15 
+DEAL:1::Cell with center: 0.3750 0.3750 0.1250, owned by 0: 3 9 13 16 7 11 15 17 
+DEAL:1::Cell with center: 0.1250 0.1250 0.3750, owned by 0: 4 5 6 7 18 19 20 21 
+DEAL:1::Cell with center: 0.3750 0.1250 0.3750, owned by 0: 5 10 7 11 19 22 21 23 
+DEAL:1::Cell with center: 0.1250 0.3750 0.3750, owned by 0: 6 7 14 15 20 21 24 25 
+DEAL:1::Cell with center: 0.3750 0.3750 0.3750, owned by 0: 7 11 15 17 21 23 25 26 
+DEAL:1::Cell with center: 0.6250 0.1250 0.1250, owned by 0: 8 27 9 28 10 29 11 30 
+DEAL:1::Cell with center: 0.8750 0.1250 0.1250, owned by 0: 27 31 28 32 29 33 30 34 
+DEAL:1::Cell with center: 0.6250 0.3750 0.1250, owned by 0: 9 28 16 35 11 30 17 36 
+DEAL:1::Cell with center: 0.8750 0.3750 0.1250, owned by 0: 28 32 35 37 30 34 36 38 
+DEAL:1::Cell with center: 0.6250 0.1250 0.3750, owned by 0: 10 29 11 30 22 39 23 40 
+DEAL:1::Cell with center: 0.8750 0.1250 0.3750, owned by 0: 29 33 30 34 39 41 40 42 
+DEAL:1::Cell with center: 0.6250 0.3750 0.3750, owned by 0: 11 30 17 36 23 40 26 43 
+DEAL:1::Cell with center: 0.8750 0.3750 0.3750, owned by 0: 30 34 36 38 40 42 43 44 
+DEAL:1::Cell with center: 0.1250 0.6250 0.1250, owned by 0: 12 13 45 46 14 15 47 48 
+DEAL:1::Cell with center: 0.3750 0.6250 0.1250, owned by 0: 13 16 46 49 15 17 48 50 
+DEAL:1::Cell with center: 0.1250 0.8750 0.1250, owned by 0: 45 46 51 52 47 48 53 54 
+DEAL:1::Cell with center: 0.3750 0.8750 0.1250, owned by 0: 46 49 52 55 48 50 54 56 
+DEAL:1::Cell with center: 0.1250 0.6250 0.3750, owned by 0: 14 15 47 48 24 25 57 58 
+DEAL:1::Cell with center: 0.3750 0.6250 0.3750, owned by 0: 15 17 48 50 25 26 58 59 
+DEAL:1::Cell with center: 0.1250 0.8750 0.3750, owned by 0: 47 48 53 54 57 58 60 61 
+DEAL:1::Cell with center: 0.3750 0.8750 0.3750, owned by 0: 48 50 54 56 58 59 61 62 
+DEAL:1::Cell with center: 0.6250 0.6250 0.1250, owned by 1: 16 35 49 63 17 36 50 64 
+DEAL:1::Cell with center: 0.8750 0.6250 0.1250, owned by 1: 35 37 63 65 36 38 64 66 
+DEAL:1::Cell with center: 0.6250 0.8750 0.1250, owned by 1: 49 63 55 67 50 64 56 68 
+DEAL:1::Cell with center: 0.8750 0.8750 0.1250, owned by 1: 63 65 67 69 64 66 68 70 
+DEAL:1::Cell with center: 0.6250 0.6250 0.3750, owned by 1: 17 36 50 64 26 43 59 71 
+DEAL:1::Cell with center: 0.8750 0.6250 0.3750, owned by 1: 36 38 64 66 43 44 71 72 
+DEAL:1::Cell with center: 0.6250 0.8750 0.3750, owned by 1: 50 64 56 68 59 71 62 73 
+DEAL:1::Cell with center: 0.8750 0.8750 0.3750, owned by 1: 64 66 68 70 71 72 73 74 
+DEAL:1::Cell with center: 0.1250 0.1250 0.6250, owned by 1: 18 19 20 21 75 76 77 78 
+DEAL:1::Cell with center: 0.3750 0.1250 0.6250, owned by 1: 19 22 21 23 76 79 78 80 
+DEAL:1::Cell with center: 0.1250 0.3750 0.6250, owned by 1: 20 21 24 25 77 78 81 82 
+DEAL:1::Cell with center: 0.3750 0.3750 0.6250, owned by 1: 21 23 25 26 78 80 82 83 
+DEAL:1::Cell with center: 0.1250 0.1250 0.8750, owned by 1: 75 76 77 78 84 85 86 87 
+DEAL:1::Cell with center: 0.3750 0.1250 0.8750, owned by 1: 76 79 78 80 85 88 87 89 
+DEAL:1::Cell with center: 0.1250 0.3750 0.8750, owned by 1: 77 78 81 82 86 87 90 91 
+DEAL:1::Cell with center: 0.3750 0.3750 0.8750, owned by 1: 78 80 82 83 87 89 91 92 
+DEAL:1::Cell with center: 0.6250 0.1250 0.6250, owned by 2: 22 39 23 40 79 93 80 94 
+DEAL:1::Cell with center: 0.8750 0.1250 0.6250, owned by 2: 39 41 40 42 93 95 94 96 
+DEAL:1::Cell with center: 0.6250 0.3750 0.6250, owned by 2: 23 40 26 43 80 94 83 97 
+DEAL:1::Cell with center: 0.8750 0.3750 0.6250, owned by 2: 40 42 43 44 94 96 97 98 
+DEAL:1::Cell with center: 0.6250 0.1250 0.8750, owned by 2: 79 93 80 94 88 99 89 100 
+DEAL:1::Cell with center: 0.8750 0.1250 0.8750, owned by 2: 93 95 94 96 99 101 100 102 
+DEAL:1::Cell with center: 0.6250 0.3750 0.8750, owned by 2: 80 94 83 97 89 100 92 103 
+DEAL:1::Cell with center: 0.8750 0.3750 0.8750, owned by 2: 94 96 97 98 100 102 103 104 
+DEAL:1::Cell with center: 0.1250 0.6250 0.6250, owned by 2: 24 25 57 58 81 82 105 106 
+DEAL:1::Cell with center: 0.3750 0.6250 0.6250, owned by 2: 25 26 58 59 82 83 106 107 
+DEAL:1::Cell with center: 0.1250 0.8750 0.6250, owned by 2: 57 58 60 61 105 106 108 109 
+DEAL:1::Cell with center: 0.3750 0.8750 0.6250, owned by 2: 58 59 61 62 106 107 109 110 
+DEAL:1::Cell with center: 0.1250 0.6250 0.8750, owned by 2: 81 82 105 106 90 91 111 112 
+DEAL:1::Cell with center: 0.3750 0.6250 0.8750, owned by 2: 82 83 106 107 91 92 112 113 
+DEAL:1::Cell with center: 0.1250 0.8750 0.8750, owned by 2: 105 106 108 109 111 112 114 115 
+DEAL:1::Cell with center: 0.3750 0.8750 0.8750, owned by 2: 106 107 109 110 112 113 115 116 
+DEAL:1::Cell with center: 0.6250 0.6250 0.6250, owned by 2: 26 43 59 71 83 97 107 117 
+DEAL:1::Cell with center: 0.8750 0.6250 0.6250, owned by 2: 43 44 71 72 97 98 117 118 
+DEAL:1::Cell with center: 0.6250 0.8750 0.6250, owned by 2: 59 71 62 73 107 117 110 119 
+DEAL:1::Cell with center: 0.8750 0.8750 0.6250, owned by 2: 71 72 73 74 117 118 119 120 
+DEAL:1::Cell with center: 0.6250 0.6250 0.8750, owned by 2: 83 97 107 117 92 103 113 121 
+DEAL:1::Cell with center: 0.8750 0.6250 0.8750, owned by 2: 97 98 117 118 103 104 121 122 
+DEAL:1::Cell with center: 0.6250 0.8750 0.8750, owned by 2: 107 117 110 119 113 121 116 123 
+DEAL:1::Cell with center: 0.8750 0.8750 0.8750, owned by 2: 117 118 119 120 121 122 123 124 
+
+
+DEAL:2::Level 0
+DEAL:2::Cell with center: 1.500 0.5000, owned by 1: 1 4 3 5 
+DEAL:2::Level 1
+DEAL:2::Cell with center: 0.7500 0.2500, owned by 0: 1 4 3 5 
+DEAL:2::Cell with center: 0.7500 0.7500, owned by 1: 3 5 7 8 
+DEAL:2::Cell with center: 1.250 0.2500, owned by 1: 4 9 5 10 
+DEAL:2::Cell with center: 1.750 0.2500, owned by 1: 9 11 10 12 
+DEAL:2::Cell with center: 1.250 0.7500, owned by 2: 5 10 8 13 
+DEAL:2::Cell with center: 1.750 0.7500, owned by 2: 10 12 13 14 
+DEAL:2::Level 2
+DEAL:2::Cell with center: 0.8750 0.1250, owned by 0: 9 11 10 12 
+DEAL:2::Cell with center: 0.8750 0.3750, owned by 0: 10 12 13 14 
+DEAL:2::Cell with center: 0.8750 0.6250, owned by 1: 13 14 21 22 
+DEAL:2::Cell with center: 0.8750 0.8750, owned by 1: 21 22 23 24 
+DEAL:2::Cell with center: 1.125 0.1250, owned by 1: 11 25 12 26 
+DEAL:2::Cell with center: 1.375 0.1250, owned by 1: 25 27 26 28 
+DEAL:2::Cell with center: 1.125 0.3750, owned by 1: 12 26 14 29 
+DEAL:2::Cell with center: 1.375 0.3750, owned by 1: 26 28 29 30 
+DEAL:2::Cell with center: 1.625 0.1250, owned by 1: 27 31 28 32 
+DEAL:2::Cell with center: 1.875 0.1250, owned by 2: 31 33 32 34 
+DEAL:2::Cell with center: 1.625 0.3750, owned by 2: 28 32 30 35 
+DEAL:2::Cell with center: 1.875 0.3750, owned by 2: 32 34 35 36 
+DEAL:2::Cell with center: 1.125 0.6250, owned by 2: 14 29 22 37 
+DEAL:2::Cell with center: 1.375 0.6250, owned by 2: 29 30 37 38 
+DEAL:2::Cell with center: 1.125 0.8750, owned by 2: 22 37 24 39 
+DEAL:2::Cell with center: 1.375 0.8750, owned by 2: 37 38 39 40 
+DEAL:2::Cell with center: 1.625 0.6250, owned by 2: 30 35 38 41 
+DEAL:2::Cell with center: 1.875 0.6250, owned by 2: 35 36 41 42 
+DEAL:2::Cell with center: 1.625 0.8750, owned by 2: 38 41 40 43 
+DEAL:2::Cell with center: 1.875 0.8750, owned by 2: 41 42 43 44 
+DEAL:2::Level 3
+DEAL:2::Cell with center: 0.9375 0.06250, owned by 0: 31 33 32 34 
+DEAL:2::Cell with center: 0.9375 0.4375, owned by 0: 41 42 43 44 
+DEAL:2::Cell with center: 0.9375 0.5625, owned by 1: 43 44 69 70 
+DEAL:2::Cell with center: 0.9375 0.6875, owned by 1: 69 70 71 72 
+DEAL:2::Cell with center: 0.9375 0.8125, owned by 1: 71 72 77 78 
+DEAL:2::Cell with center: 0.9375 0.9375, owned by 1: 77 78 79 80 
+DEAL:2::Cell with center: 1.062 0.06250, owned by 1: 33 81 34 82 
+DEAL:2::Cell with center: 1.188 0.06250, owned by 1: 81 83 82 84 
+DEAL:2::Cell with center: 1.312 0.06250, owned by 1: 83 87 84 88 
+DEAL:2::Cell with center: 1.438 0.06250, owned by 1: 87 89 88 90 
+DEAL:2::Cell with center: 1.438 0.1875, owned by 1: 88 90 91 92 
+DEAL:2::Cell with center: 1.062 0.4375, owned by 1: 42 93 44 95 
+DEAL:2::Cell with center: 1.188 0.4375, owned by 1: 93 94 95 96 
+DEAL:2::Cell with center: 1.438 0.3125, owned by 1: 91 92 97 98 
+DEAL:2::Cell with center: 1.312 0.4375, owned by 1: 94 97 96 99 
+DEAL:2::Cell with center: 1.438 0.4375, owned by 1: 97 98 99 100 
+DEAL:2::Cell with center: 1.562 0.06250, owned by 1: 89 101 90 102 
+DEAL:2::Cell with center: 1.688 0.06250, owned by 1: 101 103 102 104 
+DEAL:2::Cell with center: 1.562 0.1875, owned by 1: 90 102 92 105 
+DEAL:2::Cell with center: 1.688 0.1875, owned by 1: 102 104 105 106 
+DEAL:2::Cell with center: 1.812 0.06250, owned by 2: 103 107 104 108 
+DEAL:2::Cell with center: 1.938 0.06250, owned by 2: 107 109 108 110 
+DEAL:2::Cell with center: 1.812 0.1875, owned by 2: 104 108 106 111 
+DEAL:2::Cell with center: 1.938 0.1875, owned by 2: 108 110 111 112 
+DEAL:2::Cell with center: 1.562 0.3125, owned by 2: 92 105 98 113 
+DEAL:2::Cell with center: 1.688 0.3125, owned by 2: 105 106 113 114 
+DEAL:2::Cell with center: 1.562 0.4375, owned by 2: 98 113 100 115 
+DEAL:2::Cell with center: 1.688 0.4375, owned by 2: 113 114 115 116 
+DEAL:2::Cell with center: 1.812 0.3125, owned by 2: 106 111 114 117 
+DEAL:2::Cell with center: 1.938 0.3125, owned by 2: 111 112 117 118 
+DEAL:2::Cell with center: 1.812 0.4375, owned by 2: 114 117 116 119 
+DEAL:2::Cell with center: 1.938 0.4375, owned by 2: 117 118 119 120 
+DEAL:2::Cell with center: 1.062 0.5625, owned by 2: 44 95 70 121 
+DEAL:2::Cell with center: 1.188 0.5625, owned by 2: 95 96 121 122 
+DEAL:2::Cell with center: 1.062 0.6875, owned by 2: 70 121 72 123 
+DEAL:2::Cell with center: 1.188 0.6875, owned by 2: 121 122 123 124 
+DEAL:2::Cell with center: 1.312 0.5625, owned by 2: 96 99 122 125 
+DEAL:2::Cell with center: 1.438 0.5625, owned by 2: 99 100 125 126 
+DEAL:2::Cell with center: 1.312 0.6875, owned by 2: 122 125 124 127 
+DEAL:2::Cell with center: 1.438 0.6875, owned by 2: 125 126 127 128 
+DEAL:2::Cell with center: 1.062 0.8125, owned by 2: 72 123 78 129 
+DEAL:2::Cell with center: 1.188 0.8125, owned by 2: 123 124 129 130 
+DEAL:2::Cell with center: 1.062 0.9375, owned by 2: 78 129 80 131 
+DEAL:2::Cell with center: 1.188 0.9375, owned by 2: 129 130 131 132 
+DEAL:2::Cell with center: 1.312 0.8125, owned by 2: 124 127 130 133 
+DEAL:2::Cell with center: 1.438 0.8125, owned by 2: 127 128 133 134 
+DEAL:2::Cell with center: 1.312 0.9375, owned by 2: 130 133 132 135 
+DEAL:2::Cell with center: 1.438 0.9375, owned by 2: 133 134 135 136 
+DEAL:2::Cell with center: 1.562 0.5625, owned by 2: 100 115 126 137 
+DEAL:2::Cell with center: 1.688 0.5625, owned by 2: 115 116 137 138 
+DEAL:2::Cell with center: 1.562 0.6875, owned by 2: 126 137 128 139 
+DEAL:2::Cell with center: 1.688 0.6875, owned by 2: 137 138 139 140 
+DEAL:2::Cell with center: 1.812 0.5625, owned by 2: 116 119 138 141 
+DEAL:2::Cell with center: 1.938 0.5625, owned by 2: 119 120 141 142 
+DEAL:2::Cell with center: 1.812 0.6875, owned by 2: 138 141 140 143 
+DEAL:2::Cell with center: 1.938 0.6875, owned by 2: 141 142 143 144 
+DEAL:2::Cell with center: 1.562 0.8125, owned by 2: 128 139 134 145 
+DEAL:2::Cell with center: 1.688 0.8125, owned by 2: 139 140 145 146 
+DEAL:2::Cell with center: 1.562 0.9375, owned by 2: 134 145 136 147 
+DEAL:2::Cell with center: 1.688 0.9375, owned by 2: 145 146 147 148 
+DEAL:2::Cell with center: 1.812 0.8125, owned by 2: 140 143 146 149 
+DEAL:2::Cell with center: 1.938 0.8125, owned by 2: 143 144 149 150 
+DEAL:2::Cell with center: 1.812 0.9375, owned by 2: 146 149 148 151 
+DEAL:2::Cell with center: 1.938 0.9375, owned by 2: 149 150 151 152 
+DEAL:2::Level 0
+DEAL:2::Cell with center: 0.5000 0.5000 0.5000, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:2::Level 1
+DEAL:2::Cell with center: 0.2500 0.2500 0.2500, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:2::Cell with center: 0.7500 0.2500 0.2500, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:2::Cell with center: 0.2500 0.7500 0.2500, owned by 0: 2 3 12 13 6 7 14 15 
+DEAL:2::Cell with center: 0.7500 0.7500 0.2500, owned by 1: 3 9 13 16 7 11 15 17 
+DEAL:2::Cell with center: 0.2500 0.2500 0.7500, owned by 1: 4 5 6 7 18 19 20 21 
+DEAL:2::Cell with center: 0.7500 0.2500 0.7500, owned by 2: 5 10 7 11 19 22 21 23 
+DEAL:2::Cell with center: 0.2500 0.7500 0.7500, owned by 2: 6 7 14 15 20 21 24 25 
+DEAL:2::Cell with center: 0.7500 0.7500 0.7500, owned by 2: 7 11 15 17 21 23 25 26 
+DEAL:2::Level 2
+DEAL:2::Cell with center: 0.1250 0.1250 0.1250, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:2::Cell with center: 0.3750 0.1250 0.1250, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:2::Cell with center: 0.1250 0.3750 0.1250, owned by 0: 2 3 12 13 6 7 14 15 
+DEAL:2::Cell with center: 0.3750 0.3750 0.1250, owned by 0: 3 9 13 16 7 11 15 17 
+DEAL:2::Cell with center: 0.1250 0.1250 0.3750, owned by 0: 4 5 6 7 18 19 20 21 
+DEAL:2::Cell with center: 0.3750 0.1250 0.3750, owned by 0: 5 10 7 11 19 22 21 23 
+DEAL:2::Cell with center: 0.1250 0.3750 0.3750, owned by 0: 6 7 14 15 20 21 24 25 
+DEAL:2::Cell with center: 0.3750 0.3750 0.3750, owned by 0: 7 11 15 17 21 23 25 26 
+DEAL:2::Cell with center: 0.6250 0.1250 0.1250, owned by 0: 8 27 9 28 10 29 11 30 
+DEAL:2::Cell with center: 0.8750 0.1250 0.1250, owned by 0: 27 31 28 32 29 33 30 34 
+DEAL:2::Cell with center: 0.6250 0.3750 0.1250, owned by 0: 9 28 16 35 11 30 17 36 
+DEAL:2::Cell with center: 0.8750 0.3750 0.1250, owned by 0: 28 32 35 37 30 34 36 38 
+DEAL:2::Cell with center: 0.6250 0.1250 0.3750, owned by 0: 10 29 11 30 22 39 23 40 
+DEAL:2::Cell with center: 0.8750 0.1250 0.3750, owned by 0: 29 33 30 34 39 41 40 42 
+DEAL:2::Cell with center: 0.6250 0.3750 0.3750, owned by 0: 11 30 17 36 23 40 26 43 
+DEAL:2::Cell with center: 0.8750 0.3750 0.3750, owned by 0: 30 34 36 38 40 42 43 44 
+DEAL:2::Cell with center: 0.1250 0.6250 0.1250, owned by 0: 12 13 45 46 14 15 47 48 
+DEAL:2::Cell with center: 0.3750 0.6250 0.1250, owned by 0: 13 16 46 49 15 17 48 50 
+DEAL:2::Cell with center: 0.1250 0.8750 0.1250, owned by 0: 45 46 51 52 47 48 53 54 
+DEAL:2::Cell with center: 0.3750 0.8750 0.1250, owned by 0: 46 49 52 55 48 50 54 56 
+DEAL:2::Cell with center: 0.1250 0.6250 0.3750, owned by 0: 14 15 47 48 24 25 57 58 
+DEAL:2::Cell with center: 0.3750 0.6250 0.3750, owned by 0: 15 17 48 50 25 26 58 59 
+DEAL:2::Cell with center: 0.1250 0.8750 0.3750, owned by 0: 47 48 53 54 57 58 60 61 
+DEAL:2::Cell with center: 0.3750 0.8750 0.3750, owned by 0: 48 50 54 56 58 59 61 62 
+DEAL:2::Cell with center: 0.6250 0.6250 0.1250, owned by 1: 16 35 49 63 17 36 50 64 
+DEAL:2::Cell with center: 0.8750 0.6250 0.1250, owned by 1: 35 37 63 65 36 38 64 66 
+DEAL:2::Cell with center: 0.6250 0.8750 0.1250, owned by 1: 49 63 55 67 50 64 56 68 
+DEAL:2::Cell with center: 0.8750 0.8750 0.1250, owned by 1: 63 65 67 69 64 66 68 70 
+DEAL:2::Cell with center: 0.6250 0.6250 0.3750, owned by 1: 17 36 50 64 26 43 59 71 
+DEAL:2::Cell with center: 0.8750 0.6250 0.3750, owned by 1: 36 38 64 66 43 44 71 72 
+DEAL:2::Cell with center: 0.6250 0.8750 0.3750, owned by 1: 50 64 56 68 59 71 62 73 
+DEAL:2::Cell with center: 0.8750 0.8750 0.3750, owned by 1: 64 66 68 70 71 72 73 74 
+DEAL:2::Cell with center: 0.1250 0.1250 0.6250, owned by 1: 18 19 20 21 75 76 77 78 
+DEAL:2::Cell with center: 0.3750 0.1250 0.6250, owned by 1: 19 22 21 23 76 79 78 80 
+DEAL:2::Cell with center: 0.1250 0.3750 0.6250, owned by 1: 20 21 24 25 77 78 81 82 
+DEAL:2::Cell with center: 0.3750 0.3750 0.6250, owned by 1: 21 23 25 26 78 80 82 83 
+DEAL:2::Cell with center: 0.1250 0.1250 0.8750, owned by 1: 75 76 77 78 84 85 86 87 
+DEAL:2::Cell with center: 0.3750 0.1250 0.8750, owned by 1: 76 79 78 80 85 88 87 89 
+DEAL:2::Cell with center: 0.1250 0.3750 0.8750, owned by 1: 77 78 81 82 86 87 90 91 
+DEAL:2::Cell with center: 0.3750 0.3750 0.8750, owned by 1: 78 80 82 83 87 89 91 92 
+DEAL:2::Cell with center: 0.6250 0.1250 0.6250, owned by 2: 22 39 23 40 79 93 80 94 
+DEAL:2::Cell with center: 0.8750 0.1250 0.6250, owned by 2: 39 41 40 42 93 95 94 96 
+DEAL:2::Cell with center: 0.6250 0.3750 0.6250, owned by 2: 23 40 26 43 80 94 83 97 
+DEAL:2::Cell with center: 0.8750 0.3750 0.6250, owned by 2: 40 42 43 44 94 96 97 98 
+DEAL:2::Cell with center: 0.6250 0.1250 0.8750, owned by 2: 79 93 80 94 88 99 89 100 
+DEAL:2::Cell with center: 0.8750 0.1250 0.8750, owned by 2: 93 95 94 96 99 101 100 102 
+DEAL:2::Cell with center: 0.6250 0.3750 0.8750, owned by 2: 80 94 83 97 89 100 92 103 
+DEAL:2::Cell with center: 0.8750 0.3750 0.8750, owned by 2: 94 96 97 98 100 102 103 104 
+DEAL:2::Cell with center: 0.1250 0.6250 0.6250, owned by 2: 24 25 57 58 81 82 105 106 
+DEAL:2::Cell with center: 0.3750 0.6250 0.6250, owned by 2: 25 26 58 59 82 83 106 107 
+DEAL:2::Cell with center: 0.1250 0.8750 0.6250, owned by 2: 57 58 60 61 105 106 108 109 
+DEAL:2::Cell with center: 0.3750 0.8750 0.6250, owned by 2: 58 59 61 62 106 107 109 110 
+DEAL:2::Cell with center: 0.1250 0.6250 0.8750, owned by 2: 81 82 105 106 90 91 111 112 
+DEAL:2::Cell with center: 0.3750 0.6250 0.8750, owned by 2: 82 83 106 107 91 92 112 113 
+DEAL:2::Cell with center: 0.1250 0.8750 0.8750, owned by 2: 105 106 108 109 111 112 114 115 
+DEAL:2::Cell with center: 0.3750 0.8750 0.8750, owned by 2: 106 107 109 110 112 113 115 116 
+DEAL:2::Cell with center: 0.6250 0.6250 0.6250, owned by 2: 26 43 59 71 83 97 107 117 
+DEAL:2::Cell with center: 0.8750 0.6250 0.6250, owned by 2: 43 44 71 72 97 98 117 118 
+DEAL:2::Cell with center: 0.6250 0.8750 0.6250, owned by 2: 59 71 62 73 107 117 110 119 
+DEAL:2::Cell with center: 0.8750 0.8750 0.6250, owned by 2: 71 72 73 74 117 118 119 120 
+DEAL:2::Cell with center: 0.6250 0.6250 0.8750, owned by 2: 83 97 107 117 92 103 113 121 
+DEAL:2::Cell with center: 0.8750 0.6250 0.8750, owned by 2: 97 98 117 118 103 104 121 122 
+DEAL:2::Cell with center: 0.6250 0.8750 0.8750, owned by 2: 107 117 110 119 113 121 116 123 
+DEAL:2::Cell with center: 0.8750 0.8750 0.8750, owned by 2: 117 118 119 120 121 122 123 124 
+
diff --git a/tests/mpi/mg_ghost_dofs_periodic_01.with_p4est=true.mpirun=7.output b/tests/mpi/mg_ghost_dofs_periodic_01.with_p4est=true.mpirun=7.output
new file mode 100644 (file)
index 0000000..3782e3a
--- /dev/null
@@ -0,0 +1,942 @@
+
+DEAL:0::Level 0
+DEAL:0::Cell with center: 0.5000 0.5000, owned by 0: 0 1 2 3 
+DEAL:0::Cell with center: 1.500 0.5000, owned by 3: 1 4 3 5 
+DEAL:0::Level 1
+DEAL:0::Cell with center: 0.2500 0.2500, owned by 0: 0 1 2 3 
+DEAL:0::Cell with center: 0.7500 0.2500, owned by 0: 1 4 3 5 
+DEAL:0::Cell with center: 0.2500 0.7500, owned by 1: 2 3 6 7 
+DEAL:0::Cell with center: 0.7500 0.7500, owned by 2: 3 5 7 8 
+DEAL:0::Cell with center: 1.250 0.2500, owned by 3: 4 9 5 10 
+DEAL:0::Cell with center: 1.250 0.7500, owned by 5: 5 10 8 13 
+DEAL:0::Level 2
+DEAL:0::Cell with center: 0.1250 0.1250, owned by 0: 0 1 2 3 
+DEAL:0::Cell with center: 0.3750 0.1250, owned by 0: 1 4 3 5 
+DEAL:0::Cell with center: 0.1250 0.3750, owned by 0: 2 3 6 7 
+DEAL:0::Cell with center: 0.3750 0.3750, owned by 0: 3 5 7 8 
+DEAL:0::Cell with center: 0.6250 0.1250, owned by 0: 4 9 5 10 
+DEAL:0::Cell with center: 0.8750 0.1250, owned by 1: 9 11 10 12 
+DEAL:0::Cell with center: 0.6250 0.3750, owned by 1: 5 10 8 13 
+DEAL:0::Cell with center: 0.8750 0.3750, owned by 1: 10 12 13 14 
+DEAL:0::Cell with center: 0.1250 0.6250, owned by 1: 6 7 15 16 
+DEAL:0::Cell with center: 0.3750 0.6250, owned by 2: 7 8 16 17 
+DEAL:0::Cell with center: 0.1250 0.8750, owned by 2: 15 16 18 19 
+DEAL:0::Cell with center: 0.3750 0.8750, owned by 2: 16 17 19 20 
+DEAL:0::Cell with center: 0.6250 0.6250, owned by 2: 8 13 17 21 
+DEAL:0::Cell with center: 0.6250 0.8750, owned by 3: 17 21 20 23 
+DEAL:0::Cell with center: 0.8750 0.8750, owned by 3: 21 22 23 24 
+DEAL:0::Level 3
+DEAL:0::Cell with center: 0.06250 0.06250, owned by 0: 0 1 2 3 
+DEAL:0::Cell with center: 0.1875 0.06250, owned by 0: 1 4 3 5 
+DEAL:0::Cell with center: 0.06250 0.1875, owned by 0: 2 3 6 7 
+DEAL:0::Cell with center: 0.1875 0.1875, owned by 0: 3 5 7 8 
+DEAL:0::Cell with center: 0.3125 0.06250, owned by 0: 4 9 5 10 
+DEAL:0::Cell with center: 0.4375 0.06250, owned by 0: 9 11 10 12 
+DEAL:0::Cell with center: 0.3125 0.1875, owned by 0: 5 10 8 13 
+DEAL:0::Cell with center: 0.4375 0.1875, owned by 0: 10 12 13 14 
+DEAL:0::Cell with center: 0.06250 0.3125, owned by 0: 6 7 15 16 
+DEAL:0::Cell with center: 0.1875 0.3125, owned by 0: 7 8 16 17 
+DEAL:0::Cell with center: 0.06250 0.4375, owned by 0: 15 16 18 19 
+DEAL:0::Cell with center: 0.1875 0.4375, owned by 0: 16 17 19 20 
+DEAL:0::Cell with center: 0.3125 0.3125, owned by 0: 8 13 17 21 
+DEAL:0::Cell with center: 0.4375 0.3125, owned by 0: 13 14 21 22 
+DEAL:0::Cell with center: 0.3125 0.4375, owned by 0: 17 21 20 23 
+DEAL:0::Cell with center: 0.4375 0.4375, owned by 0: 21 22 23 24 
+DEAL:0::Cell with center: 0.5625 0.06250, owned by 0: 11 25 12 26 
+DEAL:0::Cell with center: 0.6875 0.06250, owned by 0: 25 27 26 28 
+DEAL:0::Cell with center: 0.5625 0.1875, owned by 0: 12 26 14 29 
+DEAL:0::Cell with center: 0.6875 0.1875, owned by 0: 26 28 29 30 
+DEAL:0::Cell with center: 0.8125 0.06250, owned by 1: 27 31 28 32 
+DEAL:0::Cell with center: 0.8125 0.1875, owned by 1: 28 32 30 35 
+DEAL:0::Cell with center: 0.5625 0.3125, owned by 1: 14 29 22 37 
+DEAL:0::Cell with center: 0.6875 0.3125, owned by 1: 29 30 37 38 
+DEAL:0::Cell with center: 0.5625 0.4375, owned by 1: 22 37 24 39 
+DEAL:0::Cell with center: 0.8125 0.3125, owned by 1: 30 35 38 41 
+DEAL:0::Cell with center: 0.06250 0.5625, owned by 1: 18 19 45 46 
+DEAL:0::Cell with center: 0.1875 0.5625, owned by 1: 19 20 46 47 
+DEAL:0::Cell with center: 0.3125 0.5625, owned by 2: 20 23 47 51 
+DEAL:0::Cell with center: 0.4375 0.5625, owned by 2: 23 24 51 52 
+DEAL:0::Cell with center: 0.06250 0.9375, owned by 2: 55 56 58 59 
+DEAL:0::Cell with center: 0.1875 0.9375, owned by 2: 56 57 59 60 
+DEAL:0::Cell with center: 0.3125 0.9375, owned by 2: 57 61 60 63 
+DEAL:0::Cell with center: 0.4375 0.9375, owned by 2: 61 62 63 64 
+DEAL:0::Cell with center: 0.5625 0.5625, owned by 2: 24 39 52 65 
+DEAL:0::Cell with center: 0.5625 0.9375, owned by 3: 62 73 64 75 
+DEAL:0::Cell with center: 0.6875 0.9375, owned by 3: 73 74 75 76 
+DEAL:0::Cell with center: 0.8125 0.9375, owned by 3: 74 77 76 79 
+DEAL:0::Level 0
+DEAL:0::Cell with center: 0.5000 0.5000 0.5000, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:0::Level 1
+DEAL:0::Cell with center: 0.2500 0.2500 0.2500, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:0::Cell with center: 0.7500 0.2500 0.2500, owned by 1: 1 8 3 9 5 10 7 11 
+DEAL:0::Cell with center: 0.2500 0.7500 0.2500, owned by 2: 2 3 12 13 6 7 14 15 
+DEAL:0::Cell with center: 0.7500 0.7500 0.2500, owned by 3: 3 9 13 16 7 11 15 17 
+DEAL:0::Cell with center: 0.2500 0.2500 0.7500, owned by 3: 4 5 6 7 18 19 20 21 
+DEAL:0::Cell with center: 0.7500 0.2500 0.7500, owned by 4: 5 10 7 11 19 22 21 23 
+DEAL:0::Cell with center: 0.2500 0.7500 0.7500, owned by 5: 6 7 14 15 20 21 24 25 
+DEAL:0::Cell with center: 0.7500 0.7500 0.7500, owned by 6: 7 11 15 17 21 23 25 26 
+DEAL:0::Level 2
+DEAL:0::Cell with center: 0.1250 0.1250 0.1250, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:0::Cell with center: 0.3750 0.1250 0.1250, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:0::Cell with center: 0.1250 0.3750 0.1250, owned by 0: 2 3 12 13 6 7 14 15 
+DEAL:0::Cell with center: 0.3750 0.3750 0.1250, owned by 0: 3 9 13 16 7 11 15 17 
+DEAL:0::Cell with center: 0.1250 0.1250 0.3750, owned by 0: 4 5 6 7 18 19 20 21 
+DEAL:0::Cell with center: 0.3750 0.1250 0.3750, owned by 0: 5 10 7 11 19 22 21 23 
+DEAL:0::Cell with center: 0.1250 0.3750 0.3750, owned by 0: 6 7 14 15 20 21 24 25 
+DEAL:0::Cell with center: 0.3750 0.3750 0.3750, owned by 0: 7 11 15 17 21 23 25 26 
+DEAL:0::Cell with center: 0.6250 0.1250 0.1250, owned by 1: 8 27 9 28 10 29 11 30 
+DEAL:0::Cell with center: 0.6250 0.3750 0.1250, owned by 1: 9 28 16 35 11 30 17 36 
+DEAL:0::Cell with center: 0.6250 0.1250 0.3750, owned by 1: 10 29 11 30 22 39 23 40 
+DEAL:0::Cell with center: 0.6250 0.3750 0.3750, owned by 1: 11 30 17 36 23 40 26 43 
+DEAL:0::Cell with center: 0.1250 0.6250 0.1250, owned by 2: 12 13 45 46 14 15 47 48 
+DEAL:0::Cell with center: 0.3750 0.6250 0.1250, owned by 2: 13 16 46 49 15 17 48 50 
+DEAL:0::Cell with center: 0.1250 0.8750 0.1250, owned by 2: 45 46 51 52 47 48 53 54 
+DEAL:0::Cell with center: 0.3750 0.8750 0.1250, owned by 2: 46 49 52 55 48 50 54 56 
+DEAL:0::Cell with center: 0.1250 0.6250 0.3750, owned by 2: 14 15 47 48 24 25 57 58 
+DEAL:0::Cell with center: 0.3750 0.6250 0.3750, owned by 2: 15 17 48 50 25 26 58 59 
+DEAL:0::Cell with center: 0.1250 0.8750 0.3750, owned by 2: 47 48 53 54 57 58 60 61 
+DEAL:0::Cell with center: 0.3750 0.8750 0.3750, owned by 2: 48 50 54 56 58 59 61 62 
+DEAL:0::Cell with center: 0.6250 0.6250 0.1250, owned by 3: 16 35 49 63 17 36 50 64 
+DEAL:0::Cell with center: 0.6250 0.8750 0.1250, owned by 3: 49 63 55 67 50 64 56 68 
+DEAL:0::Cell with center: 0.6250 0.6250 0.3750, owned by 3: 17 36 50 64 26 43 59 71 
+DEAL:0::Cell with center: 0.6250 0.8750 0.3750, owned by 3: 50 64 56 68 59 71 62 73 
+DEAL:0::Cell with center: 0.1250 0.1250 0.6250, owned by 3: 18 19 20 21 75 76 77 78 
+DEAL:0::Cell with center: 0.3750 0.1250 0.6250, owned by 3: 19 22 21 23 76 79 78 80 
+DEAL:0::Cell with center: 0.1250 0.3750 0.6250, owned by 3: 20 21 24 25 77 78 81 82 
+DEAL:0::Cell with center: 0.3750 0.3750 0.6250, owned by 3: 21 23 25 26 78 80 82 83 
+DEAL:0::Cell with center: 0.1250 0.1250 0.8750, owned by 3: 75 76 77 78 84 85 86 87 
+DEAL:0::Cell with center: 0.3750 0.1250 0.8750, owned by 3: 76 79 78 80 85 88 87 89 
+DEAL:0::Cell with center: 0.1250 0.3750 0.8750, owned by 3: 77 78 81 82 86 87 90 91 
+DEAL:0::Cell with center: 0.3750 0.3750 0.8750, owned by 3: 78 80 82 83 87 89 91 92 
+DEAL:0::Cell with center: 0.6250 0.1250 0.6250, owned by 4: 22 39 23 40 79 93 80 94 
+DEAL:0::Cell with center: 0.6250 0.3750 0.6250, owned by 4: 23 40 26 43 80 94 83 97 
+DEAL:0::Cell with center: 0.6250 0.1250 0.8750, owned by 4: 79 93 80 94 88 99 89 100 
+DEAL:0::Cell with center: 0.6250 0.3750 0.8750, owned by 4: 80 94 83 97 89 100 92 103 
+DEAL:0::Cell with center: 0.1250 0.6250 0.6250, owned by 5: 24 25 57 58 81 82 105 106 
+DEAL:0::Cell with center: 0.3750 0.6250 0.6250, owned by 5: 25 26 58 59 82 83 106 107 
+DEAL:0::Cell with center: 0.1250 0.8750 0.6250, owned by 5: 57 58 60 61 105 106 108 109 
+DEAL:0::Cell with center: 0.3750 0.8750 0.6250, owned by 5: 58 59 61 62 106 107 109 110 
+DEAL:0::Cell with center: 0.1250 0.6250 0.8750, owned by 5: 81 82 105 106 90 91 111 112 
+DEAL:0::Cell with center: 0.3750 0.6250 0.8750, owned by 5: 82 83 106 107 91 92 112 113 
+DEAL:0::Cell with center: 0.1250 0.8750 0.8750, owned by 5: 105 106 108 109 111 112 114 115 
+DEAL:0::Cell with center: 0.3750 0.8750 0.8750, owned by 5: 106 107 109 110 112 113 115 116 
+DEAL:0::Cell with center: 0.6250 0.6250 0.6250, owned by 6: 26 43 59 71 83 97 107 117 
+DEAL:0::Cell with center: 0.6250 0.8750 0.6250, owned by 6: 59 71 62 73 107 117 110 119 
+DEAL:0::Cell with center: 0.6250 0.6250 0.8750, owned by 6: 83 97 107 117 92 103 113 121 
+DEAL:0::Cell with center: 0.6250 0.8750 0.8750, owned by 6: 107 117 110 119 113 121 116 123 
+
+DEAL:1::Level 0
+DEAL:1::Cell with center: 0.5000 0.5000, owned by 0: 0 1 2 3 
+DEAL:1::Level 1
+DEAL:1::Cell with center: 0.2500 0.2500, owned by 0: 0 1 2 3 
+DEAL:1::Cell with center: 0.7500 0.2500, owned by 0: 1 4 3 5 
+DEAL:1::Cell with center: 0.2500 0.7500, owned by 1: 2 3 6 7 
+DEAL:1::Cell with center: 0.7500 0.7500, owned by 2: 3 5 7 8 
+DEAL:1::Level 2
+DEAL:1::Cell with center: 0.3750 0.1250, owned by 0: 1 4 3 5 
+DEAL:1::Cell with center: 0.1250 0.3750, owned by 0: 2 3 6 7 
+DEAL:1::Cell with center: 0.3750 0.3750, owned by 0: 3 5 7 8 
+DEAL:1::Cell with center: 0.6250 0.1250, owned by 0: 4 9 5 10 
+DEAL:1::Cell with center: 0.8750 0.1250, owned by 1: 9 11 10 12 
+DEAL:1::Cell with center: 0.6250 0.3750, owned by 1: 5 10 8 13 
+DEAL:1::Cell with center: 0.8750 0.3750, owned by 1: 10 12 13 14 
+DEAL:1::Cell with center: 0.1250 0.6250, owned by 1: 6 7 15 16 
+DEAL:1::Cell with center: 0.3750 0.6250, owned by 2: 7 8 16 17 
+DEAL:1::Cell with center: 0.1250 0.8750, owned by 2: 15 16 18 19 
+DEAL:1::Cell with center: 0.3750 0.8750, owned by 2: 16 17 19 20 
+DEAL:1::Cell with center: 0.6250 0.6250, owned by 2: 8 13 17 21 
+DEAL:1::Cell with center: 0.8750 0.6250, owned by 2: 13 14 21 22 
+DEAL:1::Cell with center: 0.6250 0.8750, owned by 3: 17 21 20 23 
+DEAL:1::Cell with center: 0.8750 0.8750, owned by 3: 21 22 23 24 
+DEAL:1::Cell with center: 1.125 0.1250, owned by 3: 11 25 12 26 
+DEAL:1::Cell with center: 1.125 0.3750, owned by 4: 12 26 14 29 
+DEAL:1::Cell with center: 1.125 0.6250, owned by 5: 14 29 22 37 
+DEAL:1::Cell with center: 1.125 0.8750, owned by 5: 22 37 24 39 
+DEAL:1::Level 3
+DEAL:1::Cell with center: 0.4375 0.1875, owned by 0: 10 12 13 14 
+DEAL:1::Cell with center: 0.06250 0.4375, owned by 0: 15 16 18 19 
+DEAL:1::Cell with center: 0.1875 0.4375, owned by 0: 16 17 19 20 
+DEAL:1::Cell with center: 0.4375 0.3125, owned by 0: 13 14 21 22 
+DEAL:1::Cell with center: 0.3125 0.4375, owned by 0: 17 21 20 23 
+DEAL:1::Cell with center: 0.4375 0.4375, owned by 0: 21 22 23 24 
+DEAL:1::Cell with center: 0.6875 0.06250, owned by 0: 25 27 26 28 
+DEAL:1::Cell with center: 0.5625 0.1875, owned by 0: 12 26 14 29 
+DEAL:1::Cell with center: 0.6875 0.1875, owned by 0: 26 28 29 30 
+DEAL:1::Cell with center: 0.8125 0.06250, owned by 1: 27 31 28 32 
+DEAL:1::Cell with center: 0.9375 0.06250, owned by 1: 31 33 32 34 
+DEAL:1::Cell with center: 0.8125 0.1875, owned by 1: 28 32 30 35 
+DEAL:1::Cell with center: 0.9375 0.1875, owned by 1: 32 34 35 36 
+DEAL:1::Cell with center: 0.5625 0.3125, owned by 1: 14 29 22 37 
+DEAL:1::Cell with center: 0.6875 0.3125, owned by 1: 29 30 37 38 
+DEAL:1::Cell with center: 0.5625 0.4375, owned by 1: 22 37 24 39 
+DEAL:1::Cell with center: 0.6875 0.4375, owned by 1: 37 38 39 40 
+DEAL:1::Cell with center: 0.8125 0.3125, owned by 1: 30 35 38 41 
+DEAL:1::Cell with center: 0.9375 0.3125, owned by 1: 35 36 41 42 
+DEAL:1::Cell with center: 0.8125 0.4375, owned by 1: 38 41 40 43 
+DEAL:1::Cell with center: 0.9375 0.4375, owned by 1: 41 42 43 44 
+DEAL:1::Cell with center: 0.06250 0.5625, owned by 1: 18 19 45 46 
+DEAL:1::Cell with center: 0.1875 0.5625, owned by 1: 19 20 46 47 
+DEAL:1::Cell with center: 0.06250 0.6875, owned by 1: 45 46 48 49 
+DEAL:1::Cell with center: 0.1875 0.6875, owned by 1: 46 47 49 50 
+DEAL:1::Cell with center: 0.3125 0.5625, owned by 2: 20 23 47 51 
+DEAL:1::Cell with center: 0.4375 0.5625, owned by 2: 23 24 51 52 
+DEAL:1::Cell with center: 0.3125 0.6875, owned by 2: 47 51 50 53 
+DEAL:1::Cell with center: 0.06250 0.8125, owned by 2: 48 49 55 56 
+DEAL:1::Cell with center: 0.1875 0.8125, owned by 2: 49 50 56 57 
+DEAL:1::Cell with center: 0.3125 0.8125, owned by 2: 50 53 57 61 
+DEAL:1::Cell with center: 0.5625 0.5625, owned by 2: 24 39 52 65 
+DEAL:1::Cell with center: 0.6875 0.5625, owned by 2: 39 40 65 66 
+DEAL:1::Cell with center: 0.8125 0.5625, owned by 2: 40 43 66 69 
+DEAL:1::Cell with center: 0.9375 0.5625, owned by 2: 43 44 69 70 
+DEAL:1::Cell with center: 0.6875 0.9375, owned by 3: 73 74 75 76 
+DEAL:1::Cell with center: 0.8125 0.9375, owned by 3: 74 77 76 79 
+DEAL:1::Cell with center: 0.9375 0.9375, owned by 3: 77 78 79 80 
+DEAL:1::Cell with center: 1.062 0.06250, owned by 3: 33 81 34 82 
+DEAL:1::Cell with center: 1.062 0.1875, owned by 3: 34 82 36 85 
+DEAL:1::Cell with center: 1.062 0.3125, owned by 4: 36 85 42 93 
+DEAL:1::Cell with center: 1.062 0.4375, owned by 4: 42 93 44 95 
+DEAL:1::Cell with center: 1.062 0.5625, owned by 5: 44 95 70 121 
+DEAL:1::Cell with center: 1.062 0.9375, owned by 5: 78 129 80 131 
+DEAL:1::Level 0
+DEAL:1::Cell with center: 0.5000 0.5000 0.5000, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:1::Level 1
+DEAL:1::Cell with center: 0.2500 0.2500 0.2500, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:1::Cell with center: 0.7500 0.2500 0.2500, owned by 1: 1 8 3 9 5 10 7 11 
+DEAL:1::Cell with center: 0.2500 0.7500 0.2500, owned by 2: 2 3 12 13 6 7 14 15 
+DEAL:1::Cell with center: 0.7500 0.7500 0.2500, owned by 3: 3 9 13 16 7 11 15 17 
+DEAL:1::Cell with center: 0.2500 0.2500 0.7500, owned by 3: 4 5 6 7 18 19 20 21 
+DEAL:1::Cell with center: 0.7500 0.2500 0.7500, owned by 4: 5 10 7 11 19 22 21 23 
+DEAL:1::Cell with center: 0.2500 0.7500 0.7500, owned by 5: 6 7 14 15 20 21 24 25 
+DEAL:1::Cell with center: 0.7500 0.7500 0.7500, owned by 6: 7 11 15 17 21 23 25 26 
+DEAL:1::Level 2
+DEAL:1::Cell with center: 0.3750 0.1250 0.1250, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:1::Cell with center: 0.3750 0.3750 0.1250, owned by 0: 3 9 13 16 7 11 15 17 
+DEAL:1::Cell with center: 0.3750 0.1250 0.3750, owned by 0: 5 10 7 11 19 22 21 23 
+DEAL:1::Cell with center: 0.3750 0.3750 0.3750, owned by 0: 7 11 15 17 21 23 25 26 
+DEAL:1::Cell with center: 0.6250 0.1250 0.1250, owned by 1: 8 27 9 28 10 29 11 30 
+DEAL:1::Cell with center: 0.8750 0.1250 0.1250, owned by 1: 27 31 28 32 29 33 30 34 
+DEAL:1::Cell with center: 0.6250 0.3750 0.1250, owned by 1: 9 28 16 35 11 30 17 36 
+DEAL:1::Cell with center: 0.8750 0.3750 0.1250, owned by 1: 28 32 35 37 30 34 36 38 
+DEAL:1::Cell with center: 0.6250 0.1250 0.3750, owned by 1: 10 29 11 30 22 39 23 40 
+DEAL:1::Cell with center: 0.8750 0.1250 0.3750, owned by 1: 29 33 30 34 39 41 40 42 
+DEAL:1::Cell with center: 0.6250 0.3750 0.3750, owned by 1: 11 30 17 36 23 40 26 43 
+DEAL:1::Cell with center: 0.8750 0.3750 0.3750, owned by 1: 30 34 36 38 40 42 43 44 
+DEAL:1::Cell with center: 0.3750 0.6250 0.1250, owned by 2: 13 16 46 49 15 17 48 50 
+DEAL:1::Cell with center: 0.3750 0.8750 0.1250, owned by 2: 46 49 52 55 48 50 54 56 
+DEAL:1::Cell with center: 0.3750 0.6250 0.3750, owned by 2: 15 17 48 50 25 26 58 59 
+DEAL:1::Cell with center: 0.3750 0.8750 0.3750, owned by 2: 48 50 54 56 58 59 61 62 
+DEAL:1::Cell with center: 0.6250 0.6250 0.1250, owned by 3: 16 35 49 63 17 36 50 64 
+DEAL:1::Cell with center: 0.8750 0.6250 0.1250, owned by 3: 35 37 63 65 36 38 64 66 
+DEAL:1::Cell with center: 0.6250 0.8750 0.1250, owned by 3: 49 63 55 67 50 64 56 68 
+DEAL:1::Cell with center: 0.8750 0.8750 0.1250, owned by 3: 63 65 67 69 64 66 68 70 
+DEAL:1::Cell with center: 0.6250 0.6250 0.3750, owned by 3: 17 36 50 64 26 43 59 71 
+DEAL:1::Cell with center: 0.8750 0.6250 0.3750, owned by 3: 36 38 64 66 43 44 71 72 
+DEAL:1::Cell with center: 0.6250 0.8750 0.3750, owned by 3: 50 64 56 68 59 71 62 73 
+DEAL:1::Cell with center: 0.8750 0.8750 0.3750, owned by 3: 64 66 68 70 71 72 73 74 
+DEAL:1::Cell with center: 0.3750 0.1250 0.6250, owned by 3: 19 22 21 23 76 79 78 80 
+DEAL:1::Cell with center: 0.3750 0.3750 0.6250, owned by 3: 21 23 25 26 78 80 82 83 
+DEAL:1::Cell with center: 0.3750 0.1250 0.8750, owned by 3: 76 79 78 80 85 88 87 89 
+DEAL:1::Cell with center: 0.3750 0.3750 0.8750, owned by 3: 78 80 82 83 87 89 91 92 
+DEAL:1::Cell with center: 0.6250 0.1250 0.6250, owned by 4: 22 39 23 40 79 93 80 94 
+DEAL:1::Cell with center: 0.8750 0.1250 0.6250, owned by 4: 39 41 40 42 93 95 94 96 
+DEAL:1::Cell with center: 0.6250 0.3750 0.6250, owned by 4: 23 40 26 43 80 94 83 97 
+DEAL:1::Cell with center: 0.8750 0.3750 0.6250, owned by 4: 40 42 43 44 94 96 97 98 
+DEAL:1::Cell with center: 0.6250 0.1250 0.8750, owned by 4: 79 93 80 94 88 99 89 100 
+DEAL:1::Cell with center: 0.8750 0.1250 0.8750, owned by 4: 93 95 94 96 99 101 100 102 
+DEAL:1::Cell with center: 0.6250 0.3750 0.8750, owned by 4: 80 94 83 97 89 100 92 103 
+DEAL:1::Cell with center: 0.8750 0.3750 0.8750, owned by 4: 94 96 97 98 100 102 103 104 
+DEAL:1::Cell with center: 0.3750 0.6250 0.6250, owned by 5: 25 26 58 59 82 83 106 107 
+DEAL:1::Cell with center: 0.3750 0.8750 0.6250, owned by 5: 58 59 61 62 106 107 109 110 
+DEAL:1::Cell with center: 0.3750 0.6250 0.8750, owned by 5: 82 83 106 107 91 92 112 113 
+DEAL:1::Cell with center: 0.3750 0.8750 0.8750, owned by 5: 106 107 109 110 112 113 115 116 
+DEAL:1::Cell with center: 0.6250 0.6250 0.6250, owned by 6: 26 43 59 71 83 97 107 117 
+DEAL:1::Cell with center: 0.8750 0.6250 0.6250, owned by 6: 43 44 71 72 97 98 117 118 
+DEAL:1::Cell with center: 0.6250 0.8750 0.6250, owned by 6: 59 71 62 73 107 117 110 119 
+DEAL:1::Cell with center: 0.8750 0.8750 0.6250, owned by 6: 71 72 73 74 117 118 119 120 
+DEAL:1::Cell with center: 0.6250 0.6250 0.8750, owned by 6: 83 97 107 117 92 103 113 121 
+DEAL:1::Cell with center: 0.8750 0.6250 0.8750, owned by 6: 97 98 117 118 103 104 121 122 
+DEAL:1::Cell with center: 0.6250 0.8750 0.8750, owned by 6: 107 117 110 119 113 121 116 123 
+DEAL:1::Cell with center: 0.8750 0.8750 0.8750, owned by 6: 117 118 119 120 121 122 123 124 
+
+
+DEAL:2::Level 0
+DEAL:2::Cell with center: 0.5000 0.5000, owned by 0: 0 1 2 3 
+DEAL:2::Level 1
+DEAL:2::Cell with center: 0.2500 0.2500, owned by 0: 0 1 2 3 
+DEAL:2::Cell with center: 0.7500 0.2500, owned by 0: 1 4 3 5 
+DEAL:2::Cell with center: 0.2500 0.7500, owned by 1: 2 3 6 7 
+DEAL:2::Cell with center: 0.7500 0.7500, owned by 2: 3 5 7 8 
+DEAL:2::Cell with center: 1.250 0.2500, owned by 3: 4 9 5 10 
+DEAL:2::Cell with center: 1.250 0.7500, owned by 5: 5 10 8 13 
+DEAL:2::Level 2
+DEAL:2::Cell with center: 0.1250 0.1250, owned by 0: 0 1 2 3 
+DEAL:2::Cell with center: 0.3750 0.1250, owned by 0: 1 4 3 5 
+DEAL:2::Cell with center: 0.1250 0.3750, owned by 0: 2 3 6 7 
+DEAL:2::Cell with center: 0.3750 0.3750, owned by 0: 3 5 7 8 
+DEAL:2::Cell with center: 0.6250 0.1250, owned by 0: 4 9 5 10 
+DEAL:2::Cell with center: 0.6250 0.3750, owned by 1: 5 10 8 13 
+DEAL:2::Cell with center: 0.8750 0.3750, owned by 1: 10 12 13 14 
+DEAL:2::Cell with center: 0.1250 0.6250, owned by 1: 6 7 15 16 
+DEAL:2::Cell with center: 0.3750 0.6250, owned by 2: 7 8 16 17 
+DEAL:2::Cell with center: 0.1250 0.8750, owned by 2: 15 16 18 19 
+DEAL:2::Cell with center: 0.3750 0.8750, owned by 2: 16 17 19 20 
+DEAL:2::Cell with center: 0.6250 0.6250, owned by 2: 8 13 17 21 
+DEAL:2::Cell with center: 0.8750 0.6250, owned by 2: 13 14 21 22 
+DEAL:2::Cell with center: 0.6250 0.8750, owned by 3: 17 21 20 23 
+DEAL:2::Cell with center: 0.8750 0.8750, owned by 3: 21 22 23 24 
+DEAL:2::Cell with center: 1.125 0.3750, owned by 4: 12 26 14 29 
+DEAL:2::Cell with center: 1.125 0.6250, owned by 5: 14 29 22 37 
+DEAL:2::Cell with center: 1.125 0.8750, owned by 5: 22 37 24 39 
+DEAL:2::Level 3
+DEAL:2::Cell with center: 0.06250 0.06250, owned by 0: 0 1 2 3 
+DEAL:2::Cell with center: 0.1875 0.06250, owned by 0: 1 4 3 5 
+DEAL:2::Cell with center: 0.3125 0.06250, owned by 0: 4 9 5 10 
+DEAL:2::Cell with center: 0.4375 0.06250, owned by 0: 9 11 10 12 
+DEAL:2::Cell with center: 0.1875 0.4375, owned by 0: 16 17 19 20 
+DEAL:2::Cell with center: 0.3125 0.4375, owned by 0: 17 21 20 23 
+DEAL:2::Cell with center: 0.4375 0.4375, owned by 0: 21 22 23 24 
+DEAL:2::Cell with center: 0.5625 0.06250, owned by 0: 11 25 12 26 
+DEAL:2::Cell with center: 0.5625 0.4375, owned by 1: 22 37 24 39 
+DEAL:2::Cell with center: 0.6875 0.4375, owned by 1: 37 38 39 40 
+DEAL:2::Cell with center: 0.8125 0.4375, owned by 1: 38 41 40 43 
+DEAL:2::Cell with center: 0.9375 0.4375, owned by 1: 41 42 43 44 
+DEAL:2::Cell with center: 0.1875 0.5625, owned by 1: 19 20 46 47 
+DEAL:2::Cell with center: 0.06250 0.6875, owned by 1: 45 46 48 49 
+DEAL:2::Cell with center: 0.1875 0.6875, owned by 1: 46 47 49 50 
+DEAL:2::Cell with center: 0.3125 0.5625, owned by 2: 20 23 47 51 
+DEAL:2::Cell with center: 0.4375 0.5625, owned by 2: 23 24 51 52 
+DEAL:2::Cell with center: 0.3125 0.6875, owned by 2: 47 51 50 53 
+DEAL:2::Cell with center: 0.4375 0.6875, owned by 2: 51 52 53 54 
+DEAL:2::Cell with center: 0.06250 0.8125, owned by 2: 48 49 55 56 
+DEAL:2::Cell with center: 0.1875 0.8125, owned by 2: 49 50 56 57 
+DEAL:2::Cell with center: 0.06250 0.9375, owned by 2: 55 56 58 59 
+DEAL:2::Cell with center: 0.1875 0.9375, owned by 2: 56 57 59 60 
+DEAL:2::Cell with center: 0.3125 0.8125, owned by 2: 50 53 57 61 
+DEAL:2::Cell with center: 0.4375 0.8125, owned by 2: 53 54 61 62 
+DEAL:2::Cell with center: 0.3125 0.9375, owned by 2: 57 61 60 63 
+DEAL:2::Cell with center: 0.4375 0.9375, owned by 2: 61 62 63 64 
+DEAL:2::Cell with center: 0.5625 0.5625, owned by 2: 24 39 52 65 
+DEAL:2::Cell with center: 0.6875 0.5625, owned by 2: 39 40 65 66 
+DEAL:2::Cell with center: 0.5625 0.6875, owned by 2: 52 65 54 67 
+DEAL:2::Cell with center: 0.6875 0.6875, owned by 2: 65 66 67 68 
+DEAL:2::Cell with center: 0.8125 0.5625, owned by 2: 40 43 66 69 
+DEAL:2::Cell with center: 0.9375 0.5625, owned by 2: 43 44 69 70 
+DEAL:2::Cell with center: 0.8125 0.6875, owned by 2: 66 69 68 71 
+DEAL:2::Cell with center: 0.9375 0.6875, owned by 2: 69 70 71 72 
+DEAL:2::Cell with center: 0.5625 0.8125, owned by 3: 54 67 62 73 
+DEAL:2::Cell with center: 0.6875 0.8125, owned by 3: 67 68 73 74 
+DEAL:2::Cell with center: 0.5625 0.9375, owned by 3: 62 73 64 75 
+DEAL:2::Cell with center: 0.8125 0.8125, owned by 3: 68 71 74 77 
+DEAL:2::Cell with center: 0.9375 0.8125, owned by 3: 71 72 77 78 
+DEAL:2::Cell with center: 1.062 0.4375, owned by 4: 42 93 44 95 
+DEAL:2::Cell with center: 1.062 0.5625, owned by 5: 44 95 70 121 
+DEAL:2::Cell with center: 1.062 0.6875, owned by 5: 70 121 72 123 
+DEAL:2::Cell with center: 1.062 0.8125, owned by 5: 72 123 78 129 
+DEAL:2::Level 0
+DEAL:2::Cell with center: 0.5000 0.5000 0.5000, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:2::Level 1
+DEAL:2::Cell with center: 0.2500 0.2500 0.2500, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:2::Cell with center: 0.7500 0.2500 0.2500, owned by 1: 1 8 3 9 5 10 7 11 
+DEAL:2::Cell with center: 0.2500 0.7500 0.2500, owned by 2: 2 3 12 13 6 7 14 15 
+DEAL:2::Cell with center: 0.7500 0.7500 0.2500, owned by 3: 3 9 13 16 7 11 15 17 
+DEAL:2::Cell with center: 0.2500 0.2500 0.7500, owned by 3: 4 5 6 7 18 19 20 21 
+DEAL:2::Cell with center: 0.7500 0.2500 0.7500, owned by 4: 5 10 7 11 19 22 21 23 
+DEAL:2::Cell with center: 0.2500 0.7500 0.7500, owned by 5: 6 7 14 15 20 21 24 25 
+DEAL:2::Cell with center: 0.7500 0.7500 0.7500, owned by 6: 7 11 15 17 21 23 25 26 
+DEAL:2::Level 2
+DEAL:2::Cell with center: 0.1250 0.1250 0.1250, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:2::Cell with center: 0.3750 0.1250 0.1250, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:2::Cell with center: 0.1250 0.3750 0.1250, owned by 0: 2 3 12 13 6 7 14 15 
+DEAL:2::Cell with center: 0.3750 0.3750 0.1250, owned by 0: 3 9 13 16 7 11 15 17 
+DEAL:2::Cell with center: 0.1250 0.1250 0.3750, owned by 0: 4 5 6 7 18 19 20 21 
+DEAL:2::Cell with center: 0.3750 0.1250 0.3750, owned by 0: 5 10 7 11 19 22 21 23 
+DEAL:2::Cell with center: 0.1250 0.3750 0.3750, owned by 0: 6 7 14 15 20 21 24 25 
+DEAL:2::Cell with center: 0.3750 0.3750 0.3750, owned by 0: 7 11 15 17 21 23 25 26 
+DEAL:2::Cell with center: 0.6250 0.1250 0.1250, owned by 1: 8 27 9 28 10 29 11 30 
+DEAL:2::Cell with center: 0.6250 0.3750 0.1250, owned by 1: 9 28 16 35 11 30 17 36 
+DEAL:2::Cell with center: 0.6250 0.1250 0.3750, owned by 1: 10 29 11 30 22 39 23 40 
+DEAL:2::Cell with center: 0.6250 0.3750 0.3750, owned by 1: 11 30 17 36 23 40 26 43 
+DEAL:2::Cell with center: 0.1250 0.6250 0.1250, owned by 2: 12 13 45 46 14 15 47 48 
+DEAL:2::Cell with center: 0.3750 0.6250 0.1250, owned by 2: 13 16 46 49 15 17 48 50 
+DEAL:2::Cell with center: 0.1250 0.8750 0.1250, owned by 2: 45 46 51 52 47 48 53 54 
+DEAL:2::Cell with center: 0.3750 0.8750 0.1250, owned by 2: 46 49 52 55 48 50 54 56 
+DEAL:2::Cell with center: 0.1250 0.6250 0.3750, owned by 2: 14 15 47 48 24 25 57 58 
+DEAL:2::Cell with center: 0.3750 0.6250 0.3750, owned by 2: 15 17 48 50 25 26 58 59 
+DEAL:2::Cell with center: 0.1250 0.8750 0.3750, owned by 2: 47 48 53 54 57 58 60 61 
+DEAL:2::Cell with center: 0.3750 0.8750 0.3750, owned by 2: 48 50 54 56 58 59 61 62 
+DEAL:2::Cell with center: 0.6250 0.6250 0.1250, owned by 3: 16 35 49 63 17 36 50 64 
+DEAL:2::Cell with center: 0.6250 0.8750 0.1250, owned by 3: 49 63 55 67 50 64 56 68 
+DEAL:2::Cell with center: 0.6250 0.6250 0.3750, owned by 3: 17 36 50 64 26 43 59 71 
+DEAL:2::Cell with center: 0.6250 0.8750 0.3750, owned by 3: 50 64 56 68 59 71 62 73 
+DEAL:2::Cell with center: 0.1250 0.1250 0.6250, owned by 3: 18 19 20 21 75 76 77 78 
+DEAL:2::Cell with center: 0.3750 0.1250 0.6250, owned by 3: 19 22 21 23 76 79 78 80 
+DEAL:2::Cell with center: 0.1250 0.3750 0.6250, owned by 3: 20 21 24 25 77 78 81 82 
+DEAL:2::Cell with center: 0.3750 0.3750 0.6250, owned by 3: 21 23 25 26 78 80 82 83 
+DEAL:2::Cell with center: 0.1250 0.1250 0.8750, owned by 3: 75 76 77 78 84 85 86 87 
+DEAL:2::Cell with center: 0.3750 0.1250 0.8750, owned by 3: 76 79 78 80 85 88 87 89 
+DEAL:2::Cell with center: 0.1250 0.3750 0.8750, owned by 3: 77 78 81 82 86 87 90 91 
+DEAL:2::Cell with center: 0.3750 0.3750 0.8750, owned by 3: 78 80 82 83 87 89 91 92 
+DEAL:2::Cell with center: 0.6250 0.1250 0.6250, owned by 4: 22 39 23 40 79 93 80 94 
+DEAL:2::Cell with center: 0.6250 0.3750 0.6250, owned by 4: 23 40 26 43 80 94 83 97 
+DEAL:2::Cell with center: 0.6250 0.1250 0.8750, owned by 4: 79 93 80 94 88 99 89 100 
+DEAL:2::Cell with center: 0.6250 0.3750 0.8750, owned by 4: 80 94 83 97 89 100 92 103 
+DEAL:2::Cell with center: 0.1250 0.6250 0.6250, owned by 5: 24 25 57 58 81 82 105 106 
+DEAL:2::Cell with center: 0.3750 0.6250 0.6250, owned by 5: 25 26 58 59 82 83 106 107 
+DEAL:2::Cell with center: 0.1250 0.8750 0.6250, owned by 5: 57 58 60 61 105 106 108 109 
+DEAL:2::Cell with center: 0.3750 0.8750 0.6250, owned by 5: 58 59 61 62 106 107 109 110 
+DEAL:2::Cell with center: 0.1250 0.6250 0.8750, owned by 5: 81 82 105 106 90 91 111 112 
+DEAL:2::Cell with center: 0.3750 0.6250 0.8750, owned by 5: 82 83 106 107 91 92 112 113 
+DEAL:2::Cell with center: 0.1250 0.8750 0.8750, owned by 5: 105 106 108 109 111 112 114 115 
+DEAL:2::Cell with center: 0.3750 0.8750 0.8750, owned by 5: 106 107 109 110 112 113 115 116 
+DEAL:2::Cell with center: 0.6250 0.6250 0.6250, owned by 6: 26 43 59 71 83 97 107 117 
+DEAL:2::Cell with center: 0.6250 0.8750 0.6250, owned by 6: 59 71 62 73 107 117 110 119 
+DEAL:2::Cell with center: 0.6250 0.6250 0.8750, owned by 6: 83 97 107 117 92 103 113 121 
+DEAL:2::Cell with center: 0.6250 0.8750 0.8750, owned by 6: 107 117 110 119 113 121 116 123 
+
+
+DEAL:3::Level 0
+DEAL:3::Cell with center: 0.5000 0.5000, owned by 0: 0 1 2 3 
+DEAL:3::Cell with center: 1.500 0.5000, owned by 3: 1 4 3 5 
+DEAL:3::Level 1
+DEAL:3::Cell with center: 0.7500 0.2500, owned by 0: 1 4 3 5 
+DEAL:3::Cell with center: 0.7500 0.7500, owned by 2: 3 5 7 8 
+DEAL:3::Cell with center: 1.250 0.2500, owned by 3: 4 9 5 10 
+DEAL:3::Cell with center: 1.750 0.2500, owned by 4: 9 11 10 12 
+DEAL:3::Cell with center: 1.250 0.7500, owned by 5: 5 10 8 13 
+DEAL:3::Cell with center: 1.750 0.7500, owned by 6: 10 12 13 14 
+DEAL:3::Level 2
+DEAL:3::Cell with center: 0.3750 0.1250, owned by 0: 1 4 3 5 
+DEAL:3::Cell with center: 0.6250 0.1250, owned by 0: 4 9 5 10 
+DEAL:3::Cell with center: 0.8750 0.1250, owned by 1: 9 11 10 12 
+DEAL:3::Cell with center: 0.8750 0.3750, owned by 1: 10 12 13 14 
+DEAL:3::Cell with center: 0.3750 0.6250, owned by 2: 7 8 16 17 
+DEAL:3::Cell with center: 0.3750 0.8750, owned by 2: 16 17 19 20 
+DEAL:3::Cell with center: 0.6250 0.6250, owned by 2: 8 13 17 21 
+DEAL:3::Cell with center: 0.8750 0.6250, owned by 2: 13 14 21 22 
+DEAL:3::Cell with center: 0.6250 0.8750, owned by 3: 17 21 20 23 
+DEAL:3::Cell with center: 0.8750 0.8750, owned by 3: 21 22 23 24 
+DEAL:3::Cell with center: 1.125 0.1250, owned by 3: 11 25 12 26 
+DEAL:3::Cell with center: 1.375 0.1250, owned by 3: 25 27 26 28 
+DEAL:3::Cell with center: 1.125 0.3750, owned by 4: 12 26 14 29 
+DEAL:3::Cell with center: 1.375 0.3750, owned by 4: 26 28 29 30 
+DEAL:3::Cell with center: 1.625 0.1250, owned by 4: 27 31 28 32 
+DEAL:3::Cell with center: 1.625 0.3750, owned by 4: 28 32 30 35 
+DEAL:3::Cell with center: 1.125 0.6250, owned by 5: 14 29 22 37 
+DEAL:3::Cell with center: 1.125 0.8750, owned by 5: 22 37 24 39 
+DEAL:3::Cell with center: 1.375 0.8750, owned by 6: 37 38 39 40 
+DEAL:3::Cell with center: 1.625 0.8750, owned by 6: 38 41 40 43 
+DEAL:3::Level 3
+DEAL:3::Cell with center: 0.4375 0.06250, owned by 0: 9 11 10 12 
+DEAL:3::Cell with center: 0.5625 0.06250, owned by 0: 11 25 12 26 
+DEAL:3::Cell with center: 0.6875 0.06250, owned by 0: 25 27 26 28 
+DEAL:3::Cell with center: 0.8125 0.06250, owned by 1: 27 31 28 32 
+DEAL:3::Cell with center: 0.9375 0.06250, owned by 1: 31 33 32 34 
+DEAL:3::Cell with center: 0.9375 0.1875, owned by 1: 32 34 35 36 
+DEAL:3::Cell with center: 0.9375 0.3125, owned by 1: 35 36 41 42 
+DEAL:3::Cell with center: 0.4375 0.6875, owned by 2: 51 52 53 54 
+DEAL:3::Cell with center: 0.4375 0.8125, owned by 2: 53 54 61 62 
+DEAL:3::Cell with center: 0.4375 0.9375, owned by 2: 61 62 63 64 
+DEAL:3::Cell with center: 0.5625 0.6875, owned by 2: 52 65 54 67 
+DEAL:3::Cell with center: 0.6875 0.6875, owned by 2: 65 66 67 68 
+DEAL:3::Cell with center: 0.8125 0.6875, owned by 2: 66 69 68 71 
+DEAL:3::Cell with center: 0.9375 0.6875, owned by 2: 69 70 71 72 
+DEAL:3::Cell with center: 0.5625 0.8125, owned by 3: 54 67 62 73 
+DEAL:3::Cell with center: 0.6875 0.8125, owned by 3: 67 68 73 74 
+DEAL:3::Cell with center: 0.5625 0.9375, owned by 3: 62 73 64 75 
+DEAL:3::Cell with center: 0.6875 0.9375, owned by 3: 73 74 75 76 
+DEAL:3::Cell with center: 0.8125 0.8125, owned by 3: 68 71 74 77 
+DEAL:3::Cell with center: 0.9375 0.8125, owned by 3: 71 72 77 78 
+DEAL:3::Cell with center: 0.8125 0.9375, owned by 3: 74 77 76 79 
+DEAL:3::Cell with center: 0.9375 0.9375, owned by 3: 77 78 79 80 
+DEAL:3::Cell with center: 1.062 0.06250, owned by 3: 33 81 34 82 
+DEAL:3::Cell with center: 1.188 0.06250, owned by 3: 81 83 82 84 
+DEAL:3::Cell with center: 1.062 0.1875, owned by 3: 34 82 36 85 
+DEAL:3::Cell with center: 1.188 0.1875, owned by 3: 82 84 85 86 
+DEAL:3::Cell with center: 1.312 0.06250, owned by 3: 83 87 84 88 
+DEAL:3::Cell with center: 1.438 0.06250, owned by 3: 87 89 88 90 
+DEAL:3::Cell with center: 1.312 0.1875, owned by 3: 84 88 86 91 
+DEAL:3::Cell with center: 1.438 0.1875, owned by 3: 88 90 91 92 
+DEAL:3::Cell with center: 1.062 0.3125, owned by 4: 36 85 42 93 
+DEAL:3::Cell with center: 1.188 0.3125, owned by 4: 85 86 93 94 
+DEAL:3::Cell with center: 1.312 0.3125, owned by 4: 86 91 94 97 
+DEAL:3::Cell with center: 1.438 0.3125, owned by 4: 91 92 97 98 
+DEAL:3::Cell with center: 1.562 0.06250, owned by 4: 89 101 90 102 
+DEAL:3::Cell with center: 1.562 0.1875, owned by 4: 90 102 92 105 
+DEAL:3::Cell with center: 1.562 0.3125, owned by 4: 92 105 98 113 
+DEAL:3::Cell with center: 1.062 0.6875, owned by 5: 70 121 72 123 
+DEAL:3::Cell with center: 1.062 0.8125, owned by 5: 72 123 78 129 
+DEAL:3::Cell with center: 1.062 0.9375, owned by 5: 78 129 80 131 
+DEAL:3::Cell with center: 1.188 0.9375, owned by 5: 129 130 131 132 
+DEAL:3::Cell with center: 1.312 0.9375, owned by 6: 130 133 132 135 
+DEAL:3::Cell with center: 1.438 0.9375, owned by 6: 133 134 135 136 
+DEAL:3::Cell with center: 1.562 0.9375, owned by 6: 134 145 136 147 
+DEAL:3::Level 0
+DEAL:3::Cell with center: 0.5000 0.5000 0.5000, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:3::Level 1
+DEAL:3::Cell with center: 0.2500 0.2500 0.2500, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:3::Cell with center: 0.7500 0.2500 0.2500, owned by 1: 1 8 3 9 5 10 7 11 
+DEAL:3::Cell with center: 0.2500 0.7500 0.2500, owned by 2: 2 3 12 13 6 7 14 15 
+DEAL:3::Cell with center: 0.7500 0.7500 0.2500, owned by 3: 3 9 13 16 7 11 15 17 
+DEAL:3::Cell with center: 0.2500 0.2500 0.7500, owned by 3: 4 5 6 7 18 19 20 21 
+DEAL:3::Cell with center: 0.7500 0.2500 0.7500, owned by 4: 5 10 7 11 19 22 21 23 
+DEAL:3::Cell with center: 0.2500 0.7500 0.7500, owned by 5: 6 7 14 15 20 21 24 25 
+DEAL:3::Cell with center: 0.7500 0.7500 0.7500, owned by 6: 7 11 15 17 21 23 25 26 
+DEAL:3::Level 2
+DEAL:3::Cell with center: 0.1250 0.1250 0.1250, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:3::Cell with center: 0.3750 0.1250 0.1250, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:3::Cell with center: 0.1250 0.3750 0.1250, owned by 0: 2 3 12 13 6 7 14 15 
+DEAL:3::Cell with center: 0.3750 0.3750 0.1250, owned by 0: 3 9 13 16 7 11 15 17 
+DEAL:3::Cell with center: 0.1250 0.1250 0.3750, owned by 0: 4 5 6 7 18 19 20 21 
+DEAL:3::Cell with center: 0.3750 0.1250 0.3750, owned by 0: 5 10 7 11 19 22 21 23 
+DEAL:3::Cell with center: 0.1250 0.3750 0.3750, owned by 0: 6 7 14 15 20 21 24 25 
+DEAL:3::Cell with center: 0.3750 0.3750 0.3750, owned by 0: 7 11 15 17 21 23 25 26 
+DEAL:3::Cell with center: 0.6250 0.1250 0.1250, owned by 1: 8 27 9 28 10 29 11 30 
+DEAL:3::Cell with center: 0.8750 0.1250 0.1250, owned by 1: 27 31 28 32 29 33 30 34 
+DEAL:3::Cell with center: 0.6250 0.3750 0.1250, owned by 1: 9 28 16 35 11 30 17 36 
+DEAL:3::Cell with center: 0.8750 0.3750 0.1250, owned by 1: 28 32 35 37 30 34 36 38 
+DEAL:3::Cell with center: 0.6250 0.1250 0.3750, owned by 1: 10 29 11 30 22 39 23 40 
+DEAL:3::Cell with center: 0.8750 0.1250 0.3750, owned by 1: 29 33 30 34 39 41 40 42 
+DEAL:3::Cell with center: 0.6250 0.3750 0.3750, owned by 1: 11 30 17 36 23 40 26 43 
+DEAL:3::Cell with center: 0.8750 0.3750 0.3750, owned by 1: 30 34 36 38 40 42 43 44 
+DEAL:3::Cell with center: 0.1250 0.6250 0.1250, owned by 2: 12 13 45 46 14 15 47 48 
+DEAL:3::Cell with center: 0.3750 0.6250 0.1250, owned by 2: 13 16 46 49 15 17 48 50 
+DEAL:3::Cell with center: 0.1250 0.8750 0.1250, owned by 2: 45 46 51 52 47 48 53 54 
+DEAL:3::Cell with center: 0.3750 0.8750 0.1250, owned by 2: 46 49 52 55 48 50 54 56 
+DEAL:3::Cell with center: 0.1250 0.6250 0.3750, owned by 2: 14 15 47 48 24 25 57 58 
+DEAL:3::Cell with center: 0.3750 0.6250 0.3750, owned by 2: 15 17 48 50 25 26 58 59 
+DEAL:3::Cell with center: 0.1250 0.8750 0.3750, owned by 2: 47 48 53 54 57 58 60 61 
+DEAL:3::Cell with center: 0.3750 0.8750 0.3750, owned by 2: 48 50 54 56 58 59 61 62 
+DEAL:3::Cell with center: 0.6250 0.6250 0.1250, owned by 3: 16 35 49 63 17 36 50 64 
+DEAL:3::Cell with center: 0.8750 0.6250 0.1250, owned by 3: 35 37 63 65 36 38 64 66 
+DEAL:3::Cell with center: 0.6250 0.8750 0.1250, owned by 3: 49 63 55 67 50 64 56 68 
+DEAL:3::Cell with center: 0.8750 0.8750 0.1250, owned by 3: 63 65 67 69 64 66 68 70 
+DEAL:3::Cell with center: 0.6250 0.6250 0.3750, owned by 3: 17 36 50 64 26 43 59 71 
+DEAL:3::Cell with center: 0.8750 0.6250 0.3750, owned by 3: 36 38 64 66 43 44 71 72 
+DEAL:3::Cell with center: 0.6250 0.8750 0.3750, owned by 3: 50 64 56 68 59 71 62 73 
+DEAL:3::Cell with center: 0.8750 0.8750 0.3750, owned by 3: 64 66 68 70 71 72 73 74 
+DEAL:3::Cell with center: 0.1250 0.1250 0.6250, owned by 3: 18 19 20 21 75 76 77 78 
+DEAL:3::Cell with center: 0.3750 0.1250 0.6250, owned by 3: 19 22 21 23 76 79 78 80 
+DEAL:3::Cell with center: 0.1250 0.3750 0.6250, owned by 3: 20 21 24 25 77 78 81 82 
+DEAL:3::Cell with center: 0.3750 0.3750 0.6250, owned by 3: 21 23 25 26 78 80 82 83 
+DEAL:3::Cell with center: 0.1250 0.1250 0.8750, owned by 3: 75 76 77 78 84 85 86 87 
+DEAL:3::Cell with center: 0.3750 0.1250 0.8750, owned by 3: 76 79 78 80 85 88 87 89 
+DEAL:3::Cell with center: 0.1250 0.3750 0.8750, owned by 3: 77 78 81 82 86 87 90 91 
+DEAL:3::Cell with center: 0.3750 0.3750 0.8750, owned by 3: 78 80 82 83 87 89 91 92 
+DEAL:3::Cell with center: 0.6250 0.1250 0.6250, owned by 4: 22 39 23 40 79 93 80 94 
+DEAL:3::Cell with center: 0.8750 0.1250 0.6250, owned by 4: 39 41 40 42 93 95 94 96 
+DEAL:3::Cell with center: 0.6250 0.3750 0.6250, owned by 4: 23 40 26 43 80 94 83 97 
+DEAL:3::Cell with center: 0.8750 0.3750 0.6250, owned by 4: 40 42 43 44 94 96 97 98 
+DEAL:3::Cell with center: 0.6250 0.1250 0.8750, owned by 4: 79 93 80 94 88 99 89 100 
+DEAL:3::Cell with center: 0.8750 0.1250 0.8750, owned by 4: 93 95 94 96 99 101 100 102 
+DEAL:3::Cell with center: 0.6250 0.3750 0.8750, owned by 4: 80 94 83 97 89 100 92 103 
+DEAL:3::Cell with center: 0.8750 0.3750 0.8750, owned by 4: 94 96 97 98 100 102 103 104 
+DEAL:3::Cell with center: 0.1250 0.6250 0.6250, owned by 5: 24 25 57 58 81 82 105 106 
+DEAL:3::Cell with center: 0.3750 0.6250 0.6250, owned by 5: 25 26 58 59 82 83 106 107 
+DEAL:3::Cell with center: 0.1250 0.8750 0.6250, owned by 5: 57 58 60 61 105 106 108 109 
+DEAL:3::Cell with center: 0.3750 0.8750 0.6250, owned by 5: 58 59 61 62 106 107 109 110 
+DEAL:3::Cell with center: 0.1250 0.6250 0.8750, owned by 5: 81 82 105 106 90 91 111 112 
+DEAL:3::Cell with center: 0.3750 0.6250 0.8750, owned by 5: 82 83 106 107 91 92 112 113 
+DEAL:3::Cell with center: 0.1250 0.8750 0.8750, owned by 5: 105 106 108 109 111 112 114 115 
+DEAL:3::Cell with center: 0.3750 0.8750 0.8750, owned by 5: 106 107 109 110 112 113 115 116 
+DEAL:3::Cell with center: 0.6250 0.6250 0.6250, owned by 6: 26 43 59 71 83 97 107 117 
+DEAL:3::Cell with center: 0.8750 0.6250 0.6250, owned by 6: 43 44 71 72 97 98 117 118 
+DEAL:3::Cell with center: 0.6250 0.8750 0.6250, owned by 6: 59 71 62 73 107 117 110 119 
+DEAL:3::Cell with center: 0.8750 0.8750 0.6250, owned by 6: 71 72 73 74 117 118 119 120 
+DEAL:3::Cell with center: 0.6250 0.6250 0.8750, owned by 6: 83 97 107 117 92 103 113 121 
+DEAL:3::Cell with center: 0.8750 0.6250 0.8750, owned by 6: 97 98 117 118 103 104 121 122 
+DEAL:3::Cell with center: 0.6250 0.8750 0.8750, owned by 6: 107 117 110 119 113 121 116 123 
+DEAL:3::Cell with center: 0.8750 0.8750 0.8750, owned by 6: 117 118 119 120 121 122 123 124 
+
+
+DEAL:4::Level 0
+DEAL:4::Cell with center: 1.500 0.5000, owned by 3: 1 4 3 5 
+DEAL:4::Level 1
+DEAL:4::Cell with center: 1.250 0.2500, owned by 3: 4 9 5 10 
+DEAL:4::Cell with center: 1.750 0.2500, owned by 4: 9 11 10 12 
+DEAL:4::Cell with center: 1.250 0.7500, owned by 5: 5 10 8 13 
+DEAL:4::Cell with center: 1.750 0.7500, owned by 6: 10 12 13 14 
+DEAL:4::Level 2
+DEAL:4::Cell with center: 1.125 0.1250, owned by 3: 11 25 12 26 
+DEAL:4::Cell with center: 1.375 0.1250, owned by 3: 25 27 26 28 
+DEAL:4::Cell with center: 1.125 0.3750, owned by 4: 12 26 14 29 
+DEAL:4::Cell with center: 1.375 0.3750, owned by 4: 26 28 29 30 
+DEAL:4::Cell with center: 1.625 0.1250, owned by 4: 27 31 28 32 
+DEAL:4::Cell with center: 1.875 0.1250, owned by 4: 31 33 32 34 
+DEAL:4::Cell with center: 1.625 0.3750, owned by 4: 28 32 30 35 
+DEAL:4::Cell with center: 1.875 0.3750, owned by 5: 32 34 35 36 
+DEAL:4::Cell with center: 1.125 0.6250, owned by 5: 14 29 22 37 
+DEAL:4::Cell with center: 1.375 0.6250, owned by 5: 29 30 37 38 
+DEAL:4::Cell with center: 1.375 0.8750, owned by 6: 37 38 39 40 
+DEAL:4::Cell with center: 1.625 0.6250, owned by 6: 30 35 38 41 
+DEAL:4::Cell with center: 1.875 0.6250, owned by 6: 35 36 41 42 
+DEAL:4::Cell with center: 1.625 0.8750, owned by 6: 38 41 40 43 
+DEAL:4::Cell with center: 1.875 0.8750, owned by 6: 41 42 43 44 
+DEAL:4::Cell with center: 0.8750 0.1250, owned by 1: 9 11 10 12 
+DEAL:4::Cell with center: 0.8750 0.3750, owned by 1: 10 12 13 14 
+DEAL:4::Cell with center: 0.8750 0.6250, owned by 2: 13 14 21 22 
+DEAL:4::Level 3
+DEAL:4::Cell with center: 1.062 0.1875, owned by 3: 34 82 36 85 
+DEAL:4::Cell with center: 1.188 0.1875, owned by 3: 82 84 85 86 
+DEAL:4::Cell with center: 1.438 0.06250, owned by 3: 87 89 88 90 
+DEAL:4::Cell with center: 1.312 0.1875, owned by 3: 84 88 86 91 
+DEAL:4::Cell with center: 1.438 0.1875, owned by 3: 88 90 91 92 
+DEAL:4::Cell with center: 1.062 0.3125, owned by 4: 36 85 42 93 
+DEAL:4::Cell with center: 1.188 0.3125, owned by 4: 85 86 93 94 
+DEAL:4::Cell with center: 1.062 0.4375, owned by 4: 42 93 44 95 
+DEAL:4::Cell with center: 1.188 0.4375, owned by 4: 93 94 95 96 
+DEAL:4::Cell with center: 1.312 0.3125, owned by 4: 86 91 94 97 
+DEAL:4::Cell with center: 1.438 0.3125, owned by 4: 91 92 97 98 
+DEAL:4::Cell with center: 1.312 0.4375, owned by 4: 94 97 96 99 
+DEAL:4::Cell with center: 1.438 0.4375, owned by 4: 97 98 99 100 
+DEAL:4::Cell with center: 1.562 0.06250, owned by 4: 89 101 90 102 
+DEAL:4::Cell with center: 1.688 0.06250, owned by 4: 101 103 102 104 
+DEAL:4::Cell with center: 1.562 0.1875, owned by 4: 90 102 92 105 
+DEAL:4::Cell with center: 1.688 0.1875, owned by 4: 102 104 105 106 
+DEAL:4::Cell with center: 1.812 0.06250, owned by 4: 103 107 104 108 
+DEAL:4::Cell with center: 1.938 0.06250, owned by 4: 107 109 108 110 
+DEAL:4::Cell with center: 1.812 0.1875, owned by 4: 104 108 106 111 
+DEAL:4::Cell with center: 1.938 0.1875, owned by 4: 108 110 111 112 
+DEAL:4::Cell with center: 1.562 0.3125, owned by 4: 92 105 98 113 
+DEAL:4::Cell with center: 1.688 0.3125, owned by 4: 105 106 113 114 
+DEAL:4::Cell with center: 1.562 0.4375, owned by 4: 98 113 100 115 
+DEAL:4::Cell with center: 1.688 0.4375, owned by 4: 113 114 115 116 
+DEAL:4::Cell with center: 1.812 0.3125, owned by 5: 106 111 114 117 
+DEAL:4::Cell with center: 1.938 0.3125, owned by 5: 111 112 117 118 
+DEAL:4::Cell with center: 1.812 0.4375, owned by 5: 114 117 116 119 
+DEAL:4::Cell with center: 1.062 0.5625, owned by 5: 44 95 70 121 
+DEAL:4::Cell with center: 1.188 0.5625, owned by 5: 95 96 121 122 
+DEAL:4::Cell with center: 1.312 0.5625, owned by 5: 96 99 122 125 
+DEAL:4::Cell with center: 1.438 0.5625, owned by 5: 99 100 125 126 
+DEAL:4::Cell with center: 1.438 0.9375, owned by 6: 133 134 135 136 
+DEAL:4::Cell with center: 1.562 0.5625, owned by 6: 100 115 126 137 
+DEAL:4::Cell with center: 1.688 0.5625, owned by 6: 115 116 137 138 
+DEAL:4::Cell with center: 1.812 0.5625, owned by 6: 116 119 138 141 
+DEAL:4::Cell with center: 1.562 0.9375, owned by 6: 134 145 136 147 
+DEAL:4::Cell with center: 1.688 0.9375, owned by 6: 145 146 147 148 
+DEAL:4::Cell with center: 1.812 0.9375, owned by 6: 146 149 148 151 
+DEAL:4::Cell with center: 1.938 0.9375, owned by 6: 149 150 151 152 
+DEAL:4::Cell with center: 0.9375 0.1875, owned by 1: 32 34 35 36 
+DEAL:4::Cell with center: 0.9375 0.3125, owned by 1: 35 36 41 42 
+DEAL:4::Cell with center: 0.9375 0.4375, owned by 1: 41 42 43 44 
+DEAL:4::Cell with center: 0.9375 0.5625, owned by 2: 43 44 69 70 
+DEAL:4::Level 0
+DEAL:4::Cell with center: 0.5000 0.5000 0.5000, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:4::Level 1
+DEAL:4::Cell with center: 0.2500 0.2500 0.2500, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:4::Cell with center: 0.7500 0.2500 0.2500, owned by 1: 1 8 3 9 5 10 7 11 
+DEAL:4::Cell with center: 0.2500 0.7500 0.2500, owned by 2: 2 3 12 13 6 7 14 15 
+DEAL:4::Cell with center: 0.7500 0.7500 0.2500, owned by 3: 3 9 13 16 7 11 15 17 
+DEAL:4::Cell with center: 0.2500 0.2500 0.7500, owned by 3: 4 5 6 7 18 19 20 21 
+DEAL:4::Cell with center: 0.7500 0.2500 0.7500, owned by 4: 5 10 7 11 19 22 21 23 
+DEAL:4::Cell with center: 0.2500 0.7500 0.7500, owned by 5: 6 7 14 15 20 21 24 25 
+DEAL:4::Cell with center: 0.7500 0.7500 0.7500, owned by 6: 7 11 15 17 21 23 25 26 
+DEAL:4::Level 2
+DEAL:4::Cell with center: 0.3750 0.1250 0.1250, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:4::Cell with center: 0.3750 0.3750 0.1250, owned by 0: 3 9 13 16 7 11 15 17 
+DEAL:4::Cell with center: 0.3750 0.1250 0.3750, owned by 0: 5 10 7 11 19 22 21 23 
+DEAL:4::Cell with center: 0.3750 0.3750 0.3750, owned by 0: 7 11 15 17 21 23 25 26 
+DEAL:4::Cell with center: 0.6250 0.1250 0.1250, owned by 1: 8 27 9 28 10 29 11 30 
+DEAL:4::Cell with center: 0.8750 0.1250 0.1250, owned by 1: 27 31 28 32 29 33 30 34 
+DEAL:4::Cell with center: 0.6250 0.3750 0.1250, owned by 1: 9 28 16 35 11 30 17 36 
+DEAL:4::Cell with center: 0.8750 0.3750 0.1250, owned by 1: 28 32 35 37 30 34 36 38 
+DEAL:4::Cell with center: 0.6250 0.1250 0.3750, owned by 1: 10 29 11 30 22 39 23 40 
+DEAL:4::Cell with center: 0.8750 0.1250 0.3750, owned by 1: 29 33 30 34 39 41 40 42 
+DEAL:4::Cell with center: 0.6250 0.3750 0.3750, owned by 1: 11 30 17 36 23 40 26 43 
+DEAL:4::Cell with center: 0.8750 0.3750 0.3750, owned by 1: 30 34 36 38 40 42 43 44 
+DEAL:4::Cell with center: 0.3750 0.6250 0.1250, owned by 2: 13 16 46 49 15 17 48 50 
+DEAL:4::Cell with center: 0.3750 0.8750 0.1250, owned by 2: 46 49 52 55 48 50 54 56 
+DEAL:4::Cell with center: 0.3750 0.6250 0.3750, owned by 2: 15 17 48 50 25 26 58 59 
+DEAL:4::Cell with center: 0.3750 0.8750 0.3750, owned by 2: 48 50 54 56 58 59 61 62 
+DEAL:4::Cell with center: 0.6250 0.6250 0.1250, owned by 3: 16 35 49 63 17 36 50 64 
+DEAL:4::Cell with center: 0.8750 0.6250 0.1250, owned by 3: 35 37 63 65 36 38 64 66 
+DEAL:4::Cell with center: 0.6250 0.8750 0.1250, owned by 3: 49 63 55 67 50 64 56 68 
+DEAL:4::Cell with center: 0.8750 0.8750 0.1250, owned by 3: 63 65 67 69 64 66 68 70 
+DEAL:4::Cell with center: 0.6250 0.6250 0.3750, owned by 3: 17 36 50 64 26 43 59 71 
+DEAL:4::Cell with center: 0.8750 0.6250 0.3750, owned by 3: 36 38 64 66 43 44 71 72 
+DEAL:4::Cell with center: 0.6250 0.8750 0.3750, owned by 3: 50 64 56 68 59 71 62 73 
+DEAL:4::Cell with center: 0.8750 0.8750 0.3750, owned by 3: 64 66 68 70 71 72 73 74 
+DEAL:4::Cell with center: 0.3750 0.1250 0.6250, owned by 3: 19 22 21 23 76 79 78 80 
+DEAL:4::Cell with center: 0.3750 0.3750 0.6250, owned by 3: 21 23 25 26 78 80 82 83 
+DEAL:4::Cell with center: 0.3750 0.1250 0.8750, owned by 3: 76 79 78 80 85 88 87 89 
+DEAL:4::Cell with center: 0.3750 0.3750 0.8750, owned by 3: 78 80 82 83 87 89 91 92 
+DEAL:4::Cell with center: 0.6250 0.1250 0.6250, owned by 4: 22 39 23 40 79 93 80 94 
+DEAL:4::Cell with center: 0.8750 0.1250 0.6250, owned by 4: 39 41 40 42 93 95 94 96 
+DEAL:4::Cell with center: 0.6250 0.3750 0.6250, owned by 4: 23 40 26 43 80 94 83 97 
+DEAL:4::Cell with center: 0.8750 0.3750 0.6250, owned by 4: 40 42 43 44 94 96 97 98 
+DEAL:4::Cell with center: 0.6250 0.1250 0.8750, owned by 4: 79 93 80 94 88 99 89 100 
+DEAL:4::Cell with center: 0.8750 0.1250 0.8750, owned by 4: 93 95 94 96 99 101 100 102 
+DEAL:4::Cell with center: 0.6250 0.3750 0.8750, owned by 4: 80 94 83 97 89 100 92 103 
+DEAL:4::Cell with center: 0.8750 0.3750 0.8750, owned by 4: 94 96 97 98 100 102 103 104 
+DEAL:4::Cell with center: 0.3750 0.6250 0.6250, owned by 5: 25 26 58 59 82 83 106 107 
+DEAL:4::Cell with center: 0.3750 0.8750 0.6250, owned by 5: 58 59 61 62 106 107 109 110 
+DEAL:4::Cell with center: 0.3750 0.6250 0.8750, owned by 5: 82 83 106 107 91 92 112 113 
+DEAL:4::Cell with center: 0.3750 0.8750 0.8750, owned by 5: 106 107 109 110 112 113 115 116 
+DEAL:4::Cell with center: 0.6250 0.6250 0.6250, owned by 6: 26 43 59 71 83 97 107 117 
+DEAL:4::Cell with center: 0.8750 0.6250 0.6250, owned by 6: 43 44 71 72 97 98 117 118 
+DEAL:4::Cell with center: 0.6250 0.8750 0.6250, owned by 6: 59 71 62 73 107 117 110 119 
+DEAL:4::Cell with center: 0.8750 0.8750 0.6250, owned by 6: 71 72 73 74 117 118 119 120 
+DEAL:4::Cell with center: 0.6250 0.6250 0.8750, owned by 6: 83 97 107 117 92 103 113 121 
+DEAL:4::Cell with center: 0.8750 0.6250 0.8750, owned by 6: 97 98 117 118 103 104 121 122 
+DEAL:4::Cell with center: 0.6250 0.8750 0.8750, owned by 6: 107 117 110 119 113 121 116 123 
+DEAL:4::Cell with center: 0.8750 0.8750 0.8750, owned by 6: 117 118 119 120 121 122 123 124 
+
+
+DEAL:5::Level 0
+DEAL:5::Cell with center: 1.500 0.5000, owned by 3: 1 4 3 5 
+DEAL:5::Level 1
+DEAL:5::Cell with center: 0.7500 0.2500, owned by 0: 1 4 3 5 
+DEAL:5::Cell with center: 0.7500 0.7500, owned by 2: 3 5 7 8 
+DEAL:5::Cell with center: 1.250 0.2500, owned by 3: 4 9 5 10 
+DEAL:5::Cell with center: 1.750 0.2500, owned by 4: 9 11 10 12 
+DEAL:5::Cell with center: 1.250 0.7500, owned by 5: 5 10 8 13 
+DEAL:5::Cell with center: 1.750 0.7500, owned by 6: 10 12 13 14 
+DEAL:5::Level 2
+DEAL:5::Cell with center: 0.8750 0.1250, owned by 1: 9 11 10 12 
+DEAL:5::Cell with center: 0.8750 0.3750, owned by 1: 10 12 13 14 
+DEAL:5::Cell with center: 0.8750 0.6250, owned by 2: 13 14 21 22 
+DEAL:5::Cell with center: 0.8750 0.8750, owned by 3: 21 22 23 24 
+DEAL:5::Cell with center: 1.125 0.1250, owned by 3: 11 25 12 26 
+DEAL:5::Cell with center: 1.375 0.1250, owned by 3: 25 27 26 28 
+DEAL:5::Cell with center: 1.125 0.3750, owned by 4: 12 26 14 29 
+DEAL:5::Cell with center: 1.375 0.3750, owned by 4: 26 28 29 30 
+DEAL:5::Cell with center: 1.625 0.1250, owned by 4: 27 31 28 32 
+DEAL:5::Cell with center: 1.875 0.1250, owned by 4: 31 33 32 34 
+DEAL:5::Cell with center: 1.625 0.3750, owned by 4: 28 32 30 35 
+DEAL:5::Cell with center: 1.875 0.3750, owned by 5: 32 34 35 36 
+DEAL:5::Cell with center: 1.125 0.6250, owned by 5: 14 29 22 37 
+DEAL:5::Cell with center: 1.375 0.6250, owned by 5: 29 30 37 38 
+DEAL:5::Cell with center: 1.125 0.8750, owned by 5: 22 37 24 39 
+DEAL:5::Cell with center: 1.375 0.8750, owned by 6: 37 38 39 40 
+DEAL:5::Cell with center: 1.625 0.6250, owned by 6: 30 35 38 41 
+DEAL:5::Cell with center: 1.875 0.6250, owned by 6: 35 36 41 42 
+DEAL:5::Cell with center: 1.625 0.8750, owned by 6: 38 41 40 43 
+DEAL:5::Level 3
+DEAL:5::Cell with center: 0.9375 0.06250, owned by 1: 31 33 32 34 
+DEAL:5::Cell with center: 0.9375 0.4375, owned by 1: 41 42 43 44 
+DEAL:5::Cell with center: 0.9375 0.5625, owned by 2: 43 44 69 70 
+DEAL:5::Cell with center: 0.9375 0.6875, owned by 2: 69 70 71 72 
+DEAL:5::Cell with center: 0.9375 0.8125, owned by 3: 71 72 77 78 
+DEAL:5::Cell with center: 0.9375 0.9375, owned by 3: 77 78 79 80 
+DEAL:5::Cell with center: 1.062 0.06250, owned by 3: 33 81 34 82 
+DEAL:5::Cell with center: 1.188 0.06250, owned by 3: 81 83 82 84 
+DEAL:5::Cell with center: 1.312 0.06250, owned by 3: 83 87 84 88 
+DEAL:5::Cell with center: 1.062 0.4375, owned by 4: 42 93 44 95 
+DEAL:5::Cell with center: 1.188 0.4375, owned by 4: 93 94 95 96 
+DEAL:5::Cell with center: 1.312 0.4375, owned by 4: 94 97 96 99 
+DEAL:5::Cell with center: 1.438 0.4375, owned by 4: 97 98 99 100 
+DEAL:5::Cell with center: 1.688 0.1875, owned by 4: 102 104 105 106 
+DEAL:5::Cell with center: 1.812 0.1875, owned by 4: 104 108 106 111 
+DEAL:5::Cell with center: 1.938 0.1875, owned by 4: 108 110 111 112 
+DEAL:5::Cell with center: 1.688 0.3125, owned by 4: 105 106 113 114 
+DEAL:5::Cell with center: 1.562 0.4375, owned by 4: 98 113 100 115 
+DEAL:5::Cell with center: 1.688 0.4375, owned by 4: 113 114 115 116 
+DEAL:5::Cell with center: 1.812 0.3125, owned by 5: 106 111 114 117 
+DEAL:5::Cell with center: 1.938 0.3125, owned by 5: 111 112 117 118 
+DEAL:5::Cell with center: 1.812 0.4375, owned by 5: 114 117 116 119 
+DEAL:5::Cell with center: 1.938 0.4375, owned by 5: 117 118 119 120 
+DEAL:5::Cell with center: 1.062 0.5625, owned by 5: 44 95 70 121 
+DEAL:5::Cell with center: 1.188 0.5625, owned by 5: 95 96 121 122 
+DEAL:5::Cell with center: 1.062 0.6875, owned by 5: 70 121 72 123 
+DEAL:5::Cell with center: 1.188 0.6875, owned by 5: 121 122 123 124 
+DEAL:5::Cell with center: 1.312 0.5625, owned by 5: 96 99 122 125 
+DEAL:5::Cell with center: 1.438 0.5625, owned by 5: 99 100 125 126 
+DEAL:5::Cell with center: 1.312 0.6875, owned by 5: 122 125 124 127 
+DEAL:5::Cell with center: 1.438 0.6875, owned by 5: 125 126 127 128 
+DEAL:5::Cell with center: 1.062 0.8125, owned by 5: 72 123 78 129 
+DEAL:5::Cell with center: 1.188 0.8125, owned by 5: 123 124 129 130 
+DEAL:5::Cell with center: 1.062 0.9375, owned by 5: 78 129 80 131 
+DEAL:5::Cell with center: 1.188 0.9375, owned by 5: 129 130 131 132 
+DEAL:5::Cell with center: 1.312 0.8125, owned by 6: 124 127 130 133 
+DEAL:5::Cell with center: 1.438 0.8125, owned by 6: 127 128 133 134 
+DEAL:5::Cell with center: 1.312 0.9375, owned by 6: 130 133 132 135 
+DEAL:5::Cell with center: 1.562 0.5625, owned by 6: 100 115 126 137 
+DEAL:5::Cell with center: 1.688 0.5625, owned by 6: 115 116 137 138 
+DEAL:5::Cell with center: 1.562 0.6875, owned by 6: 126 137 128 139 
+DEAL:5::Cell with center: 1.812 0.5625, owned by 6: 116 119 138 141 
+DEAL:5::Cell with center: 1.938 0.5625, owned by 6: 119 120 141 142 
+DEAL:5::Cell with center: 1.562 0.8125, owned by 6: 128 139 134 145 
+DEAL:5::Level 0
+DEAL:5::Cell with center: 0.5000 0.5000 0.5000, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:5::Level 1
+DEAL:5::Cell with center: 0.2500 0.2500 0.2500, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:5::Cell with center: 0.7500 0.2500 0.2500, owned by 1: 1 8 3 9 5 10 7 11 
+DEAL:5::Cell with center: 0.2500 0.7500 0.2500, owned by 2: 2 3 12 13 6 7 14 15 
+DEAL:5::Cell with center: 0.7500 0.7500 0.2500, owned by 3: 3 9 13 16 7 11 15 17 
+DEAL:5::Cell with center: 0.2500 0.2500 0.7500, owned by 3: 4 5 6 7 18 19 20 21 
+DEAL:5::Cell with center: 0.7500 0.2500 0.7500, owned by 4: 5 10 7 11 19 22 21 23 
+DEAL:5::Cell with center: 0.2500 0.7500 0.7500, owned by 5: 6 7 14 15 20 21 24 25 
+DEAL:5::Cell with center: 0.7500 0.7500 0.7500, owned by 6: 7 11 15 17 21 23 25 26 
+DEAL:5::Level 2
+DEAL:5::Cell with center: 0.1250 0.1250 0.1250, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:5::Cell with center: 0.3750 0.1250 0.1250, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:5::Cell with center: 0.1250 0.3750 0.1250, owned by 0: 2 3 12 13 6 7 14 15 
+DEAL:5::Cell with center: 0.3750 0.3750 0.1250, owned by 0: 3 9 13 16 7 11 15 17 
+DEAL:5::Cell with center: 0.1250 0.1250 0.3750, owned by 0: 4 5 6 7 18 19 20 21 
+DEAL:5::Cell with center: 0.3750 0.1250 0.3750, owned by 0: 5 10 7 11 19 22 21 23 
+DEAL:5::Cell with center: 0.1250 0.3750 0.3750, owned by 0: 6 7 14 15 20 21 24 25 
+DEAL:5::Cell with center: 0.3750 0.3750 0.3750, owned by 0: 7 11 15 17 21 23 25 26 
+DEAL:5::Cell with center: 0.6250 0.1250 0.1250, owned by 1: 8 27 9 28 10 29 11 30 
+DEAL:5::Cell with center: 0.6250 0.3750 0.1250, owned by 1: 9 28 16 35 11 30 17 36 
+DEAL:5::Cell with center: 0.6250 0.1250 0.3750, owned by 1: 10 29 11 30 22 39 23 40 
+DEAL:5::Cell with center: 0.6250 0.3750 0.3750, owned by 1: 11 30 17 36 23 40 26 43 
+DEAL:5::Cell with center: 0.1250 0.6250 0.1250, owned by 2: 12 13 45 46 14 15 47 48 
+DEAL:5::Cell with center: 0.3750 0.6250 0.1250, owned by 2: 13 16 46 49 15 17 48 50 
+DEAL:5::Cell with center: 0.1250 0.8750 0.1250, owned by 2: 45 46 51 52 47 48 53 54 
+DEAL:5::Cell with center: 0.3750 0.8750 0.1250, owned by 2: 46 49 52 55 48 50 54 56 
+DEAL:5::Cell with center: 0.1250 0.6250 0.3750, owned by 2: 14 15 47 48 24 25 57 58 
+DEAL:5::Cell with center: 0.3750 0.6250 0.3750, owned by 2: 15 17 48 50 25 26 58 59 
+DEAL:5::Cell with center: 0.1250 0.8750 0.3750, owned by 2: 47 48 53 54 57 58 60 61 
+DEAL:5::Cell with center: 0.3750 0.8750 0.3750, owned by 2: 48 50 54 56 58 59 61 62 
+DEAL:5::Cell with center: 0.6250 0.6250 0.1250, owned by 3: 16 35 49 63 17 36 50 64 
+DEAL:5::Cell with center: 0.6250 0.8750 0.1250, owned by 3: 49 63 55 67 50 64 56 68 
+DEAL:5::Cell with center: 0.6250 0.6250 0.3750, owned by 3: 17 36 50 64 26 43 59 71 
+DEAL:5::Cell with center: 0.6250 0.8750 0.3750, owned by 3: 50 64 56 68 59 71 62 73 
+DEAL:5::Cell with center: 0.1250 0.1250 0.6250, owned by 3: 18 19 20 21 75 76 77 78 
+DEAL:5::Cell with center: 0.3750 0.1250 0.6250, owned by 3: 19 22 21 23 76 79 78 80 
+DEAL:5::Cell with center: 0.1250 0.3750 0.6250, owned by 3: 20 21 24 25 77 78 81 82 
+DEAL:5::Cell with center: 0.3750 0.3750 0.6250, owned by 3: 21 23 25 26 78 80 82 83 
+DEAL:5::Cell with center: 0.1250 0.1250 0.8750, owned by 3: 75 76 77 78 84 85 86 87 
+DEAL:5::Cell with center: 0.3750 0.1250 0.8750, owned by 3: 76 79 78 80 85 88 87 89 
+DEAL:5::Cell with center: 0.1250 0.3750 0.8750, owned by 3: 77 78 81 82 86 87 90 91 
+DEAL:5::Cell with center: 0.3750 0.3750 0.8750, owned by 3: 78 80 82 83 87 89 91 92 
+DEAL:5::Cell with center: 0.6250 0.1250 0.6250, owned by 4: 22 39 23 40 79 93 80 94 
+DEAL:5::Cell with center: 0.6250 0.3750 0.6250, owned by 4: 23 40 26 43 80 94 83 97 
+DEAL:5::Cell with center: 0.6250 0.1250 0.8750, owned by 4: 79 93 80 94 88 99 89 100 
+DEAL:5::Cell with center: 0.6250 0.3750 0.8750, owned by 4: 80 94 83 97 89 100 92 103 
+DEAL:5::Cell with center: 0.1250 0.6250 0.6250, owned by 5: 24 25 57 58 81 82 105 106 
+DEAL:5::Cell with center: 0.3750 0.6250 0.6250, owned by 5: 25 26 58 59 82 83 106 107 
+DEAL:5::Cell with center: 0.1250 0.8750 0.6250, owned by 5: 57 58 60 61 105 106 108 109 
+DEAL:5::Cell with center: 0.3750 0.8750 0.6250, owned by 5: 58 59 61 62 106 107 109 110 
+DEAL:5::Cell with center: 0.1250 0.6250 0.8750, owned by 5: 81 82 105 106 90 91 111 112 
+DEAL:5::Cell with center: 0.3750 0.6250 0.8750, owned by 5: 82 83 106 107 91 92 112 113 
+DEAL:5::Cell with center: 0.1250 0.8750 0.8750, owned by 5: 105 106 108 109 111 112 114 115 
+DEAL:5::Cell with center: 0.3750 0.8750 0.8750, owned by 5: 106 107 109 110 112 113 115 116 
+DEAL:5::Cell with center: 0.6250 0.6250 0.6250, owned by 6: 26 43 59 71 83 97 107 117 
+DEAL:5::Cell with center: 0.6250 0.8750 0.6250, owned by 6: 59 71 62 73 107 117 110 119 
+DEAL:5::Cell with center: 0.6250 0.6250 0.8750, owned by 6: 83 97 107 117 92 103 113 121 
+DEAL:5::Cell with center: 0.6250 0.8750 0.8750, owned by 6: 107 117 110 119 113 121 116 123 
+
+
+DEAL:6::Level 0
+DEAL:6::Cell with center: 1.500 0.5000, owned by 3: 1 4 3 5 
+DEAL:6::Level 1
+DEAL:6::Cell with center: 1.250 0.2500, owned by 3: 4 9 5 10 
+DEAL:6::Cell with center: 1.750 0.2500, owned by 4: 9 11 10 12 
+DEAL:6::Cell with center: 1.250 0.7500, owned by 5: 5 10 8 13 
+DEAL:6::Cell with center: 1.750 0.7500, owned by 6: 10 12 13 14 
+DEAL:6::Level 2
+DEAL:6::Cell with center: 1.125 0.1250, owned by 3: 11 25 12 26 
+DEAL:6::Cell with center: 1.375 0.1250, owned by 3: 25 27 26 28 
+DEAL:6::Cell with center: 1.375 0.3750, owned by 4: 26 28 29 30 
+DEAL:6::Cell with center: 1.625 0.1250, owned by 4: 27 31 28 32 
+DEAL:6::Cell with center: 1.875 0.1250, owned by 4: 31 33 32 34 
+DEAL:6::Cell with center: 1.625 0.3750, owned by 4: 28 32 30 35 
+DEAL:6::Cell with center: 1.875 0.3750, owned by 5: 32 34 35 36 
+DEAL:6::Cell with center: 1.125 0.6250, owned by 5: 14 29 22 37 
+DEAL:6::Cell with center: 1.375 0.6250, owned by 5: 29 30 37 38 
+DEAL:6::Cell with center: 1.125 0.8750, owned by 5: 22 37 24 39 
+DEAL:6::Cell with center: 1.375 0.8750, owned by 6: 37 38 39 40 
+DEAL:6::Cell with center: 1.625 0.6250, owned by 6: 30 35 38 41 
+DEAL:6::Cell with center: 1.875 0.6250, owned by 6: 35 36 41 42 
+DEAL:6::Cell with center: 1.625 0.8750, owned by 6: 38 41 40 43 
+DEAL:6::Cell with center: 1.875 0.8750, owned by 6: 41 42 43 44 
+DEAL:6::Level 3
+DEAL:6::Cell with center: 1.188 0.06250, owned by 3: 81 83 82 84 
+DEAL:6::Cell with center: 1.312 0.06250, owned by 3: 83 87 84 88 
+DEAL:6::Cell with center: 1.438 0.06250, owned by 3: 87 89 88 90 
+DEAL:6::Cell with center: 1.438 0.4375, owned by 4: 97 98 99 100 
+DEAL:6::Cell with center: 1.562 0.06250, owned by 4: 89 101 90 102 
+DEAL:6::Cell with center: 1.688 0.06250, owned by 4: 101 103 102 104 
+DEAL:6::Cell with center: 1.812 0.06250, owned by 4: 103 107 104 108 
+DEAL:6::Cell with center: 1.938 0.06250, owned by 4: 107 109 108 110 
+DEAL:6::Cell with center: 1.562 0.4375, owned by 4: 98 113 100 115 
+DEAL:6::Cell with center: 1.688 0.4375, owned by 4: 113 114 115 116 
+DEAL:6::Cell with center: 1.812 0.4375, owned by 5: 114 117 116 119 
+DEAL:6::Cell with center: 1.938 0.4375, owned by 5: 117 118 119 120 
+DEAL:6::Cell with center: 1.188 0.6875, owned by 5: 121 122 123 124 
+DEAL:6::Cell with center: 1.438 0.5625, owned by 5: 99 100 125 126 
+DEAL:6::Cell with center: 1.312 0.6875, owned by 5: 122 125 124 127 
+DEAL:6::Cell with center: 1.438 0.6875, owned by 5: 125 126 127 128 
+DEAL:6::Cell with center: 1.188 0.8125, owned by 5: 123 124 129 130 
+DEAL:6::Cell with center: 1.188 0.9375, owned by 5: 129 130 131 132 
+DEAL:6::Cell with center: 1.312 0.8125, owned by 6: 124 127 130 133 
+DEAL:6::Cell with center: 1.438 0.8125, owned by 6: 127 128 133 134 
+DEAL:6::Cell with center: 1.312 0.9375, owned by 6: 130 133 132 135 
+DEAL:6::Cell with center: 1.438 0.9375, owned by 6: 133 134 135 136 
+DEAL:6::Cell with center: 1.562 0.5625, owned by 6: 100 115 126 137 
+DEAL:6::Cell with center: 1.688 0.5625, owned by 6: 115 116 137 138 
+DEAL:6::Cell with center: 1.562 0.6875, owned by 6: 126 137 128 139 
+DEAL:6::Cell with center: 1.688 0.6875, owned by 6: 137 138 139 140 
+DEAL:6::Cell with center: 1.812 0.5625, owned by 6: 116 119 138 141 
+DEAL:6::Cell with center: 1.938 0.5625, owned by 6: 119 120 141 142 
+DEAL:6::Cell with center: 1.812 0.6875, owned by 6: 138 141 140 143 
+DEAL:6::Cell with center: 1.938 0.6875, owned by 6: 141 142 143 144 
+DEAL:6::Cell with center: 1.562 0.8125, owned by 6: 128 139 134 145 
+DEAL:6::Cell with center: 1.688 0.8125, owned by 6: 139 140 145 146 
+DEAL:6::Cell with center: 1.562 0.9375, owned by 6: 134 145 136 147 
+DEAL:6::Cell with center: 1.688 0.9375, owned by 6: 145 146 147 148 
+DEAL:6::Cell with center: 1.812 0.8125, owned by 6: 140 143 146 149 
+DEAL:6::Cell with center: 1.938 0.8125, owned by 6: 143 144 149 150 
+DEAL:6::Cell with center: 1.812 0.9375, owned by 6: 146 149 148 151 
+DEAL:6::Cell with center: 1.938 0.9375, owned by 6: 149 150 151 152 
+DEAL:6::Level 0
+DEAL:6::Cell with center: 0.5000 0.5000 0.5000, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:6::Level 1
+DEAL:6::Cell with center: 0.2500 0.2500 0.2500, owned by 0: 0 1 2 3 4 5 6 7 
+DEAL:6::Cell with center: 0.7500 0.2500 0.2500, owned by 1: 1 8 3 9 5 10 7 11 
+DEAL:6::Cell with center: 0.2500 0.7500 0.2500, owned by 2: 2 3 12 13 6 7 14 15 
+DEAL:6::Cell with center: 0.7500 0.7500 0.2500, owned by 3: 3 9 13 16 7 11 15 17 
+DEAL:6::Cell with center: 0.2500 0.2500 0.7500, owned by 3: 4 5 6 7 18 19 20 21 
+DEAL:6::Cell with center: 0.7500 0.2500 0.7500, owned by 4: 5 10 7 11 19 22 21 23 
+DEAL:6::Cell with center: 0.2500 0.7500 0.7500, owned by 5: 6 7 14 15 20 21 24 25 
+DEAL:6::Cell with center: 0.7500 0.7500 0.7500, owned by 6: 7 11 15 17 21 23 25 26 
+DEAL:6::Level 2
+DEAL:6::Cell with center: 0.3750 0.1250 0.1250, owned by 0: 1 8 3 9 5 10 7 11 
+DEAL:6::Cell with center: 0.3750 0.3750 0.1250, owned by 0: 3 9 13 16 7 11 15 17 
+DEAL:6::Cell with center: 0.3750 0.1250 0.3750, owned by 0: 5 10 7 11 19 22 21 23 
+DEAL:6::Cell with center: 0.3750 0.3750 0.3750, owned by 0: 7 11 15 17 21 23 25 26 
+DEAL:6::Cell with center: 0.6250 0.1250 0.1250, owned by 1: 8 27 9 28 10 29 11 30 
+DEAL:6::Cell with center: 0.8750 0.1250 0.1250, owned by 1: 27 31 28 32 29 33 30 34 
+DEAL:6::Cell with center: 0.6250 0.3750 0.1250, owned by 1: 9 28 16 35 11 30 17 36 
+DEAL:6::Cell with center: 0.8750 0.3750 0.1250, owned by 1: 28 32 35 37 30 34 36 38 
+DEAL:6::Cell with center: 0.6250 0.1250 0.3750, owned by 1: 10 29 11 30 22 39 23 40 
+DEAL:6::Cell with center: 0.8750 0.1250 0.3750, owned by 1: 29 33 30 34 39 41 40 42 
+DEAL:6::Cell with center: 0.6250 0.3750 0.3750, owned by 1: 11 30 17 36 23 40 26 43 
+DEAL:6::Cell with center: 0.8750 0.3750 0.3750, owned by 1: 30 34 36 38 40 42 43 44 
+DEAL:6::Cell with center: 0.3750 0.6250 0.1250, owned by 2: 13 16 46 49 15 17 48 50 
+DEAL:6::Cell with center: 0.3750 0.8750 0.1250, owned by 2: 46 49 52 55 48 50 54 56 
+DEAL:6::Cell with center: 0.3750 0.6250 0.3750, owned by 2: 15 17 48 50 25 26 58 59 
+DEAL:6::Cell with center: 0.3750 0.8750 0.3750, owned by 2: 48 50 54 56 58 59 61 62 
+DEAL:6::Cell with center: 0.6250 0.6250 0.1250, owned by 3: 16 35 49 63 17 36 50 64 
+DEAL:6::Cell with center: 0.8750 0.6250 0.1250, owned by 3: 35 37 63 65 36 38 64 66 
+DEAL:6::Cell with center: 0.6250 0.8750 0.1250, owned by 3: 49 63 55 67 50 64 56 68 
+DEAL:6::Cell with center: 0.8750 0.8750 0.1250, owned by 3: 63 65 67 69 64 66 68 70 
+DEAL:6::Cell with center: 0.6250 0.6250 0.3750, owned by 3: 17 36 50 64 26 43 59 71 
+DEAL:6::Cell with center: 0.8750 0.6250 0.3750, owned by 3: 36 38 64 66 43 44 71 72 
+DEAL:6::Cell with center: 0.6250 0.8750 0.3750, owned by 3: 50 64 56 68 59 71 62 73 
+DEAL:6::Cell with center: 0.8750 0.8750 0.3750, owned by 3: 64 66 68 70 71 72 73 74 
+DEAL:6::Cell with center: 0.3750 0.1250 0.6250, owned by 3: 19 22 21 23 76 79 78 80 
+DEAL:6::Cell with center: 0.3750 0.3750 0.6250, owned by 3: 21 23 25 26 78 80 82 83 
+DEAL:6::Cell with center: 0.3750 0.1250 0.8750, owned by 3: 76 79 78 80 85 88 87 89 
+DEAL:6::Cell with center: 0.3750 0.3750 0.8750, owned by 3: 78 80 82 83 87 89 91 92 
+DEAL:6::Cell with center: 0.6250 0.1250 0.6250, owned by 4: 22 39 23 40 79 93 80 94 
+DEAL:6::Cell with center: 0.8750 0.1250 0.6250, owned by 4: 39 41 40 42 93 95 94 96 
+DEAL:6::Cell with center: 0.6250 0.3750 0.6250, owned by 4: 23 40 26 43 80 94 83 97 
+DEAL:6::Cell with center: 0.8750 0.3750 0.6250, owned by 4: 40 42 43 44 94 96 97 98 
+DEAL:6::Cell with center: 0.6250 0.1250 0.8750, owned by 4: 79 93 80 94 88 99 89 100 
+DEAL:6::Cell with center: 0.8750 0.1250 0.8750, owned by 4: 93 95 94 96 99 101 100 102 
+DEAL:6::Cell with center: 0.6250 0.3750 0.8750, owned by 4: 80 94 83 97 89 100 92 103 
+DEAL:6::Cell with center: 0.8750 0.3750 0.8750, owned by 4: 94 96 97 98 100 102 103 104 
+DEAL:6::Cell with center: 0.3750 0.6250 0.6250, owned by 5: 25 26 58 59 82 83 106 107 
+DEAL:6::Cell with center: 0.3750 0.8750 0.6250, owned by 5: 58 59 61 62 106 107 109 110 
+DEAL:6::Cell with center: 0.3750 0.6250 0.8750, owned by 5: 82 83 106 107 91 92 112 113 
+DEAL:6::Cell with center: 0.3750 0.8750 0.8750, owned by 5: 106 107 109 110 112 113 115 116 
+DEAL:6::Cell with center: 0.6250 0.6250 0.6250, owned by 6: 26 43 59 71 83 97 107 117 
+DEAL:6::Cell with center: 0.8750 0.6250 0.6250, owned by 6: 43 44 71 72 97 98 117 118 
+DEAL:6::Cell with center: 0.6250 0.8750 0.6250, owned by 6: 59 71 62 73 107 117 110 119 
+DEAL:6::Cell with center: 0.8750 0.8750 0.6250, owned by 6: 71 72 73 74 117 118 119 120 
+DEAL:6::Cell with center: 0.6250 0.6250 0.8750, owned by 6: 83 97 107 117 92 103 113 121 
+DEAL:6::Cell with center: 0.8750 0.6250 0.8750, owned by 6: 97 98 117 118 103 104 121 122 
+DEAL:6::Cell with center: 0.6250 0.8750 0.8750, owned by 6: 107 117 110 119 113 121 116 123 
+DEAL:6::Cell with center: 0.8750 0.8750 0.8750, owned by 6: 117 118 119 120 121 122 123 124 
+

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.