]> https://gitweb.dealii.org/ - dealii.git/commitdiff
MF: No special treatment of cells close to proc interface 9683/head
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Thu, 19 Mar 2020 14:00:38 +0000 (15:00 +0100)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Wed, 8 Apr 2020 05:22:18 +0000 (07:22 +0200)
include/deal.II/matrix_free/face_setup_internal.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/matrix_free/task_info.h
source/matrix_free/task_info.cc
tests/matrix_free/cell_categorization.with_p4est=true.mpirun=7.output
tests/matrix_free/cell_categorization.with_p4est=true.mpirun=7.output.avx
tests/matrix_free/cell_categorization.with_p4est=true.mpirun=7.output.avx512
tests/matrix_free/cell_categorization.with_p4est=true.mpirun=7.output.novec
tests/matrix_free/dg_pbc_02.with_mpi=true.with_p4est=true.mpirun=7.output
tests/matrix_free/dg_pbc_02.with_mpi=true.with_p4est=true.mpirun=7.output.avx
tests/matrix_free/dg_pbc_02.with_mpi=true.with_p4est=true.mpirun=7.output.avx512

index 2e8c7d3c22b8d46d13f33b1ec8cde7fe89aaaf2f..b019cd3cc4847a0bbf41be0663db33174891aacf 100644 (file)
@@ -131,7 +131,6 @@ namespace internal
 
       std::vector<FaceCategory>          face_is_owned;
       std::vector<bool>                  at_processor_boundary;
-      std::vector<unsigned int>          cells_close_to_boundary;
       std::vector<FaceToCellTopology<1>> inner_faces;
       std::vector<FaceToCellTopology<1>> boundary_faces;
       std::vector<FaceToCellTopology<1>> inner_ghost_faces;
@@ -190,7 +189,6 @@ namespace internal
       // interesting
 
       at_processor_boundary.resize(cell_levels.size(), false);
-      cells_close_to_boundary.clear();
       face_is_owned.resize(dim > 1 ? triangulation.n_raw_faces() :
                                      triangulation.n_vertices(),
                            FaceCategory::locally_active_done_elsewhere);
@@ -655,12 +653,7 @@ namespace internal
                                         neighbor->level_subdomain_id());
                     }
                   else if (additional_data.hold_all_faces_to_owned_cells ==
-                           false)
-                    {
-                      // mark the cell to be close to the boundary
-                      cells_close_to_boundary.emplace_back(i);
-                    }
-                  else
+                           true)
                     {
                       // add all cells to ghost layer...
                       face_is_owned[dcell->face(f)->index()] =
@@ -730,18 +723,6 @@ namespace internal
       // cells
       for (const auto &ghost_cell : ghost_cells)
         cell_levels.push_back(ghost_cell);
-
-      // step 3: clean up the cells close to the boundary
-      std::sort(cells_close_to_boundary.begin(), cells_close_to_boundary.end());
-      cells_close_to_boundary.erase(std::unique(cells_close_to_boundary.begin(),
-                                                cells_close_to_boundary.end()),
-                                    cells_close_to_boundary.end());
-      std::vector<unsigned int> final_cells;
-      final_cells.reserve(cells_close_to_boundary.size());
-      for (const unsigned int cell : cells_close_to_boundary)
-        if (at_processor_boundary[cell] == false)
-          final_cells.push_back(cell);
-      cells_close_to_boundary = std::move(final_cells);
     }
 
 
index fc0b4670edbfe18e4b684dd752630a4dac6cbb4e..3f973f263c87778335bf0af78e5be75ec0ba4551 100644 (file)
@@ -453,8 +453,7 @@ MatrixFree<dim, Number, VectorizedArrayType>::internal_reinit(
                                        cell_level_index.size(),
                                        VectorizedArrayType::size(),
                                        dummy);
-      task_info.create_blocks_serial(
-        dummy, dummy, 1, dummy, false, dummy, dummy2);
+      task_info.create_blocks_serial(dummy, 1, dummy, false, dummy, dummy2);
       for (unsigned int i = 0; i < dof_info.size(); ++i)
         {
           dof_info[i].dimension = dim;
@@ -623,8 +622,7 @@ MatrixFree<dim, Number, VectorizedArrayType>::internal_reinit(
                                        cell_level_index.size(),
                                        VectorizedArrayType::size(),
                                        dummy);
-      task_info.create_blocks_serial(
-        dummy, dummy, 1, dummy, false, dummy, dummy2);
+      task_info.create_blocks_serial(dummy, 1, dummy, false, dummy, dummy2);
       for (unsigned int i = 0; i < dof_info.size(); ++i)
         {
           Assert(dof_handler[i]->get_fe_collection().size() == 1,
@@ -1193,7 +1191,6 @@ MatrixFree<dim, Number, VectorizedArrayType>::initialize_indices(
       for (const auto &info : dof_info)
         dofs_per_cell = std::max(dofs_per_cell, info.dofs_per_cell[0]);
       task_info.create_blocks_serial(subdomain_boundary_cells,
-                                     face_setup.cells_close_to_boundary,
                                      dofs_per_cell,
                                      dof_info[0].cell_active_fe_index,
                                      strict_categories,
index 51a233f1ead4a95723fb3a5fc2cc15a981b52a34..12ad101c93eb34adbbdc53c163ce28f39ed1ffb8 100644 (file)
@@ -156,10 +156,6 @@ namespace internal
        * to performing computations. These will be given a certain id in the
        * partitioning.
        *
-       * @param cells_close_to_boundary A list of cells that interact with
-       * boundaries between different subdomains and are involved in sending
-       * data to neighboring processes.
-       *
        * @param dofs_per_cell Gives an expected value for the number of degrees
        * of freedom on a cell, which is used to determine the block size for
        * interleaving cell and face integrals.
@@ -187,7 +183,6 @@ namespace internal
       void
       create_blocks_serial(
         const std::vector<unsigned int> &boundary_cells,
-        const std::vector<unsigned int> &cells_close_to_boundary,
         const unsigned int               dofs_per_cell,
         const std::vector<unsigned int> &cell_vectorization_categories,
         const bool                       cell_vectorization_categories_strict,
index 9cf2d3f1a1dbba2f34382000e5536631e9b1b1fa..0e8b5c729e6de5e46f22f829c55f2583e056883e 100644 (file)
@@ -774,7 +774,6 @@ namespace internal
     void
     TaskInfo ::create_blocks_serial(
       const std::vector<unsigned int> &boundary_cells,
-      const std::vector<unsigned int> &cells_close_to_boundary,
       const unsigned int               dofs_per_cell,
       const std::vector<unsigned int> &cell_vectorization_categories,
       const bool                       cell_vectorization_categories_strict,
@@ -813,14 +812,7 @@ namespace internal
             ((n_active_cells - n_boundary_cells) / 2 / vectorization_length) *
             vectorization_length;
           unsigned int count = 0;
-          for (const unsigned int cell : cells_close_to_boundary)
-            if (cell_marked[cell] == 0)
-              {
-                cell_marked[cell] = count < n_second_slot ? 1 : 3;
-                ++count;
-              }
-
-          unsigned int c = 0;
+          unsigned int c     = 0;
           for (; c < n_active_cells && count < n_second_slot; ++c)
             if (cell_marked[c] == 0)
               {
@@ -877,15 +869,8 @@ namespace internal
           incompletely_filled_vectorization.resize(
             incompletely_filled_vectorization.size() + 4 * n_categories);
         }
-      else if (cells_close_to_boundary.empty())
-        tight_category_map.resize(n_active_cells + n_ghost_cells, 0);
       else
-        {
-          n_categories = 2;
-          tight_category_map.resize(n_active_cells + n_ghost_cells, 1);
-          for (const unsigned int cell : cells_close_to_boundary)
-            tight_category_map[cell] = 0;
-        }
+        tight_category_map.resize(n_active_cells + n_ghost_cells, 0);
 
       cell_partition_data.clear();
       cell_partition_data.resize(1, 0);
index cbbe5af38c301c51fdb81ec0bf6766f80d143f86..47dc078ecbc4e5fea56978239533d29d28f5af6a 100644 (file)
@@ -11,15 +11,15 @@ DEAL:0::0_5:00103 with 0
 DEAL:0::0_4:0011 with 0
 DEAL:0::0_4:0012 with 0
 DEAL:0::0_4:0020 with 1
-DEAL:0::0_4:0021 with 1
-DEAL:0::0_3:012 with 1
 DEAL:0::0_4:0013 with 1
 DEAL:0::0_5:00220 with 2
 DEAL:0::0_5:00221 with 2
 DEAL:0::0_6:002220 with 2
-DEAL:0::0_3:013 with 2
-DEAL:0::0_3:022 with 4
-DEAL:0::0_6:002221 with 4
+DEAL:0::0_6:002221 with 2
+DEAL:0::0_6:002222 with 2
+DEAL:0::0_6:002223 with 2
+DEAL:0::0_5:00223 with 2
+DEAL:0::0_4:0021 with 2
 DEAL:0::0_4:0110 with 0
 DEAL:0::0_4:0111 with 0
 DEAL:0::0_4:0211 with 2
@@ -28,10 +28,9 @@ DEAL:0::0_4:0212 with 3
 DEAL:0::0_4:0213 with 3
 DEAL:0::0_3:010 with 0
 DEAL:0::0_4:0030 with 1
+DEAL:0::0_4:0031 with 1
+DEAL:0::0_3:012 with 1
 DEAL:0::0_4:0112 with 1
-DEAL:0::0_6:002222 with 2
-DEAL:0::0_6:002223 with 2
-DEAL:0::0_5:00223 with 2
 DEAL:0::0_4:0023 with 2
 DEAL:0::0_4:0032 with 2
 DEAL:0::0_4:0033 with 2
@@ -43,10 +42,11 @@ DEAL:0::0_5:02010 with 2
 DEAL:0::0_5:02011 with 2
 DEAL:0::0_5:02012 with 2
 DEAL:0::0_5:02013 with 2
-DEAL:0::0_4:0210 with 2
-DEAL:0::0_4:0031 with 2
+DEAL:0::0_3:013 with 2
 DEAL:0::0_4:0202 with 3
-DEAL:0::0_4:0203 with 3
+DEAL:0::0_4:0210 with 3
+DEAL:0::0_3:022 with 4
+DEAL:0::0_4:0203 with 4
 DEAL:0::
 DEAL:0::Number of cell batches: 26
 DEAL:0::0_4:0000 with 0
@@ -62,13 +62,13 @@ DEAL:0::0_4:0012 with 0
 DEAL:0::0_4:0013 with 0
 DEAL:0::0_4:0020 with 1
 DEAL:0::0_4:0021 with 1
-DEAL:0::0_3:012 with 1
-DEAL:0::0_3:013 with 1
 DEAL:0::0_5:00220 with 2
 DEAL:0::0_5:00221 with 2
 DEAL:0::0_6:002220 with 2
 DEAL:0::0_6:002221 with 2
-DEAL:0::0_3:022 with 4
+DEAL:0::0_6:002222 with 2
+DEAL:0::0_6:002223 with 2
+DEAL:0::0_5:00223 with 2
 DEAL:0::0_4:0110 with 0
 DEAL:0::0_4:0111 with 0
 DEAL:0::0_4:0113 with 0
@@ -79,9 +79,8 @@ DEAL:0::0_3:010 with 0
 DEAL:0::0_4:0112 with 0
 DEAL:0::0_4:0030 with 1
 DEAL:0::0_4:0031 with 1
-DEAL:0::0_6:002222 with 2
-DEAL:0::0_6:002223 with 2
-DEAL:0::0_5:00223 with 2
+DEAL:0::0_3:012 with 1
+DEAL:0::0_3:013 with 1
 DEAL:0::0_4:0023 with 2
 DEAL:0::0_4:0032 with 2
 DEAL:0::0_4:0033 with 2
@@ -96,6 +95,7 @@ DEAL:0::0_5:02013 with 2
 DEAL:0::0_4:0210 with 2
 DEAL:0::0_4:0202 with 3
 DEAL:0::0_4:0203 with 3
+DEAL:0::0_3:022 with 4
 DEAL:0::
 DEAL:0::Number of cell batches: 24
 DEAL:0::0_4:0000 with 100000000
@@ -115,18 +115,15 @@ DEAL:0::0_5:00220 with 100000000
 DEAL:0::0_5:00221 with 100000000
 DEAL:0::0_6:002220 with 100000000
 DEAL:0::0_6:002221 with 100000000
-DEAL:0::0_3:012 with 100000000
-DEAL:0::0_3:013 with 100000000
-DEAL:0::0_3:022 with 100000000
+DEAL:0::0_6:002222 with 100000000
+DEAL:0::0_6:002223 with 100000000
+DEAL:0::0_5:00223 with 100000000
 DEAL:0::0_4:0110 with 100000000
 DEAL:0::0_4:0111 with 100000000
 DEAL:0::0_4:0113 with 100000000
 DEAL:0::0_4:0211 with 100000000
 DEAL:0::0_4:0212 with 100000000
 DEAL:0::0_4:0213 with 100000000
-DEAL:0::0_6:002222 with 100000000
-DEAL:0::0_6:002223 with 100000000
-DEAL:0::0_5:00223 with 100000000
 DEAL:0::0_4:0023 with 100000000
 DEAL:0::0_4:0030 with 100000000
 DEAL:0::0_4:0031 with 100000000
@@ -134,6 +131,8 @@ DEAL:0::0_4:0032 with 100000000
 DEAL:0::0_4:0033 with 100000000
 DEAL:0::0_3:010 with 100000000
 DEAL:0::0_4:0112 with 100000000
+DEAL:0::0_3:012 with 100000000
+DEAL:0::0_3:013 with 100000000
 DEAL:0::0_5:02000 with 100000000
 DEAL:0::0_5:02001 with 100000000
 DEAL:0::0_5:02002 with 100000000
@@ -145,12 +144,13 @@ DEAL:0::0_5:02013 with 100000000
 DEAL:0::0_4:0202 with 100000000
 DEAL:0::0_4:0203 with 100000000
 DEAL:0::0_4:0210 with 100000000
+DEAL:0::0_3:022 with 100000000
 DEAL:0::
 DEAL:0::Number of cell batches: 8
 DEAL:0::0_3:000 with 0
 DEAL:0::0_3:001 with 0
-DEAL:0::0_2:03 with 3
-DEAL:0::0_2:07 with 3
+DEAL:0::0_3:002 with 1
+DEAL:0::0_3:003 with 1
 DEAL:0::0_3:007 with 1
 DEAL:0::0_2:01 with 1
 DEAL:0::0_2:04 with 1
@@ -158,16 +158,16 @@ DEAL:0::0_2:05 with 1
 DEAL:0::0_2:02 with 3
 DEAL:0::0_2:06 with 3
 DEAL:0::0_3:004 with 0
-DEAL:0::0_3:002 with 1
-DEAL:0::0_3:003 with 1
 DEAL:0::0_3:006 with 1
 DEAL:0::0_3:005 with 1
+DEAL:0::0_2:03 with 3
+DEAL:0::0_2:07 with 3
 DEAL:0::
 DEAL:0::Number of cell batches: 8
 DEAL:0::0_3:000 with 0
 DEAL:0::0_3:001 with 0
-DEAL:0::0_2:03 with 3
-DEAL:0::0_2:07 with 3
+DEAL:0::0_3:002 with 1
+DEAL:0::0_3:003 with 1
 DEAL:0::0_3:007 with 1
 DEAL:0::0_2:01 with 1
 DEAL:0::0_2:04 with 1
@@ -176,26 +176,26 @@ DEAL:0::0_2:02 with 3
 DEAL:0::0_2:06 with 3
 DEAL:0::0_3:004 with 0
 DEAL:0::0_3:005 with 0
-DEAL:0::0_3:002 with 1
-DEAL:0::0_3:003 with 1
 DEAL:0::0_3:006 with 1
+DEAL:0::0_2:03 with 3
+DEAL:0::0_2:07 with 3
 DEAL:0::
 DEAL:0::Number of cell batches: 8
 DEAL:0::0_3:000 with 100000000
 DEAL:0::0_3:001 with 100000000
-DEAL:0::0_2:03 with 100000000
-DEAL:0::0_2:07 with 100000000
+DEAL:0::0_3:002 with 100000000
+DEAL:0::0_3:003 with 100000000
 DEAL:0::0_3:007 with 100000000
 DEAL:0::0_2:01 with 100000000
 DEAL:0::0_2:02 with 100000000
 DEAL:0::0_2:04 with 100000000
 DEAL:0::0_2:05 with 100000000
 DEAL:0::0_2:06 with 100000000
-DEAL:0::0_3:002 with 100000000
-DEAL:0::0_3:003 with 100000000
 DEAL:0::0_3:004 with 100000000
 DEAL:0::0_3:005 with 100000000
 DEAL:0::0_3:006 with 100000000
+DEAL:0::0_2:03 with 100000000
+DEAL:0::0_2:07 with 100000000
 DEAL:0::
 
 DEAL:1::Number of cell batches: 24
@@ -211,8 +211,8 @@ DEAL:1::0_3:032 with 4
 DEAL:1::0_3:033 with 4
 DEAL:1::0_3:123 with 4
 DEAL:1::0_3:132 with 4
-DEAL:1::0_3:213 with 6
-DEAL:1::0_4:2002 with 6
+DEAL:1::0_4:2002 with 5
+DEAL:1::0_4:2003 with 5
 DEAL:1::0_3:102 with 1
 DEAL:1::0_3:101 with 1
 DEAL:1::0_4:0310 with 2
@@ -231,11 +231,11 @@ DEAL:1::0_4:2032 with 7
 DEAL:1::0_4:2033 with 7
 DEAL:1::0_4:2122 with 7
 DEAL:1::0_4:2123 with 7
-DEAL:1::0_4:2003 with 5
 DEAL:1::0_4:2010 with 5
 DEAL:1::0_4:2011 with 5
 DEAL:1::0_4:2012 with 5
 DEAL:1::0_4:2013 with 5
+DEAL:1::0_3:210 with 5
 DEAL:1::0_4:2020 with 6
 DEAL:1::0_4:2021 with 6
 DEAL:1::0_5:20300 with 6
@@ -245,9 +245,9 @@ DEAL:1::0_5:20303 with 6
 DEAL:1::0_4:2031 with 6
 DEAL:1::0_4:2120 with 6
 DEAL:1::0_4:2121 with 6
-DEAL:1::0_3:210 with 6
+DEAL:1::0_3:213 with 6
 DEAL:1::
-DEAL:1::Number of cell batches: 28
+DEAL:1::Number of cell batches: 27
 DEAL:1::0_3:100 with 0
 DEAL:1::0_3:103 with 1
 DEAL:1::0_2:11 with 1
@@ -261,7 +261,7 @@ DEAL:1::0_3:033 with 4
 DEAL:1::0_3:123 with 4
 DEAL:1::0_3:132 with 4
 DEAL:1::0_4:2002 with 5
-DEAL:1::0_3:213 with 6
+DEAL:1::0_4:2003 with 5
 DEAL:1::0_3:101 with 0
 DEAL:1::0_3:102 with 1
 DEAL:1::0_4:0310 with 2
@@ -280,7 +280,6 @@ DEAL:1::0_4:2032 with 7
 DEAL:1::0_4:2033 with 7
 DEAL:1::0_4:2122 with 7
 DEAL:1::0_4:2123 with 7
-DEAL:1::0_4:2003 with 5
 DEAL:1::0_4:2010 with 5
 DEAL:1::0_4:2011 with 5
 DEAL:1::0_4:2012 with 5
@@ -295,6 +294,7 @@ DEAL:1::0_5:20303 with 6
 DEAL:1::0_4:2031 with 6
 DEAL:1::0_4:2120 with 6
 DEAL:1::0_4:2121 with 6
+DEAL:1::0_3:213 with 6
 DEAL:1::
 DEAL:1::Number of cell batches: 24
 DEAL:1::0_4:0312 with 100000000
@@ -310,7 +310,7 @@ DEAL:1::0_3:123 with 100000000
 DEAL:1::0_3:130 with 100000000
 DEAL:1::0_3:132 with 100000000
 DEAL:1::0_4:2002 with 100000000
-DEAL:1::0_3:213 with 100000000
+DEAL:1::0_4:2003 with 100000000
 DEAL:1::0_3:023 with 100000000
 DEAL:1::0_3:030 with 100000000
 DEAL:1::0_4:0310 with 100000000
@@ -329,7 +329,6 @@ DEAL:1::0_4:2033 with 100000000
 DEAL:1::0_3:211 with 100000000
 DEAL:1::0_4:2122 with 100000000
 DEAL:1::0_4:2123 with 100000000
-DEAL:1::0_4:2003 with 100000000
 DEAL:1::0_4:2010 with 100000000
 DEAL:1::0_4:2011 with 100000000
 DEAL:1::0_4:2012 with 100000000
@@ -344,12 +343,13 @@ DEAL:1::0_4:2031 with 100000000
 DEAL:1::0_3:210 with 100000000
 DEAL:1::0_4:2120 with 100000000
 DEAL:1::0_4:2121 with 100000000
+DEAL:1::0_3:213 with 100000000
 DEAL:1::
 DEAL:1::Number of cell batches: 12
 DEAL:1::0_2:20 with 6
 DEAL:1::0_2:10 with 6
-DEAL:1::0_2:36 with 8
-DEAL:1::0_2:34 with 8
+DEAL:1::0_2:22 with 8
+DEAL:1::0_2:23 with 8
 DEAL:1::0_2:11 with 1
 DEAL:1::0_2:14 with 1
 DEAL:1::0_2:12 with 3
@@ -366,16 +366,16 @@ DEAL:1::0_2:26 with 8
 DEAL:1::0_2:27 with 8
 DEAL:1::0_2:33 with 8
 DEAL:1::0_2:37 with 8
-DEAL:1::0_2:22 with 8
-DEAL:1::0_2:23 with 8
+DEAL:1::0_2:30 with 6
+DEAL:1::0_2:34 with 6
 DEAL:1::0_2:32 with 8
-DEAL:1::0_2:30 with 8
+DEAL:1::0_2:36 with 8
 DEAL:1::
-DEAL:1::Number of cell batches: 15
+DEAL:1::Number of cell batches: 14
 DEAL:1::0_2:10 with 1
 DEAL:1::0_2:20 with 6
-DEAL:1::0_2:34 with 6
-DEAL:1::0_2:36 with 8
+DEAL:1::0_2:22 with 8
+DEAL:1::0_2:23 with 8
 DEAL:1::0_2:11 with 1
 DEAL:1::0_2:14 with 1
 DEAL:1::0_2:15 with 1
@@ -393,15 +393,15 @@ DEAL:1::0_2:27 with 8
 DEAL:1::0_2:33 with 8
 DEAL:1::0_2:37 with 8
 DEAL:1::0_2:30 with 6
-DEAL:1::0_2:22 with 8
-DEAL:1::0_2:23 with 8
+DEAL:1::0_2:34 with 6
 DEAL:1::0_2:32 with 8
+DEAL:1::0_2:36 with 8
 DEAL:1::
 DEAL:1::Number of cell batches: 12
 DEAL:1::0_2:10 with 100000000
 DEAL:1::0_2:20 with 100000000
-DEAL:1::0_2:34 with 100000000
-DEAL:1::0_2:36 with 100000000
+DEAL:1::0_2:22 with 100000000
+DEAL:1::0_2:23 with 100000000
 DEAL:1::0_2:11 with 100000000
 DEAL:1::0_2:12 with 100000000
 DEAL:1::0_2:13 with 100000000
@@ -418,10 +418,10 @@ DEAL:1::0_2:31 with 100000000
 DEAL:1::0_2:33 with 100000000
 DEAL:1::0_2:35 with 100000000
 DEAL:1::0_2:37 with 100000000
-DEAL:1::0_2:22 with 100000000
-DEAL:1::0_2:23 with 100000000
 DEAL:1::0_2:30 with 100000000
 DEAL:1::0_2:32 with 100000000
+DEAL:1::0_2:34 with 100000000
+DEAL:1::0_2:36 with 100000000
 DEAL:1::
 
 
@@ -429,6 +429,8 @@ DEAL:2::Number of cell batches: 24
 DEAL:2::0_3:300 with 5
 DEAL:2::0_4:3102 with 5
 DEAL:2::0_3:303 with 6
+DEAL:2::0_3:312 with 6
+DEAL:2::0_3:313 with 6
 DEAL:2::0_4:3103 with 6
 DEAL:2::0_3:220 with 8
 DEAL:2::0_3:221 with 8
@@ -442,8 +444,6 @@ DEAL:2::0_4:2330 with 9
 DEAL:2::0_4:2331 with 9
 DEAL:2::0_4:2332 with 9
 DEAL:2::0_4:2333 with 9
-DEAL:2::0_4:3323 with 9
-DEAL:2::0_4:3313 with 9
 DEAL:2::0_3:301 with 5
 DEAL:2::0_4:3100 with 5
 DEAL:2::0_4:3101 with 5
@@ -454,13 +454,11 @@ DEAL:2::0_3:230 with 8
 DEAL:2::0_3:231 with 8
 DEAL:2::0_4:3321 with 9
 DEAL:2::0_4:3312 with 9
-DEAL:2::0_3:312 with 6
 DEAL:2::0_4:3210 with 7
 DEAL:2::0_4:3211 with 7
 DEAL:2::0_4:3300 with 7
 DEAL:2::0_4:3301 with 7
 DEAL:2::0_4:3310 with 7
-DEAL:2::0_3:313 with 7
 DEAL:2::0_3:320 with 8
 DEAL:2::0_4:3212 with 8
 DEAL:2::0_4:3213 with 8
@@ -473,15 +471,18 @@ DEAL:2::0_3:322 with 9
 DEAL:2::0_3:323 with 9
 DEAL:2::0_4:3320 with 9
 DEAL:2::0_4:3322 with 9
+DEAL:2::0_4:3323 with 9
+DEAL:2::0_4:3313 with 9
 DEAL:2::
 DEAL:2::Number of cell batches: 28
 DEAL:2::0_3:300 with 5
 DEAL:2::0_4:3102 with 5
 DEAL:2::0_4:3103 with 5
 DEAL:2::0_3:303 with 6
+DEAL:2::0_3:312 with 6
+DEAL:2::0_3:313 with 6
 DEAL:2::0_3:220 with 8
 DEAL:2::0_3:221 with 8
-DEAL:2::0_4:3313 with 8
 DEAL:2::0_3:222 with 9
 DEAL:2::0_4:2230 with 9
 DEAL:2::0_4:2231 with 9
@@ -492,7 +493,6 @@ DEAL:2::0_4:2330 with 9
 DEAL:2::0_4:2331 with 9
 DEAL:2::0_4:2332 with 9
 DEAL:2::0_4:2333 with 9
-DEAL:2::0_4:3323 with 9
 DEAL:2::0_3:301 with 5
 DEAL:2::0_4:3100 with 5
 DEAL:2::0_4:3101 with 5
@@ -503,8 +503,6 @@ DEAL:2::0_3:230 with 8
 DEAL:2::0_3:231 with 8
 DEAL:2::0_4:3312 with 8
 DEAL:2::0_4:3321 with 9
-DEAL:2::0_3:312 with 6
-DEAL:2::0_3:313 with 6
 DEAL:2::0_4:3210 with 7
 DEAL:2::0_4:3211 with 7
 DEAL:2::0_4:3300 with 7
@@ -518,10 +516,12 @@ DEAL:2::0_5:33030 with 8
 DEAL:2::0_5:33031 with 8
 DEAL:2::0_5:33032 with 8
 DEAL:2::0_5:33033 with 8
+DEAL:2::0_4:3313 with 8
 DEAL:2::0_3:322 with 9
 DEAL:2::0_3:323 with 9
 DEAL:2::0_4:3320 with 9
 DEAL:2::0_4:3322 with 9
+DEAL:2::0_4:3323 with 9
 DEAL:2::
 DEAL:2::Number of cell batches: 24
 DEAL:2::0_3:220 with 100000000
@@ -540,8 +540,8 @@ DEAL:2::0_3:300 with 100000000
 DEAL:2::0_3:303 with 100000000
 DEAL:2::0_4:3102 with 100000000
 DEAL:2::0_4:3103 with 100000000
-DEAL:2::0_4:3313 with 100000000
-DEAL:2::0_4:3323 with 100000000
+DEAL:2::0_3:312 with 100000000
+DEAL:2::0_3:313 with 100000000
 DEAL:2::0_3:230 with 100000000
 DEAL:2::0_3:231 with 100000000
 DEAL:2::0_3:301 with 100000000
@@ -552,8 +552,6 @@ DEAL:2::0_3:311 with 100000000
 DEAL:2::0_4:3311 with 100000000
 DEAL:2::0_4:3312 with 100000000
 DEAL:2::0_4:3321 with 100000000
-DEAL:2::0_3:312 with 100000000
-DEAL:2::0_3:313 with 100000000
 DEAL:2::0_3:320 with 100000000
 DEAL:2::0_4:3210 with 100000000
 DEAL:2::0_4:3211 with 100000000
@@ -569,12 +567,14 @@ DEAL:2::0_5:33031 with 100000000
 DEAL:2::0_5:33032 with 100000000
 DEAL:2::0_5:33033 with 100000000
 DEAL:2::0_4:3310 with 100000000
+DEAL:2::0_4:3313 with 100000000
 DEAL:2::0_4:3320 with 100000000
 DEAL:2::0_4:3322 with 100000000
+DEAL:2::0_4:3323 with 100000000
 DEAL:2::
 DEAL:2::Number of cell batches: 8
 DEAL:2::0_2:40 with 1
-DEAL:2::0_2:50 with 1
+DEAL:2::0_2:44 with 1
 DEAL:2::0_2:41 with 1
 DEAL:2::0_2:51 with 1
 DEAL:2::0_2:42 with 3
@@ -585,14 +585,14 @@ DEAL:2::0_2:52 with 3
 DEAL:2::0_2:53 with 3
 DEAL:2::0_2:57 with 3
 DEAL:2::0_2:55 with 3
-DEAL:2::0_2:44 with 1
 DEAL:2::0_2:45 with 1
+DEAL:2::0_2:50 with 1
 DEAL:2::0_2:56 with 3
 DEAL:2::0_2:54 with 3
 DEAL:2::
 DEAL:2::Number of cell batches: 10
 DEAL:2::0_2:40 with 1
-DEAL:2::0_2:50 with 1
+DEAL:2::0_2:44 with 1
 DEAL:2::0_2:41 with 1
 DEAL:2::0_2:51 with 1
 DEAL:2::0_2:55 with 1
@@ -603,14 +603,14 @@ DEAL:2::0_2:47 with 3
 DEAL:2::0_2:52 with 3
 DEAL:2::0_2:53 with 3
 DEAL:2::0_2:57 with 3
-DEAL:2::0_2:44 with 1
 DEAL:2::0_2:45 with 1
+DEAL:2::0_2:50 with 1
 DEAL:2::0_2:54 with 1
 DEAL:2::0_2:56 with 3
 DEAL:2::
 DEAL:2::Number of cell batches: 8
 DEAL:2::0_2:40 with 100000000
-DEAL:2::0_2:50 with 100000000
+DEAL:2::0_2:44 with 100000000
 DEAL:2::0_2:41 with 100000000
 DEAL:2::0_2:42 with 100000000
 DEAL:2::0_2:43 with 100000000
@@ -621,8 +621,8 @@ DEAL:2::0_2:52 with 100000000
 DEAL:2::0_2:53 with 100000000
 DEAL:2::0_2:55 with 100000000
 DEAL:2::0_2:57 with 100000000
-DEAL:2::0_2:44 with 100000000
 DEAL:2::0_2:45 with 100000000
+DEAL:2::0_2:50 with 100000000
 DEAL:2::0_2:54 with 100000000
 DEAL:2::0_2:56 with 100000000
 DEAL:2::
@@ -632,17 +632,17 @@ DEAL:3::Number of cell batches: 24
 DEAL:3::1_3:003 with 1
 DEAL:3::1_3:001 with 1
 DEAL:3::1_3:020 with 3
+DEAL:3::1_3:021 with 3
+DEAL:3::1_3:030 with 3
 DEAL:3::1_2:01 with 3
 DEAL:3::1_3:022 with 4
 DEAL:3::1_4:0230 with 4
 DEAL:3::1_4:0231 with 4
-DEAL:3::1_3:021 with 4
-DEAL:3::1_3:200 with 5
-DEAL:3::1_4:0232 with 5
-DEAL:3::1_3:212 with 6
-DEAL:3::1_3:213 with 6
-DEAL:3::1_4:2023 with 7
-DEAL:3::1_4:2033 with 7
+DEAL:3::1_4:0232 with 4
+DEAL:3::1_4:0233 with 4
+DEAL:3::1_3:032 with 4
+DEAL:3::1_3:033 with 4
+DEAL:3::1_3:031 with 4
 DEAL:3::0_4:3330 with 9
 DEAL:3::0_4:3333 with 9
 DEAL:3::1_3:002 with 1
@@ -660,22 +660,22 @@ DEAL:3::1_4:2020 with 7
 DEAL:3::0_4:3331 with 9
 DEAL:3::0_4:3332 with 9
 DEAL:3::1_2:10 with 1
-DEAL:3::1_3:030 with 3
-DEAL:3::1_3:031 with 3
 DEAL:3::1_3:120 with 3
 DEAL:3::1_3:121 with 3
-DEAL:3::1_4:0233 with 4
-DEAL:3::1_3:032 with 4
+DEAL:3::1_3:200 with 5
 DEAL:3::1_3:201 with 5
 DEAL:3::1_3:210 with 5
 DEAL:3::1_4:2110 with 5
-DEAL:3::1_3:033 with 5
 DEAL:3::1_4:2021 with 6
 DEAL:3::1_4:2030 with 6
 DEAL:3::1_4:2031 with 6
+DEAL:3::1_3:212 with 6
+DEAL:3::1_3:213 with 6
 DEAL:3::1_4:2112 with 6
+DEAL:3::1_4:2023 with 7
 DEAL:3::1_5:20320 with 7
 DEAL:3::1_5:20321 with 7
+DEAL:3::1_4:2033 with 7
 DEAL:3::
 DEAL:3::Number of cell batches: 28
 DEAL:3::1_3:001 with 0
@@ -683,15 +683,15 @@ DEAL:3::1_3:003 with 1
 DEAL:3::1_2:01 with 1
 DEAL:3::1_3:020 with 3
 DEAL:3::1_3:021 with 3
+DEAL:3::1_3:030 with 3
+DEAL:3::1_3:031 with 3
 DEAL:3::1_3:022 with 4
 DEAL:3::1_4:0230 with 4
 DEAL:3::1_4:0231 with 4
 DEAL:3::1_4:0232 with 4
-DEAL:3::1_3:200 with 5
-DEAL:3::1_3:212 with 6
-DEAL:3::1_3:213 with 6
-DEAL:3::1_4:2023 with 7
-DEAL:3::1_4:2033 with 7
+DEAL:3::1_4:0233 with 4
+DEAL:3::1_3:032 with 4
+DEAL:3::1_3:033 with 4
 DEAL:3::0_4:3330 with 9
 DEAL:3::0_4:3333 with 9
 DEAL:3::1_3:000 with 0
@@ -709,13 +709,9 @@ DEAL:3::1_5:20323 with 7
 DEAL:3::0_4:3331 with 9
 DEAL:3::0_4:3332 with 9
 DEAL:3::1_2:10 with 1
-DEAL:3::1_3:030 with 3
-DEAL:3::1_3:031 with 3
 DEAL:3::1_3:120 with 3
 DEAL:3::1_3:121 with 3
-DEAL:3::1_4:0233 with 4
-DEAL:3::1_3:032 with 4
-DEAL:3::1_3:033 with 4
+DEAL:3::1_3:200 with 5
 DEAL:3::1_3:201 with 5
 DEAL:3::1_3:210 with 5
 DEAL:3::1_4:2110 with 5
@@ -723,8 +719,12 @@ DEAL:3::1_4:2112 with 5
 DEAL:3::1_4:2021 with 6
 DEAL:3::1_4:2030 with 6
 DEAL:3::1_4:2031 with 6
+DEAL:3::1_3:212 with 6
+DEAL:3::1_3:213 with 6
+DEAL:3::1_4:2023 with 7
 DEAL:3::1_5:20320 with 7
 DEAL:3::1_5:20321 with 7
+DEAL:3::1_4:2033 with 7
 DEAL:3::
 DEAL:3::Number of cell batches: 24
 DEAL:3::0_4:3330 with 100000000
@@ -738,11 +738,11 @@ DEAL:3::1_3:022 with 100000000
 DEAL:3::1_4:0230 with 100000000
 DEAL:3::1_4:0231 with 100000000
 DEAL:3::1_4:0232 with 100000000
-DEAL:3::1_3:200 with 100000000
-DEAL:3::1_4:2023 with 100000000
-DEAL:3::1_4:2033 with 100000000
-DEAL:3::1_3:212 with 100000000
-DEAL:3::1_3:213 with 100000000
+DEAL:3::1_4:0233 with 100000000
+DEAL:3::1_3:030 with 100000000
+DEAL:3::1_3:031 with 100000000
+DEAL:3::1_3:032 with 100000000
+DEAL:3::1_3:033 with 100000000
 DEAL:3::0_4:3331 with 100000000
 DEAL:3::0_4:3332 with 100000000
 DEAL:3::1_3:000 with 100000000
@@ -757,23 +757,23 @@ DEAL:3::1_5:20322 with 100000000
 DEAL:3::1_5:20323 with 100000000
 DEAL:3::1_4:2111 with 100000000
 DEAL:3::1_4:2113 with 100000000
-DEAL:3::1_4:0233 with 100000000
-DEAL:3::1_3:030 with 100000000
-DEAL:3::1_3:031 with 100000000
-DEAL:3::1_3:032 with 100000000
-DEAL:3::1_3:033 with 100000000
 DEAL:3::1_2:10 with 100000000
 DEAL:3::1_3:120 with 100000000
 DEAL:3::1_3:121 with 100000000
+DEAL:3::1_3:200 with 100000000
 DEAL:3::1_3:201 with 100000000
 DEAL:3::1_4:2021 with 100000000
+DEAL:3::1_4:2023 with 100000000
 DEAL:3::1_4:2030 with 100000000
 DEAL:3::1_4:2031 with 100000000
 DEAL:3::1_5:20320 with 100000000
 DEAL:3::1_5:20321 with 100000000
+DEAL:3::1_4:2033 with 100000000
 DEAL:3::1_3:210 with 100000000
 DEAL:3::1_4:2110 with 100000000
 DEAL:3::1_4:2112 with 100000000
+DEAL:3::1_3:212 with 100000000
+DEAL:3::1_3:213 with 100000000
 DEAL:3::
 DEAL:3::Number of cell batches: 8
 DEAL:3::0_2:60 with 6
@@ -829,20 +829,20 @@ DEAL:3::
 
 
 DEAL:4::Number of cell batches: 23
-DEAL:4::1_3:300 with 5
-DEAL:4::2_2:00 with 5
-DEAL:4::1_4:2210 with 7
-DEAL:4::1_3:301 with 7
 DEAL:4::1_4:2203 with 8
 DEAL:4::1_4:2212 with 8
 DEAL:4::1_4:2213 with 8
-DEAL:4::2_2:03 with 8
+DEAL:4::1_4:2210 with 8
 DEAL:4::1_4:2220 with 9
 DEAL:4::1_4:2221 with 9
 DEAL:4::1_5:22221 with 9
 DEAL:4::1_5:22223 with 9
-DEAL:4::2_3:121 with 10
-DEAL:4::1_4:2223 with 10
+DEAL:4::1_4:2223 with 9
+DEAL:4::1_3:223 with 9
+DEAL:4::1_3:232 with 9
+DEAL:4::1_4:2330 with 9
+DEAL:4::1_4:2331 with 9
+DEAL:4::1_4:2332 with 9
 DEAL:4::1_3:310 with 5
 DEAL:4::1_3:311 with 5
 DEAL:4::1_3:302 with 6
@@ -859,29 +859,25 @@ DEAL:4::1_5:22220 with 9
 DEAL:4::1_5:22222 with 9
 DEAL:4::2_3:123 with 11
 DEAL:4::2_3:122 with 11
+DEAL:4::1_3:300 with 5
+DEAL:4::1_3:301 with 5
+DEAL:4::2_2:01 with 5
+DEAL:4::2_2:00 with 5
 DEAL:4::1_3:303 with 6
-DEAL:4::2_2:01 with 6
+DEAL:4::1_3:312 with 6
+DEAL:4::2_2:03 with 7
 DEAL:4::2_2:10 with 7
-DEAL:4::1_3:312 with 7
 DEAL:4::1_3:320 with 8
 DEAL:4::1_3:321 with 8
-DEAL:4::1_3:223 with 9
-DEAL:4::1_3:232 with 9
-DEAL:4::1_4:2330 with 9
-DEAL:4::1_4:2331 with 9
-DEAL:4::1_4:2332 with 9
 DEAL:4::1_4:2333 with 9
 DEAL:4::1_3:322 with 9
+DEAL:4::1_3:323 with 9
 DEAL:4::2_3:120 with 9
 DEAL:4::2_2:11 with 10
-DEAL:4::1_3:323 with 10
+DEAL:4::2_3:121 with 10
 DEAL:4::
-DEAL:4::Number of cell batches: 29
-DEAL:4::2_2:00 with 2
-DEAL:4::1_3:300 with 5
-DEAL:4::1_3:301 with 5
+DEAL:4::Number of cell batches: 28
 DEAL:4::1_4:2210 with 7
-DEAL:4::2_2:03 with 7
 DEAL:4::1_4:2203 with 8
 DEAL:4::1_4:2212 with 8
 DEAL:4::1_4:2213 with 8
@@ -890,7 +886,11 @@ DEAL:4::1_4:2221 with 9
 DEAL:4::1_5:22221 with 9
 DEAL:4::1_5:22223 with 9
 DEAL:4::1_4:2223 with 9
-DEAL:4::2_3:121 with 10
+DEAL:4::1_3:223 with 9
+DEAL:4::1_3:232 with 9
+DEAL:4::1_4:2330 with 9
+DEAL:4::1_4:2331 with 9
+DEAL:4::1_4:2332 with 9
 DEAL:4::1_3:310 with 5
 DEAL:4::1_3:311 with 5
 DEAL:4::2_2:02 with 5
@@ -907,22 +907,22 @@ DEAL:4::1_5:22220 with 9
 DEAL:4::1_5:22222 with 9
 DEAL:4::2_3:122 with 10
 DEAL:4::2_3:123 with 11
+DEAL:4::2_2:00 with 2
+DEAL:4::1_3:300 with 5
+DEAL:4::1_3:301 with 5
 DEAL:4::2_2:01 with 5
 DEAL:4::1_3:303 with 6
 DEAL:4::1_3:312 with 6
+DEAL:4::2_2:03 with 7
 DEAL:4::2_2:10 with 7
 DEAL:4::1_3:320 with 8
 DEAL:4::1_3:321 with 8
 DEAL:4::2_3:120 with 8
-DEAL:4::1_3:223 with 9
-DEAL:4::1_3:232 with 9
-DEAL:4::1_4:2330 with 9
-DEAL:4::1_4:2331 with 9
-DEAL:4::1_4:2332 with 9
 DEAL:4::1_4:2333 with 9
 DEAL:4::1_3:322 with 9
 DEAL:4::1_3:323 with 9
 DEAL:4::2_2:11 with 10
+DEAL:4::2_3:121 with 10
 DEAL:4::
 DEAL:4::Number of cell batches: 23
 DEAL:4::1_4:2203 with 100000000
@@ -934,11 +934,11 @@ DEAL:4::1_4:2221 with 100000000
 DEAL:4::1_5:22221 with 100000000
 DEAL:4::1_5:22223 with 100000000
 DEAL:4::1_4:2223 with 100000000
-DEAL:4::1_3:300 with 100000000
-DEAL:4::1_3:301 with 100000000
-DEAL:4::2_2:00 with 100000000
-DEAL:4::2_2:03 with 100000000
-DEAL:4::2_3:121 with 100000000
+DEAL:4::1_3:223 with 100000000
+DEAL:4::1_3:232 with 100000000
+DEAL:4::1_4:2330 with 100000000
+DEAL:4::1_4:2331 with 100000000
+DEAL:4::1_4:2332 with 100000000
 DEAL:4::1_4:2200 with 100000000
 DEAL:4::1_4:2201 with 100000000
 DEAL:4::1_4:2202 with 100000000
@@ -955,28 +955,28 @@ DEAL:4::1_2:33 with 100000000
 DEAL:4::2_2:02 with 100000000
 DEAL:4::2_3:122 with 100000000
 DEAL:4::2_3:123 with 100000000
-DEAL:4::1_3:223 with 100000000
-DEAL:4::1_3:232 with 100000000
-DEAL:4::1_4:2330 with 100000000
-DEAL:4::1_4:2331 with 100000000
-DEAL:4::1_4:2332 with 100000000
 DEAL:4::1_4:2333 with 100000000
+DEAL:4::1_3:300 with 100000000
+DEAL:4::1_3:301 with 100000000
 DEAL:4::1_3:303 with 100000000
 DEAL:4::1_3:312 with 100000000
 DEAL:4::1_3:320 with 100000000
 DEAL:4::1_3:321 with 100000000
 DEAL:4::1_3:322 with 100000000
 DEAL:4::1_3:323 with 100000000
+DEAL:4::2_2:00 with 100000000
 DEAL:4::2_2:01 with 100000000
+DEAL:4::2_2:03 with 100000000
 DEAL:4::2_2:10 with 100000000
 DEAL:4::2_2:11 with 100000000
 DEAL:4::2_3:120 with 100000000
+DEAL:4::2_3:121 with 100000000
 DEAL:4::
 DEAL:4::Number of cell batches: 11
-DEAL:4::1_2:60 with 6
-DEAL:4::1_1:1 with 6
-DEAL:4::1_2:62 with 8
-DEAL:4::1_1:3 with 8
+DEAL:4::1_1:0 with 2
+DEAL:4::1_1:1 with 2
+DEAL:4::0_3:777 with 9
+DEAL:4::1_1:2 with 9
 DEAL:4::1_2:61 with 6
 DEAL:4::1_1:5 with 6
 DEAL:4::0_3:770 with 8
@@ -989,18 +989,18 @@ DEAL:4::0_3:772 with 9
 DEAL:4::0_3:773 with 9
 DEAL:4::0_3:776 with 9
 DEAL:4::1_2:67 with 9
-DEAL:4::1_1:0 with 2
-DEAL:4::1_1:4 with 2
-DEAL:4::1_1:2 with 7
-DEAL:4::1_2:64 with 7
-DEAL:4::0_3:777 with 9
-DEAL:4::1_2:66 with 9
-DEAL:4::
-DEAL:4::Number of cell batches: 16
-DEAL:4::1_1:1 with 2
 DEAL:4::1_2:60 with 6
+DEAL:4::1_1:4 with 6
 DEAL:4::1_1:3 with 7
+DEAL:4::1_2:64 with 7
 DEAL:4::1_2:62 with 8
+DEAL:4::1_2:66 with 8
+DEAL:4::
+DEAL:4::Number of cell batches: 14
+DEAL:4::1_1:0 with 2
+DEAL:4::1_1:1 with 2
+DEAL:4::1_1:2 with 7
+DEAL:4::0_3:777 with 9
 DEAL:4::1_1:5 with 2
 DEAL:4::1_2:61 with 6
 DEAL:4::1_2:65 with 6
@@ -1013,18 +1013,18 @@ DEAL:4::1_2:67 with 8
 DEAL:4::0_3:772 with 9
 DEAL:4::0_3:773 with 9
 DEAL:4::0_3:776 with 9
-DEAL:4::1_1:0 with 2
 DEAL:4::1_1:4 with 2
+DEAL:4::1_2:60 with 6
 DEAL:4::1_2:64 with 6
-DEAL:4::1_1:2 with 7
+DEAL:4::1_1:3 with 7
+DEAL:4::1_2:62 with 8
 DEAL:4::1_2:66 with 8
-DEAL:4::0_3:777 with 9
 DEAL:4::
 DEAL:4::Number of cell batches: 11
+DEAL:4::0_3:777 with 100000000
+DEAL:4::1_1:0 with 100000000
 DEAL:4::1_1:1 with 100000000
-DEAL:4::1_1:3 with 100000000
-DEAL:4::1_2:60 with 100000000
-DEAL:4::1_2:62 with 100000000
+DEAL:4::1_1:2 with 100000000
 DEAL:4::0_3:770 with 100000000
 DEAL:4::0_3:771 with 100000000
 DEAL:4::0_3:772 with 100000000
@@ -1037,10 +1037,10 @@ DEAL:4::1_2:61 with 100000000
 DEAL:4::1_2:63 with 100000000
 DEAL:4::1_2:65 with 100000000
 DEAL:4::1_2:67 with 100000000
-DEAL:4::0_3:777 with 100000000
-DEAL:4::1_1:0 with 100000000
-DEAL:4::1_1:2 with 100000000
+DEAL:4::1_1:3 with 100000000
 DEAL:4::1_1:4 with 100000000
+DEAL:4::1_2:60 with 100000000
+DEAL:4::1_2:62 with 100000000
 DEAL:4::1_2:64 with 100000000
 DEAL:4::1_2:66 with 100000000
 DEAL:4::
@@ -1049,14 +1049,14 @@ DEAL:4::
 DEAL:5::Number of cell batches: 24
 DEAL:5::2_2:22 with 10
 DEAL:5::2_2:20 with 10
+DEAL:5::2_3:230 with 11
+DEAL:5::3_3:001 with 11
 DEAL:5::2_3:231 with 12
 DEAL:5::2_3:232 with 12
-DEAL:5::2_2:30 with 12
-DEAL:5::2_3:230 with 12
 DEAL:5::2_3:133 with 13
 DEAL:5::2_3:233 with 13
-DEAL:5::3_3:133 with 14
-DEAL:5::2_3:310 with 14
+DEAL:5::2_3:310 with 13
+DEAL:5::2_2:30 with 13
 DEAL:5::2_3:311 with 15
 DEAL:5::2_3:312 with 15
 DEAL:5::2_3:313 with 16
@@ -1077,28 +1077,29 @@ DEAL:5::3_2:20 with 16
 DEAL:5::3_3:132 with 16
 DEAL:5::2_3:333 with 18
 DEAL:5::2_3:331 with 18
-DEAL:5::3_3:001 with 10
 DEAL:5::3_3:100 with 10
 DEAL:5::3_3:101 with 10
-DEAL:5::3_3:110 with 10
 DEAL:5::3_3:003 with 11
 DEAL:5::3_2:01 with 11
 DEAL:5::3_3:102 with 11
 DEAL:5::3_3:103 with 11
+DEAL:5::3_3:112 with 11
+DEAL:5::3_3:110 with 11
 DEAL:5::3_4:1300 with 12
-DEAL:5::3_3:112 with 12
+DEAL:5::3_4:1301 with 12
 DEAL:5::3_2:02 with 13
 DEAL:5::3_2:03 with 13
 DEAL:5::3_3:120 with 13
 DEAL:5::3_3:121 with 13
 DEAL:5::3_4:1302 with 13
 DEAL:5::3_4:1303 with 13
-DEAL:5::3_3:131 with 13
-DEAL:5::3_4:1301 with 13
+DEAL:5::3_3:133 with 14
+DEAL:5::3_3:131 with 14
 DEAL:5::
 DEAL:5::Number of cell batches: 32
 DEAL:5::2_2:20 with 7
 DEAL:5::2_2:22 with 10
+DEAL:5::3_3:001 with 10
 DEAL:5::2_3:230 with 11
 DEAL:5::2_3:231 with 12
 DEAL:5::2_3:232 with 12
@@ -1106,7 +1107,6 @@ DEAL:5::2_2:30 with 12
 DEAL:5::2_3:133 with 13
 DEAL:5::2_3:233 with 13
 DEAL:5::2_3:310 with 13
-DEAL:5::3_3:133 with 14
 DEAL:5::2_3:311 with 15
 DEAL:5::2_3:312 with 15
 DEAL:5::2_2:32 with 15
@@ -1127,7 +1127,6 @@ DEAL:5::3_3:132 with 14
 DEAL:5::3_2:20 with 16
 DEAL:5::2_3:331 with 17
 DEAL:5::2_3:333 with 18
-DEAL:5::3_3:001 with 10
 DEAL:5::3_3:100 with 10
 DEAL:5::3_3:101 with 10
 DEAL:5::3_3:110 with 10
@@ -1145,6 +1144,7 @@ DEAL:5::3_3:121 with 13
 DEAL:5::3_4:1302 with 13
 DEAL:5::3_4:1303 with 13
 DEAL:5::3_3:131 with 13
+DEAL:5::3_3:133 with 14
 DEAL:5::
 DEAL:5::Number of cell batches: 24
 DEAL:5::2_3:133 with 100000000
@@ -1162,7 +1162,7 @@ DEAL:5::2_3:313 with 100000000
 DEAL:5::2_2:32 with 100000000
 DEAL:5::2_3:330 with 100000000
 DEAL:5::2_3:332 with 100000000
-DEAL:5::3_3:133 with 100000000
+DEAL:5::3_3:001 with 100000000
 DEAL:5::2_3:130 with 100000000
 DEAL:5::2_3:131 with 100000000
 DEAL:5::2_3:132 with 100000000
@@ -1177,7 +1177,6 @@ DEAL:5::3_3:122 with 100000000
 DEAL:5::3_3:123 with 100000000
 DEAL:5::3_3:132 with 100000000
 DEAL:5::3_2:20 with 100000000
-DEAL:5::3_3:001 with 100000000
 DEAL:5::3_3:003 with 100000000
 DEAL:5::3_2:01 with 100000000
 DEAL:5::3_2:02 with 100000000
@@ -1195,63 +1194,64 @@ DEAL:5::3_4:1301 with 100000000
 DEAL:5::3_4:1302 with 100000000
 DEAL:5::3_4:1303 with 100000000
 DEAL:5::3_3:131 with 100000000
+DEAL:5::3_3:133 with 100000000
 DEAL:5::
 DEAL:5::Number of cell batches: 9
-DEAL:5::3_1:5 with 12
-DEAL:5::2_1:1 with 12
-DEAL:5::3_1:7 with 17
-DEAL:5::2_1:3 with 17
+DEAL:5::2_1:1 with 10
+DEAL:5::2_1:5 with 10
+DEAL:5::2_1:3 with 15
+DEAL:5::2_1:6 with 15
 DEAL:5::2_1:0 with 5
 DEAL:5::2_1:4 with 5
 DEAL:5::2_1:2 with 10
 DEAL:5::1_1:7 with 10
 DEAL:5::3_1:3 with 17
 DEAL:5::3_1:1 with 17
-DEAL:5::2_1:5 with 10
 DEAL:5::3_1:0 with 12
-DEAL:5::2_1:6 with 12
-DEAL:5::2_1:7 with 15
-DEAL:5::3_1:4 with 15
+DEAL:5::3_1:4 with 12
+DEAL:5::3_1:5 with 12
 DEAL:5::3_1:2 with 17
 DEAL:5::3_1:6 with 17
+DEAL:5::3_1:7 with 17
+DEAL:5::2_1:7 with 17
 DEAL:5::
 DEAL:5::Number of cell batches: 13
 DEAL:5::2_1:1 with 10
-DEAL:5::3_1:5 with 12
+DEAL:5::2_1:5 with 10
+DEAL:5::2_1:6 with 10
 DEAL:5::2_1:3 with 15
-DEAL:5::3_1:7 with 17
 DEAL:5::2_1:0 with 5
 DEAL:5::2_1:4 with 5
 DEAL:5::1_1:7 with 7
 DEAL:5::2_1:2 with 10
 DEAL:5::3_1:1 with 12
 DEAL:5::3_1:3 with 17
-DEAL:5::2_1:5 with 10
-DEAL:5::2_1:6 with 10
 DEAL:5::3_1:0 with 12
 DEAL:5::3_1:4 with 12
+DEAL:5::3_1:5 with 12
 DEAL:5::2_1:7 with 15
 DEAL:5::3_1:2 with 17
 DEAL:5::3_1:6 with 17
+DEAL:5::3_1:7 with 17
 DEAL:5::
 DEAL:5::Number of cell batches: 9
 DEAL:5::2_1:1 with 100000000
 DEAL:5::2_1:3 with 100000000
-DEAL:5::3_1:5 with 100000000
-DEAL:5::3_1:7 with 100000000
+DEAL:5::2_1:5 with 100000000
+DEAL:5::2_1:6 with 100000000
 DEAL:5::1_1:7 with 100000000
 DEAL:5::2_1:0 with 100000000
 DEAL:5::2_1:2 with 100000000
 DEAL:5::2_1:4 with 100000000
 DEAL:5::3_1:1 with 100000000
 DEAL:5::3_1:3 with 100000000
-DEAL:5::2_1:5 with 100000000
-DEAL:5::2_1:6 with 100000000
 DEAL:5::2_1:7 with 100000000
 DEAL:5::3_1:0 with 100000000
 DEAL:5::3_1:2 with 100000000
 DEAL:5::3_1:4 with 100000000
+DEAL:5::3_1:5 with 100000000
 DEAL:5::3_1:6 with 100000000
+DEAL:5::3_1:7 with 100000000
 DEAL:5::
 
 
index 0dccca725de4630bcc060486f988101521986fab..bbe5e5ade079c451faf9f9328138bc40d49d1b12 100644 (file)
@@ -12,10 +12,10 @@ DEAL:0::0_4:0020 with 1
 DEAL:0::0_4:0013 with 1
 DEAL:0::0_4:0012 with 1
 DEAL:0::0_4:0011 with 1
-DEAL:0::0_3:022 with 4
-DEAL:0::0_3:013 with 4
-DEAL:0::0_3:012 with 4
-DEAL:0::0_4:0021 with 4
+DEAL:0::0_5:00220 with 2
+DEAL:0::0_5:00221 with 2
+DEAL:0::0_6:002220 with 2
+DEAL:0::0_4:0021 with 2
 DEAL:0::0_3:010 with 0
 DEAL:0::0_4:0110 with 0
 DEAL:0::0_4:0111 with 0
@@ -27,9 +27,6 @@ DEAL:0::0_4:0033 with 3
 DEAL:0::0_4:0030 with 1
 DEAL:0::0_4:0031 with 1
 DEAL:0::0_4:0112 with 1
-DEAL:0::0_5:00220 with 2
-DEAL:0::0_5:00221 with 2
-DEAL:0::0_6:002220 with 2
 DEAL:0::0_6:002221 with 2
 DEAL:0::0_6:002222 with 2
 DEAL:0::0_6:002223 with 2
@@ -43,10 +40,13 @@ DEAL:0::0_5:02003 with 2
 DEAL:0::0_5:02010 with 2
 DEAL:0::0_5:02011 with 2
 DEAL:0::0_5:02012 with 2
-DEAL:0::0_4:0202 with 3
-DEAL:0::0_4:0203 with 3
-DEAL:0::0_4:0210 with 3
-DEAL:0::0_5:02013 with 3
+DEAL:0::0_5:02013 with 2
+DEAL:0::0_3:013 with 2
+DEAL:0::0_3:012 with 2
+DEAL:0::0_3:022 with 4
+DEAL:0::0_4:0203 with 4
+DEAL:0::0_4:0202 with 4
+DEAL:0::0_4:0210 with 4
 DEAL:0::
 DEAL:0::Number of cell batches: 16
 DEAL:0::0_4:0000 with 0
@@ -62,9 +62,9 @@ DEAL:0::0_4:0012 with 0
 DEAL:0::0_4:0013 with 0
 DEAL:0::0_4:0020 with 1
 DEAL:0::0_4:0021 with 1
-DEAL:0::0_3:012 with 1
-DEAL:0::0_3:013 with 1
-DEAL:0::0_3:022 with 4
+DEAL:0::0_5:00220 with 2
+DEAL:0::0_5:00221 with 2
+DEAL:0::0_6:002220 with 2
 DEAL:0::0_3:010 with 0
 DEAL:0::0_4:0110 with 0
 DEAL:0::0_4:0111 with 0
@@ -76,9 +76,8 @@ DEAL:0::0_4:0213 with 3
 DEAL:0::0_4:0112 with 0
 DEAL:0::0_4:0030 with 1
 DEAL:0::0_4:0031 with 1
-DEAL:0::0_5:00220 with 2
-DEAL:0::0_5:00221 with 2
-DEAL:0::0_6:002220 with 2
+DEAL:0::0_3:012 with 1
+DEAL:0::0_3:013 with 1
 DEAL:0::0_6:002221 with 2
 DEAL:0::0_6:002222 with 2
 DEAL:0::0_6:002223 with 2
@@ -96,6 +95,7 @@ DEAL:0::0_5:02013 with 2
 DEAL:0::0_4:0210 with 2
 DEAL:0::0_4:0202 with 3
 DEAL:0::0_4:0203 with 3
+DEAL:0::0_3:022 with 4
 DEAL:0::
 DEAL:0::Number of cell batches: 12
 DEAL:0::0_4:0000 with 100000000
@@ -111,9 +111,9 @@ DEAL:0::0_4:0012 with 100000000
 DEAL:0::0_4:0013 with 100000000
 DEAL:0::0_4:0020 with 100000000
 DEAL:0::0_4:0021 with 100000000
-DEAL:0::0_3:012 with 100000000
-DEAL:0::0_3:013 with 100000000
-DEAL:0::0_3:022 with 100000000
+DEAL:0::0_5:00220 with 100000000
+DEAL:0::0_5:00221 with 100000000
+DEAL:0::0_6:002220 with 100000000
 DEAL:0::0_4:0033 with 100000000
 DEAL:0::0_3:010 with 100000000
 DEAL:0::0_4:0110 with 100000000
@@ -122,9 +122,6 @@ DEAL:0::0_4:0113 with 100000000
 DEAL:0::0_4:0211 with 100000000
 DEAL:0::0_4:0212 with 100000000
 DEAL:0::0_4:0213 with 100000000
-DEAL:0::0_5:00220 with 100000000
-DEAL:0::0_5:00221 with 100000000
-DEAL:0::0_6:002220 with 100000000
 DEAL:0::0_6:002221 with 100000000
 DEAL:0::0_6:002222 with 100000000
 DEAL:0::0_6:002223 with 100000000
@@ -134,6 +131,8 @@ DEAL:0::0_4:0030 with 100000000
 DEAL:0::0_4:0031 with 100000000
 DEAL:0::0_4:0032 with 100000000
 DEAL:0::0_4:0112 with 100000000
+DEAL:0::0_3:012 with 100000000
+DEAL:0::0_3:013 with 100000000
 DEAL:0::0_5:02000 with 100000000
 DEAL:0::0_5:02001 with 100000000
 DEAL:0::0_5:02002 with 100000000
@@ -145,6 +144,7 @@ DEAL:0::0_5:02013 with 100000000
 DEAL:0::0_4:0202 with 100000000
 DEAL:0::0_4:0203 with 100000000
 DEAL:0::0_4:0210 with 100000000
+DEAL:0::0_3:022 with 100000000
 DEAL:0::
 DEAL:0::Number of cell batches: 4
 DEAL:0::0_3:006 with 1
@@ -207,10 +207,10 @@ DEAL:1::0_3:032 with 4
 DEAL:1::0_3:130 with 4
 DEAL:1::0_3:121 with 4
 DEAL:1::0_3:120 with 4
-DEAL:1::0_3:213 with 6
-DEAL:1::0_4:2002 with 6
-DEAL:1::0_3:132 with 6
-DEAL:1::0_3:123 with 6
+DEAL:1::0_4:2002 with 5
+DEAL:1::0_4:2003 with 5
+DEAL:1::0_3:132 with 5
+DEAL:1::0_3:123 with 5
 DEAL:1::0_4:0310 with 2
 DEAL:1::0_3:102 with 2
 DEAL:1::0_3:101 with 2
@@ -231,9 +231,9 @@ DEAL:1::0_4:2122 with 7
 DEAL:1::0_4:2123 with 7
 DEAL:1::0_3:211 with 7
 DEAL:1::0_4:2001 with 7
-DEAL:1::0_4:2003 with 5
 DEAL:1::0_4:2010 with 5
 DEAL:1::0_4:2011 with 5
+DEAL:1::0_4:2012 with 5
 DEAL:1::0_4:2020 with 6
 DEAL:1::0_4:2021 with 6
 DEAL:1::0_5:20300 with 6
@@ -243,11 +243,11 @@ DEAL:1::0_5:20303 with 6
 DEAL:1::0_4:2031 with 6
 DEAL:1::0_4:2120 with 6
 DEAL:1::0_4:2121 with 6
+DEAL:1::0_3:213 with 6
 DEAL:1::0_3:210 with 6
 DEAL:1::0_4:2013 with 6
-DEAL:1::0_4:2012 with 6
 DEAL:1::
-DEAL:1::Number of cell batches: 19
+DEAL:1::Number of cell batches: 18
 DEAL:1::0_3:103 with 1
 DEAL:1::0_2:11 with 1
 DEAL:1::0_4:0312 with 3
@@ -259,7 +259,7 @@ DEAL:1::0_3:032 with 4
 DEAL:1::0_3:123 with 4
 DEAL:1::0_3:132 with 4
 DEAL:1::0_4:2002 with 5
-DEAL:1::0_3:213 with 6
+DEAL:1::0_4:2003 with 5
 DEAL:1::0_3:100 with 0
 DEAL:1::0_3:101 with 0
 DEAL:1::0_3:102 with 1
@@ -280,7 +280,6 @@ DEAL:1::0_4:2032 with 7
 DEAL:1::0_4:2033 with 7
 DEAL:1::0_4:2122 with 7
 DEAL:1::0_4:2123 with 7
-DEAL:1::0_4:2003 with 5
 DEAL:1::0_4:2010 with 5
 DEAL:1::0_4:2011 with 5
 DEAL:1::0_4:2012 with 5
@@ -295,6 +294,7 @@ DEAL:1::0_5:20303 with 6
 DEAL:1::0_4:2031 with 6
 DEAL:1::0_4:2120 with 6
 DEAL:1::0_4:2121 with 6
+DEAL:1::0_3:213 with 6
 DEAL:1::
 DEAL:1::Number of cell batches: 12
 DEAL:1::0_4:0312 with 100000000
@@ -308,7 +308,7 @@ DEAL:1::0_3:123 with 100000000
 DEAL:1::0_3:130 with 100000000
 DEAL:1::0_3:132 with 100000000
 DEAL:1::0_4:2002 with 100000000
-DEAL:1::0_3:213 with 100000000
+DEAL:1::0_4:2003 with 100000000
 DEAL:1::0_3:023 with 100000000
 DEAL:1::0_3:030 with 100000000
 DEAL:1::0_4:0310 with 100000000
@@ -329,7 +329,6 @@ DEAL:1::0_4:2033 with 100000000
 DEAL:1::0_3:211 with 100000000
 DEAL:1::0_4:2122 with 100000000
 DEAL:1::0_4:2123 with 100000000
-DEAL:1::0_4:2003 with 100000000
 DEAL:1::0_4:2010 with 100000000
 DEAL:1::0_4:2011 with 100000000
 DEAL:1::0_4:2012 with 100000000
@@ -344,10 +343,11 @@ DEAL:1::0_4:2031 with 100000000
 DEAL:1::0_3:210 with 100000000
 DEAL:1::0_4:2120 with 100000000
 DEAL:1::0_4:2121 with 100000000
+DEAL:1::0_3:213 with 100000000
 DEAL:1::
 DEAL:1::Number of cell batches: 6
-DEAL:1::0_2:36 with 8
-DEAL:1::0_2:34 with 8
+DEAL:1::0_2:22 with 8
+DEAL:1::0_2:23 with 8
 DEAL:1::0_2:20 with 8
 DEAL:1::0_2:10 with 8
 DEAL:1::0_2:12 with 3
@@ -366,16 +366,16 @@ DEAL:1::0_2:26 with 8
 DEAL:1::0_2:27 with 8
 DEAL:1::0_2:33 with 8
 DEAL:1::0_2:37 with 8
-DEAL:1::0_2:22 with 8
-DEAL:1::0_2:23 with 8
 DEAL:1::0_2:32 with 8
+DEAL:1::0_2:36 with 8
+DEAL:1::0_2:34 with 8
 DEAL:1::0_2:30 with 8
 DEAL:1::
 DEAL:1::Number of cell batches: 10
 DEAL:1::0_2:10 with 1
 DEAL:1::0_2:20 with 6
-DEAL:1::0_2:34 with 6
-DEAL:1::0_2:36 with 8
+DEAL:1::0_2:22 with 8
+DEAL:1::0_2:23 with 8
 DEAL:1::0_2:11 with 1
 DEAL:1::0_2:14 with 1
 DEAL:1::0_2:15 with 1
@@ -393,15 +393,15 @@ DEAL:1::0_2:27 with 8
 DEAL:1::0_2:33 with 8
 DEAL:1::0_2:37 with 8
 DEAL:1::0_2:30 with 6
-DEAL:1::0_2:22 with 8
-DEAL:1::0_2:23 with 8
+DEAL:1::0_2:34 with 6
 DEAL:1::0_2:32 with 8
+DEAL:1::0_2:36 with 8
 DEAL:1::
 DEAL:1::Number of cell batches: 6
 DEAL:1::0_2:10 with 100000000
 DEAL:1::0_2:20 with 100000000
-DEAL:1::0_2:34 with 100000000
-DEAL:1::0_2:36 with 100000000
+DEAL:1::0_2:22 with 100000000
+DEAL:1::0_2:23 with 100000000
 DEAL:1::0_2:11 with 100000000
 DEAL:1::0_2:12 with 100000000
 DEAL:1::0_2:13 with 100000000
@@ -418,10 +418,10 @@ DEAL:1::0_2:31 with 100000000
 DEAL:1::0_2:33 with 100000000
 DEAL:1::0_2:35 with 100000000
 DEAL:1::0_2:37 with 100000000
-DEAL:1::0_2:22 with 100000000
-DEAL:1::0_2:23 with 100000000
 DEAL:1::0_2:30 with 100000000
 DEAL:1::0_2:32 with 100000000
+DEAL:1::0_2:34 with 100000000
+DEAL:1::0_2:36 with 100000000
 DEAL:1::
 
 
@@ -430,6 +430,10 @@ DEAL:2::0_3:303 with 6
 DEAL:2::0_4:3103 with 6
 DEAL:2::0_4:3102 with 6
 DEAL:2::0_3:300 with 6
+DEAL:2::0_3:220 with 8
+DEAL:2::0_3:221 with 8
+DEAL:2::0_3:313 with 8
+DEAL:2::0_3:312 with 8
 DEAL:2::0_3:222 with 9
 DEAL:2::0_4:2230 with 9
 DEAL:2::0_4:2231 with 9
@@ -438,10 +442,6 @@ DEAL:2::0_4:2330 with 9
 DEAL:2::0_4:2331 with 9
 DEAL:2::0_4:2332 with 9
 DEAL:2::0_4:2333 with 9
-DEAL:2::0_4:3323 with 9
-DEAL:2::0_4:3313 with 9
-DEAL:2::0_3:221 with 9
-DEAL:2::0_3:220 with 9
 DEAL:2::0_3:301 with 5
 DEAL:2::0_4:3100 with 5
 DEAL:2::0_4:3101 with 5
@@ -457,31 +457,32 @@ DEAL:2::0_4:3312 with 9
 DEAL:2::0_4:3210 with 7
 DEAL:2::0_4:3211 with 7
 DEAL:2::0_4:3300 with 7
-DEAL:2::0_4:3301 with 7
-DEAL:2::0_4:3310 with 7
-DEAL:2::0_3:313 with 7
-DEAL:2::0_3:312 with 7
 DEAL:2::0_3:320 with 8
 DEAL:2::0_4:3212 with 8
 DEAL:2::0_4:3213 with 8
 DEAL:2::0_4:3302 with 8
 DEAL:2::0_5:33030 with 8
 DEAL:2::0_5:33031 with 8
-DEAL:2::0_5:33032 with 8
-DEAL:2::0_5:33033 with 8
+DEAL:2::0_4:3310 with 8
+DEAL:2::0_4:3301 with 8
 DEAL:2::0_3:322 with 9
 DEAL:2::0_3:323 with 9
 DEAL:2::0_4:3320 with 9
 DEAL:2::0_4:3322 with 9
+DEAL:2::0_4:3323 with 9
+DEAL:2::0_4:3313 with 9
+DEAL:2::0_5:33033 with 9
+DEAL:2::0_5:33032 with 9
 DEAL:2::
 DEAL:2::Number of cell batches: 17
 DEAL:2::0_3:300 with 5
 DEAL:2::0_4:3102 with 5
 DEAL:2::0_4:3103 with 5
 DEAL:2::0_3:303 with 6
+DEAL:2::0_3:312 with 6
+DEAL:2::0_3:313 with 6
 DEAL:2::0_3:220 with 8
 DEAL:2::0_3:221 with 8
-DEAL:2::0_4:3313 with 8
 DEAL:2::0_3:222 with 9
 DEAL:2::0_4:2230 with 9
 DEAL:2::0_4:2231 with 9
@@ -490,7 +491,6 @@ DEAL:2::0_4:2330 with 9
 DEAL:2::0_4:2331 with 9
 DEAL:2::0_4:2332 with 9
 DEAL:2::0_4:2333 with 9
-DEAL:2::0_4:3323 with 9
 DEAL:2::0_3:301 with 5
 DEAL:2::0_4:3100 with 5
 DEAL:2::0_4:3101 with 5
@@ -503,8 +503,6 @@ DEAL:2::0_4:3312 with 8
 DEAL:2::0_4:2232 with 9
 DEAL:2::0_4:2233 with 9
 DEAL:2::0_4:3321 with 9
-DEAL:2::0_3:312 with 6
-DEAL:2::0_3:313 with 6
 DEAL:2::0_4:3210 with 7
 DEAL:2::0_4:3211 with 7
 DEAL:2::0_4:3300 with 7
@@ -518,10 +516,12 @@ DEAL:2::0_5:33030 with 8
 DEAL:2::0_5:33031 with 8
 DEAL:2::0_5:33032 with 8
 DEAL:2::0_5:33033 with 8
+DEAL:2::0_4:3313 with 8
 DEAL:2::0_3:322 with 9
 DEAL:2::0_3:323 with 9
 DEAL:2::0_4:3320 with 9
 DEAL:2::0_4:3322 with 9
+DEAL:2::0_4:3323 with 9
 DEAL:2::
 DEAL:2::Number of cell batches: 12
 DEAL:2::0_3:220 with 100000000
@@ -538,8 +538,8 @@ DEAL:2::0_3:300 with 100000000
 DEAL:2::0_3:303 with 100000000
 DEAL:2::0_4:3102 with 100000000
 DEAL:2::0_4:3103 with 100000000
-DEAL:2::0_4:3313 with 100000000
-DEAL:2::0_4:3323 with 100000000
+DEAL:2::0_3:312 with 100000000
+DEAL:2::0_3:313 with 100000000
 DEAL:2::0_4:2232 with 100000000
 DEAL:2::0_4:2233 with 100000000
 DEAL:2::0_3:230 with 100000000
@@ -552,8 +552,6 @@ DEAL:2::0_3:311 with 100000000
 DEAL:2::0_4:3311 with 100000000
 DEAL:2::0_4:3312 with 100000000
 DEAL:2::0_4:3321 with 100000000
-DEAL:2::0_3:312 with 100000000
-DEAL:2::0_3:313 with 100000000
 DEAL:2::0_3:320 with 100000000
 DEAL:2::0_4:3210 with 100000000
 DEAL:2::0_4:3211 with 100000000
@@ -569,8 +567,10 @@ DEAL:2::0_5:33031 with 100000000
 DEAL:2::0_5:33032 with 100000000
 DEAL:2::0_5:33033 with 100000000
 DEAL:2::0_4:3310 with 100000000
+DEAL:2::0_4:3313 with 100000000
 DEAL:2::0_4:3320 with 100000000
 DEAL:2::0_4:3322 with 100000000
+DEAL:2::0_4:3323 with 100000000
 DEAL:2::
 DEAL:2::Number of cell batches: 4
 DEAL:2::0_2:40 with 1
@@ -633,14 +633,14 @@ DEAL:3::1_3:020 with 3
 DEAL:3::1_2:01 with 3
 DEAL:3::1_3:003 with 3
 DEAL:3::1_3:001 with 3
-DEAL:3::1_3:200 with 5
-DEAL:3::1_4:0230 with 5
-DEAL:3::1_3:022 with 5
-DEAL:3::1_3:021 with 5
-DEAL:3::1_4:2023 with 7
-DEAL:3::1_4:2033 with 7
-DEAL:3::1_3:213 with 7
-DEAL:3::1_3:212 with 7
+DEAL:3::1_3:022 with 4
+DEAL:3::1_4:0230 with 4
+DEAL:3::1_4:0231 with 4
+DEAL:3::1_4:0232 with 4
+DEAL:3::1_4:0233 with 4
+DEAL:3::1_3:031 with 4
+DEAL:3::1_3:030 with 4
+DEAL:3::1_3:021 with 4
 DEAL:3::1_2:13 with 3
 DEAL:3::1_2:11 with 3
 DEAL:3::1_3:002 with 3
@@ -657,39 +657,39 @@ DEAL:3::0_4:3330 with 9
 DEAL:3::0_4:3331 with 9
 DEAL:3::0_4:3332 with 9
 DEAL:3::0_4:3333 with 9
-DEAL:3::1_3:030 with 3
-DEAL:3::1_3:031 with 3
+DEAL:3::1_3:120 with 3
+DEAL:3::1_3:121 with 3
 DEAL:3::1_2:10 with 3
-DEAL:3::1_4:0231 with 4
-DEAL:3::1_4:0232 with 4
-DEAL:3::1_3:121 with 4
-DEAL:3::1_3:120 with 4
+DEAL:3::1_3:200 with 5
 DEAL:3::1_3:201 with 5
 DEAL:3::1_3:033 with 5
 DEAL:3::1_3:032 with 5
-DEAL:3::1_4:0233 with 5
 DEAL:3::1_4:2021 with 6
+DEAL:3::1_4:2030 with 6
+DEAL:3::1_4:2031 with 6
+DEAL:3::1_3:212 with 6
+DEAL:3::1_3:213 with 6
 DEAL:3::1_4:2112 with 6
 DEAL:3::1_4:2110 with 6
 DEAL:3::1_3:210 with 6
+DEAL:3::1_4:2023 with 7
 DEAL:3::1_5:20320 with 7
 DEAL:3::1_5:20321 with 7
-DEAL:3::1_4:2031 with 7
-DEAL:3::1_4:2030 with 7
+DEAL:3::1_4:2033 with 7
 DEAL:3::
-DEAL:3::Number of cell batches: 22
+DEAL:3::Number of cell batches: 21
 DEAL:3::1_3:001 with 0
 DEAL:3::1_3:003 with 1
 DEAL:3::1_2:01 with 1
 DEAL:3::1_3:020 with 3
 DEAL:3::1_3:021 with 3
+DEAL:3::1_3:030 with 3
+DEAL:3::1_3:031 with 3
 DEAL:3::1_3:022 with 4
 DEAL:3::1_4:0230 with 4
-DEAL:3::1_3:200 with 5
-DEAL:3::1_3:212 with 6
-DEAL:3::1_3:213 with 6
-DEAL:3::1_4:2023 with 7
-DEAL:3::1_4:2033 with 7
+DEAL:3::1_4:0231 with 4
+DEAL:3::1_4:0232 with 4
+DEAL:3::1_4:0233 with 4
 DEAL:3::1_3:000 with 0
 DEAL:3::1_3:002 with 1
 DEAL:3::1_2:11 with 1
@@ -707,15 +707,11 @@ DEAL:3::0_4:3331 with 9
 DEAL:3::0_4:3332 with 9
 DEAL:3::0_4:3333 with 9
 DEAL:3::1_2:10 with 1
-DEAL:3::1_3:030 with 3
-DEAL:3::1_3:031 with 3
 DEAL:3::1_3:120 with 3
 DEAL:3::1_3:121 with 3
-DEAL:3::1_4:0231 with 4
-DEAL:3::1_4:0232 with 4
-DEAL:3::1_4:0233 with 4
 DEAL:3::1_3:032 with 4
 DEAL:3::1_3:033 with 4
+DEAL:3::1_3:200 with 5
 DEAL:3::1_3:201 with 5
 DEAL:3::1_3:210 with 5
 DEAL:3::1_4:2110 with 5
@@ -723,8 +719,12 @@ DEAL:3::1_4:2112 with 5
 DEAL:3::1_4:2021 with 6
 DEAL:3::1_4:2030 with 6
 DEAL:3::1_4:2031 with 6
+DEAL:3::1_3:212 with 6
+DEAL:3::1_3:213 with 6
+DEAL:3::1_4:2023 with 7
 DEAL:3::1_5:20320 with 7
 DEAL:3::1_5:20321 with 7
+DEAL:3::1_4:2033 with 7
 DEAL:3::
 DEAL:3::Number of cell batches: 12
 DEAL:3::1_3:001 with 100000000
@@ -734,11 +734,11 @@ DEAL:3::1_3:020 with 100000000
 DEAL:3::1_3:021 with 100000000
 DEAL:3::1_3:022 with 100000000
 DEAL:3::1_4:0230 with 100000000
-DEAL:3::1_3:200 with 100000000
-DEAL:3::1_4:2023 with 100000000
-DEAL:3::1_4:2033 with 100000000
-DEAL:3::1_3:212 with 100000000
-DEAL:3::1_3:213 with 100000000
+DEAL:3::1_4:0231 with 100000000
+DEAL:3::1_4:0232 with 100000000
+DEAL:3::1_4:0233 with 100000000
+DEAL:3::1_3:030 with 100000000
+DEAL:3::1_3:031 with 100000000
 DEAL:3::0_4:3330 with 100000000
 DEAL:3::0_4:3331 with 100000000
 DEAL:3::0_4:3332 with 100000000
@@ -755,25 +755,25 @@ DEAL:3::1_5:20322 with 100000000
 DEAL:3::1_5:20323 with 100000000
 DEAL:3::1_4:2111 with 100000000
 DEAL:3::1_4:2113 with 100000000
-DEAL:3::1_4:0231 with 100000000
-DEAL:3::1_4:0232 with 100000000
-DEAL:3::1_4:0233 with 100000000
-DEAL:3::1_3:030 with 100000000
-DEAL:3::1_3:031 with 100000000
 DEAL:3::1_3:032 with 100000000
 DEAL:3::1_3:033 with 100000000
 DEAL:3::1_2:10 with 100000000
 DEAL:3::1_3:120 with 100000000
 DEAL:3::1_3:121 with 100000000
+DEAL:3::1_3:200 with 100000000
 DEAL:3::1_3:201 with 100000000
 DEAL:3::1_4:2021 with 100000000
+DEAL:3::1_4:2023 with 100000000
 DEAL:3::1_4:2030 with 100000000
 DEAL:3::1_4:2031 with 100000000
 DEAL:3::1_5:20320 with 100000000
 DEAL:3::1_5:20321 with 100000000
+DEAL:3::1_4:2033 with 100000000
 DEAL:3::1_3:210 with 100000000
 DEAL:3::1_4:2110 with 100000000
 DEAL:3::1_4:2112 with 100000000
+DEAL:3::1_3:212 with 100000000
+DEAL:3::1_3:213 with 100000000
 DEAL:3::
 DEAL:3::Number of cell batches: 4
 DEAL:3::0_2:70 with 6
@@ -829,18 +829,18 @@ DEAL:3::
 
 
 DEAL:4::Number of cell batches: 12
-DEAL:4::1_4:2210 with 7
-DEAL:4::1_3:301 with 7
-DEAL:4::1_3:300 with 7
-DEAL:4::2_2:00 with 7
 DEAL:4::1_4:2203 with 8
 DEAL:4::1_4:2212 with 8
 DEAL:4::1_4:2213 with 8
-DEAL:4::2_2:03 with 8
-DEAL:4::2_3:121 with 10
-DEAL:4::1_5:22221 with 10
-DEAL:4::1_4:2221 with 10
-DEAL:4::1_4:2220 with 10
+DEAL:4::1_4:2210 with 8
+DEAL:4::1_4:2220 with 9
+DEAL:4::1_4:2221 with 9
+DEAL:4::1_5:22221 with 9
+DEAL:4::1_5:22223 with 9
+DEAL:4::1_4:2223 with 9
+DEAL:4::1_3:223 with 9
+DEAL:4::1_3:232 with 9
+DEAL:4::1_4:2330 with 9
 DEAL:4::1_3:302 with 6
 DEAL:4::2_2:02 with 6
 DEAL:4::1_3:311 with 6
@@ -857,38 +857,38 @@ DEAL:4::2_3:123 with 11
 DEAL:4::2_3:122 with 11
 DEAL:4::1_5:22222 with 11
 DEAL:4::1_5:22220 with 11
+DEAL:4::1_3:300 with 5
+DEAL:4::2_2:00 with 5
 DEAL:4::1_3:303 with 6
+DEAL:4::1_3:312 with 6
 DEAL:4::2_2:01 with 6
+DEAL:4::1_3:301 with 6
 DEAL:4::1_3:320 with 8
 DEAL:4::1_3:321 with 8
 DEAL:4::2_2:10 with 8
-DEAL:4::1_3:312 with 8
-DEAL:4::1_5:22223 with 9
-DEAL:4::1_4:2223 with 9
-DEAL:4::1_3:223 with 9
-DEAL:4::1_3:232 with 9
-DEAL:4::1_4:2330 with 9
+DEAL:4::2_2:03 with 8
 DEAL:4::1_4:2331 with 9
 DEAL:4::1_4:2332 with 9
+DEAL:4::1_4:2333 with 9
 DEAL:4::2_3:120 with 9
 DEAL:4::2_2:11 with 10
+DEAL:4::2_3:121 with 10
 DEAL:4::1_3:323 with 10
 DEAL:4::1_3:322 with 10
-DEAL:4::1_4:2333 with 10
 DEAL:4::
-DEAL:4::Number of cell batches: 21
-DEAL:4::2_2:00 with 2
-DEAL:4::1_3:300 with 5
-DEAL:4::1_3:301 with 5
+DEAL:4::Number of cell batches: 19
 DEAL:4::1_4:2210 with 7
-DEAL:4::2_2:03 with 7
 DEAL:4::1_4:2203 with 8
 DEAL:4::1_4:2212 with 8
 DEAL:4::1_4:2213 with 8
 DEAL:4::1_4:2220 with 9
 DEAL:4::1_4:2221 with 9
 DEAL:4::1_5:22221 with 9
-DEAL:4::2_3:121 with 10
+DEAL:4::1_5:22223 with 9
+DEAL:4::1_4:2223 with 9
+DEAL:4::1_3:223 with 9
+DEAL:4::1_3:232 with 9
+DEAL:4::1_4:2330 with 9
 DEAL:4::1_3:310 with 5
 DEAL:4::1_3:311 with 5
 DEAL:4::2_2:02 with 5
@@ -905,24 +905,24 @@ DEAL:4::1_5:22220 with 9
 DEAL:4::1_5:22222 with 9
 DEAL:4::2_3:122 with 10
 DEAL:4::2_3:123 with 11
+DEAL:4::2_2:00 with 2
+DEAL:4::1_3:300 with 5
+DEAL:4::1_3:301 with 5
 DEAL:4::2_2:01 with 5
 DEAL:4::1_3:303 with 6
 DEAL:4::1_3:312 with 6
+DEAL:4::2_2:03 with 7
 DEAL:4::2_2:10 with 7
 DEAL:4::1_3:320 with 8
 DEAL:4::1_3:321 with 8
 DEAL:4::2_3:120 with 8
-DEAL:4::1_5:22223 with 9
-DEAL:4::1_4:2223 with 9
-DEAL:4::1_3:223 with 9
-DEAL:4::1_3:232 with 9
-DEAL:4::1_4:2330 with 9
 DEAL:4::1_4:2331 with 9
 DEAL:4::1_4:2332 with 9
 DEAL:4::1_4:2333 with 9
 DEAL:4::1_3:322 with 9
 DEAL:4::1_3:323 with 9
 DEAL:4::2_2:11 with 10
+DEAL:4::2_3:121 with 10
 DEAL:4::
 DEAL:4::Number of cell batches: 12
 DEAL:4::1_4:2203 with 100000000
@@ -932,11 +932,11 @@ DEAL:4::1_4:2213 with 100000000
 DEAL:4::1_4:2220 with 100000000
 DEAL:4::1_4:2221 with 100000000
 DEAL:4::1_5:22221 with 100000000
-DEAL:4::1_3:300 with 100000000
-DEAL:4::1_3:301 with 100000000
-DEAL:4::2_2:00 with 100000000
-DEAL:4::2_2:03 with 100000000
-DEAL:4::2_3:121 with 100000000
+DEAL:4::1_5:22223 with 100000000
+DEAL:4::1_4:2223 with 100000000
+DEAL:4::1_3:223 with 100000000
+DEAL:4::1_3:232 with 100000000
+DEAL:4::1_4:2330 with 100000000
 DEAL:4::1_4:2200 with 100000000
 DEAL:4::1_4:2201 with 100000000
 DEAL:4::1_4:2202 with 100000000
@@ -953,30 +953,30 @@ DEAL:4::1_2:33 with 100000000
 DEAL:4::2_2:02 with 100000000
 DEAL:4::2_3:122 with 100000000
 DEAL:4::2_3:123 with 100000000
-DEAL:4::1_5:22223 with 100000000
-DEAL:4::1_4:2223 with 100000000
-DEAL:4::1_3:223 with 100000000
-DEAL:4::1_3:232 with 100000000
-DEAL:4::1_4:2330 with 100000000
 DEAL:4::1_4:2331 with 100000000
 DEAL:4::1_4:2332 with 100000000
 DEAL:4::1_4:2333 with 100000000
+DEAL:4::1_3:300 with 100000000
+DEAL:4::1_3:301 with 100000000
 DEAL:4::1_3:303 with 100000000
 DEAL:4::1_3:312 with 100000000
 DEAL:4::1_3:320 with 100000000
 DEAL:4::1_3:321 with 100000000
 DEAL:4::1_3:322 with 100000000
 DEAL:4::1_3:323 with 100000000
+DEAL:4::2_2:00 with 100000000
 DEAL:4::2_2:01 with 100000000
+DEAL:4::2_2:03 with 100000000
 DEAL:4::2_2:10 with 100000000
 DEAL:4::2_2:11 with 100000000
 DEAL:4::2_3:120 with 100000000
+DEAL:4::2_3:121 with 100000000
 DEAL:4::
 DEAL:4::Number of cell batches: 6
-DEAL:4::1_2:62 with 8
-DEAL:4::1_1:3 with 8
-DEAL:4::1_2:60 with 8
-DEAL:4::1_1:1 with 8
+DEAL:4::0_3:777 with 9
+DEAL:4::1_1:2 with 9
+DEAL:4::1_1:1 with 9
+DEAL:4::1_1:0 with 9
 DEAL:4::0_3:770 with 8
 DEAL:4::0_3:771 with 8
 DEAL:4::0_3:774 with 8
@@ -989,18 +989,18 @@ DEAL:4::0_3:772 with 9
 DEAL:4::0_3:773 with 9
 DEAL:4::0_3:776 with 9
 DEAL:4::1_2:67 with 9
-DEAL:4::1_1:0 with 2
-DEAL:4::1_1:4 with 2
-DEAL:4::0_3:777 with 9
-DEAL:4::1_2:66 with 9
-DEAL:4::1_1:2 with 9
-DEAL:4::1_2:64 with 9
-DEAL:4::
-DEAL:4::Number of cell batches: 14
-DEAL:4::1_1:1 with 2
 DEAL:4::1_2:60 with 6
-DEAL:4::1_1:3 with 7
+DEAL:4::1_1:4 with 6
 DEAL:4::1_2:62 with 8
+DEAL:4::1_2:66 with 8
+DEAL:4::1_1:3 with 8
+DEAL:4::1_2:64 with 8
+DEAL:4::
+DEAL:4::Number of cell batches: 12
+DEAL:4::1_1:0 with 2
+DEAL:4::1_1:1 with 2
+DEAL:4::1_1:2 with 7
+DEAL:4::0_3:777 with 9
 DEAL:4::1_1:5 with 2
 DEAL:4::1_2:61 with 6
 DEAL:4::1_2:65 with 6
@@ -1013,18 +1013,18 @@ DEAL:4::1_2:67 with 8
 DEAL:4::0_3:772 with 9
 DEAL:4::0_3:773 with 9
 DEAL:4::0_3:776 with 9
-DEAL:4::1_1:0 with 2
 DEAL:4::1_1:4 with 2
+DEAL:4::1_2:60 with 6
 DEAL:4::1_2:64 with 6
-DEAL:4::1_1:2 with 7
+DEAL:4::1_1:3 with 7
+DEAL:4::1_2:62 with 8
 DEAL:4::1_2:66 with 8
-DEAL:4::0_3:777 with 9
 DEAL:4::
 DEAL:4::Number of cell batches: 6
+DEAL:4::0_3:777 with 100000000
+DEAL:4::1_1:0 with 100000000
 DEAL:4::1_1:1 with 100000000
-DEAL:4::1_1:3 with 100000000
-DEAL:4::1_2:60 with 100000000
-DEAL:4::1_2:62 with 100000000
+DEAL:4::1_1:2 with 100000000
 DEAL:4::0_3:770 with 100000000
 DEAL:4::0_3:771 with 100000000
 DEAL:4::0_3:772 with 100000000
@@ -1037,10 +1037,10 @@ DEAL:4::1_2:61 with 100000000
 DEAL:4::1_2:63 with 100000000
 DEAL:4::1_2:65 with 100000000
 DEAL:4::1_2:67 with 100000000
-DEAL:4::0_3:777 with 100000000
-DEAL:4::1_1:0 with 100000000
-DEAL:4::1_1:2 with 100000000
+DEAL:4::1_1:3 with 100000000
 DEAL:4::1_1:4 with 100000000
+DEAL:4::1_2:60 with 100000000
+DEAL:4::1_2:62 with 100000000
 DEAL:4::1_2:64 with 100000000
 DEAL:4::1_2:66 with 100000000
 DEAL:4::
@@ -1051,14 +1051,14 @@ DEAL:5::2_3:230 with 11
 DEAL:5::3_3:003 with 11
 DEAL:5::3_3:001 with 11
 DEAL:5::2_2:22 with 11
-DEAL:5::2_3:233 with 13
-DEAL:5::2_2:30 with 13
-DEAL:5::2_3:232 with 13
-DEAL:5::2_3:231 with 13
+DEAL:5::2_3:231 with 12
+DEAL:5::2_3:232 with 12
+DEAL:5::2_2:30 with 12
+DEAL:5::3_2:01 with 12
 DEAL:5::2_3:311 with 15
 DEAL:5::2_3:312 with 15
-DEAL:5::3_3:133 with 15
 DEAL:5::2_3:310 with 15
+DEAL:5::2_3:233 with 15
 DEAL:5::2_3:332 with 17
 DEAL:5::2_3:330 with 17
 DEAL:5::2_3:313 with 17
@@ -1079,34 +1079,34 @@ DEAL:5::2_3:333 with 18
 DEAL:5::2_3:331 with 18
 DEAL:5::3_2:20 with 18
 DEAL:5::3_3:132 with 18
-DEAL:5::3_2:01 with 11
+DEAL:5::3_3:102 with 11
 DEAL:5::3_3:110 with 11
 DEAL:5::3_3:101 with 11
 DEAL:5::3_3:100 with 11
 DEAL:5::3_4:1300 with 12
+DEAL:5::3_4:1301 with 12
 DEAL:5::3_3:112 with 12
 DEAL:5::3_3:103 with 12
-DEAL:5::3_3:102 with 12
 DEAL:5::3_2:02 with 13
 DEAL:5::3_2:03 with 13
 DEAL:5::3_3:120 with 13
 DEAL:5::3_3:121 with 13
-DEAL:5::3_4:1302 with 13
-DEAL:5::3_4:1303 with 13
-DEAL:5::3_3:131 with 13
-DEAL:5::3_4:1301 with 13
+DEAL:5::3_3:133 with 14
+DEAL:5::3_3:131 with 14
+DEAL:5::3_4:1303 with 14
+DEAL:5::3_4:1302 with 14
 DEAL:5::
 DEAL:5::Number of cell batches: 22
 DEAL:5::2_2:22 with 10
 DEAL:5::3_3:001 with 10
 DEAL:5::2_3:230 with 11
 DEAL:5::3_3:003 with 11
+DEAL:5::3_2:01 with 11
 DEAL:5::2_3:231 with 12
 DEAL:5::2_3:232 with 12
 DEAL:5::2_2:30 with 12
 DEAL:5::2_3:233 with 13
 DEAL:5::2_3:310 with 13
-DEAL:5::3_3:133 with 14
 DEAL:5::2_3:311 with 15
 DEAL:5::2_3:312 with 15
 DEAL:5::2_2:32 with 15
@@ -1132,7 +1132,6 @@ DEAL:5::2_3:333 with 18
 DEAL:5::3_3:100 with 10
 DEAL:5::3_3:101 with 10
 DEAL:5::3_3:110 with 10
-DEAL:5::3_2:01 with 11
 DEAL:5::3_3:102 with 11
 DEAL:5::3_3:103 with 11
 DEAL:5::3_3:112 with 11
@@ -1145,6 +1144,7 @@ DEAL:5::3_3:121 with 13
 DEAL:5::3_4:1302 with 13
 DEAL:5::3_4:1303 with 13
 DEAL:5::3_3:131 with 13
+DEAL:5::3_3:133 with 14
 DEAL:5::
 DEAL:5::Number of cell batches: 12
 DEAL:5::2_2:22 with 100000000
@@ -1162,7 +1162,7 @@ DEAL:5::2_3:330 with 100000000
 DEAL:5::2_3:332 with 100000000
 DEAL:5::3_3:001 with 100000000
 DEAL:5::3_3:003 with 100000000
-DEAL:5::3_3:133 with 100000000
+DEAL:5::3_2:01 with 100000000
 DEAL:5::2_3:130 with 100000000
 DEAL:5::2_3:131 with 100000000
 DEAL:5::2_3:132 with 100000000
@@ -1179,7 +1179,6 @@ DEAL:5::3_3:122 with 100000000
 DEAL:5::3_3:123 with 100000000
 DEAL:5::3_3:132 with 100000000
 DEAL:5::3_2:20 with 100000000
-DEAL:5::3_2:01 with 100000000
 DEAL:5::3_2:02 with 100000000
 DEAL:5::3_2:03 with 100000000
 DEAL:5::3_3:100 with 100000000
@@ -1195,12 +1194,13 @@ DEAL:5::3_4:1301 with 100000000
 DEAL:5::3_4:1302 with 100000000
 DEAL:5::3_4:1303 with 100000000
 DEAL:5::3_3:131 with 100000000
+DEAL:5::3_3:133 with 100000000
 DEAL:5::
 DEAL:5::Number of cell batches: 5
-DEAL:5::3_1:7 with 17
-DEAL:5::3_1:5 with 17
-DEAL:5::2_1:6 with 17
-DEAL:5::2_1:5 with 17
+DEAL:5::2_1:7 with 15
+DEAL:5::3_1:0 with 15
+DEAL:5::2_1:6 with 15
+DEAL:5::2_1:5 with 15
 DEAL:5::2_1:1 with 10
 DEAL:5::1_1:7 with 10
 DEAL:5::2_1:4 with 10
@@ -1209,17 +1209,17 @@ DEAL:5::3_1:3 with 17
 DEAL:5::2_1:3 with 17
 DEAL:5::3_1:1 with 17
 DEAL:5::2_1:2 with 17
-DEAL:5::3_1:0 with 12
+DEAL:5::3_1:4 with 12
 DEAL:5::3_1:2 with 17
 DEAL:5::3_1:6 with 17
-DEAL:5::2_1:7 with 17
-DEAL:5::3_1:4 with 17
+DEAL:5::3_1:7 with 17
+DEAL:5::3_1:5 with 17
 DEAL:5::
-DEAL:5::Number of cell batches: 12
+DEAL:5::Number of cell batches: 11
 DEAL:5::2_1:5 with 10
 DEAL:5::2_1:6 with 10
-DEAL:5::3_1:5 with 12
-DEAL:5::3_1:7 with 17
+DEAL:5::3_1:0 with 12
+DEAL:5::2_1:7 with 15
 DEAL:5::2_1:0 with 5
 DEAL:5::2_1:4 with 5
 DEAL:5::1_1:7 with 7
@@ -1228,17 +1228,17 @@ DEAL:5::2_1:2 with 10
 DEAL:5::3_1:1 with 12
 DEAL:5::2_1:3 with 15
 DEAL:5::3_1:3 with 17
-DEAL:5::3_1:0 with 12
 DEAL:5::3_1:4 with 12
-DEAL:5::2_1:7 with 15
+DEAL:5::3_1:5 with 12
 DEAL:5::3_1:2 with 17
 DEAL:5::3_1:6 with 17
+DEAL:5::3_1:7 with 17
 DEAL:5::
 DEAL:5::Number of cell batches: 5
 DEAL:5::2_1:5 with 100000000
 DEAL:5::2_1:6 with 100000000
-DEAL:5::3_1:5 with 100000000
-DEAL:5::3_1:7 with 100000000
+DEAL:5::2_1:7 with 100000000
+DEAL:5::3_1:0 with 100000000
 DEAL:5::1_1:7 with 100000000
 DEAL:5::2_1:0 with 100000000
 DEAL:5::2_1:1 with 100000000
@@ -1247,11 +1247,11 @@ DEAL:5::2_1:3 with 100000000
 DEAL:5::2_1:4 with 100000000
 DEAL:5::3_1:1 with 100000000
 DEAL:5::3_1:3 with 100000000
-DEAL:5::2_1:7 with 100000000
-DEAL:5::3_1:0 with 100000000
 DEAL:5::3_1:2 with 100000000
 DEAL:5::3_1:4 with 100000000
+DEAL:5::3_1:5 with 100000000
 DEAL:5::3_1:6 with 100000000
+DEAL:5::3_1:7 with 100000000
 DEAL:5::
 
 
index 5ca615e91824ffa09c26f3f87f8fd6a22f910d45..e227fd0a0d311390516bf818200bb6accb7098bc 100644 (file)
@@ -8,14 +8,14 @@ DEAL:0::0_5:00100 with 0
 DEAL:0::0_5:00101 with 0
 DEAL:0::0_5:00102 with 0
 DEAL:0::0_5:00103 with 0
-DEAL:0::0_3:022 with 4
-DEAL:0::0_3:013 with 4
-DEAL:0::0_3:012 with 4
-DEAL:0::0_4:0021 with 4
-DEAL:0::0_4:0020 with 4
-DEAL:0::0_4:0013 with 4
-DEAL:0::0_4:0012 with 4
-DEAL:0::0_4:0011 with 4
+DEAL:0::0_5:00220 with 2
+DEAL:0::0_5:00221 with 2
+DEAL:0::0_6:002220 with 2
+DEAL:0::0_4:0021 with 2
+DEAL:0::0_4:0020 with 2
+DEAL:0::0_4:0013 with 2
+DEAL:0::0_4:0012 with 2
+DEAL:0::0_4:0011 with 2
 DEAL:0::0_4:0212 with 3
 DEAL:0::0_4:0213 with 3
 DEAL:0::0_4:0211 with 3
@@ -24,9 +24,6 @@ DEAL:0::0_4:0113 with 3
 DEAL:0::0_4:0111 with 3
 DEAL:0::0_4:0110 with 3
 DEAL:0::0_3:010 with 3
-DEAL:0::0_5:00220 with 2
-DEAL:0::0_5:00221 with 2
-DEAL:0::0_6:002220 with 2
 DEAL:0::0_6:002221 with 2
 DEAL:0::0_6:002222 with 2
 DEAL:0::0_6:002223 with 2
@@ -36,17 +33,20 @@ DEAL:0::0_4:0032 with 2
 DEAL:0::0_5:02000 with 2
 DEAL:0::0_5:02001 with 2
 DEAL:0::0_5:02002 with 2
+DEAL:0::0_5:02003 with 2
+DEAL:0::0_3:013 with 2
+DEAL:0::0_3:012 with 2
 DEAL:0::0_4:0031 with 2
 DEAL:0::0_4:0030 with 2
 DEAL:0::0_4:0112 with 2
-DEAL:0::0_4:0202 with 3
-DEAL:0::0_4:0203 with 3
-DEAL:0::0_4:0210 with 3
-DEAL:0::0_5:02013 with 3
-DEAL:0::0_5:02012 with 3
-DEAL:0::0_5:02011 with 3
-DEAL:0::0_5:02010 with 3
-DEAL:0::0_5:02003 with 3
+DEAL:0::0_3:022 with 4
+DEAL:0::0_4:0203 with 4
+DEAL:0::0_4:0202 with 4
+DEAL:0::0_4:0210 with 4
+DEAL:0::0_5:02013 with 4
+DEAL:0::0_5:02012 with 4
+DEAL:0::0_5:02011 with 4
+DEAL:0::0_5:02010 with 4
 DEAL:0::
 DEAL:0::Number of cell batches: 13
 DEAL:0::0_4:0000 with 0
@@ -62,9 +62,9 @@ DEAL:0::0_4:0012 with 0
 DEAL:0::0_4:0013 with 0
 DEAL:0::0_4:0020 with 1
 DEAL:0::0_4:0021 with 1
-DEAL:0::0_3:012 with 1
-DEAL:0::0_3:013 with 1
-DEAL:0::0_3:022 with 4
+DEAL:0::0_5:00220 with 2
+DEAL:0::0_5:00221 with 2
+DEAL:0::0_6:002220 with 2
 DEAL:0::0_3:010 with 0
 DEAL:0::0_4:0110 with 0
 DEAL:0::0_4:0111 with 0
@@ -76,9 +76,8 @@ DEAL:0::0_4:0213 with 3
 DEAL:0::0_4:0112 with 0
 DEAL:0::0_4:0030 with 1
 DEAL:0::0_4:0031 with 1
-DEAL:0::0_5:00220 with 2
-DEAL:0::0_5:00221 with 2
-DEAL:0::0_6:002220 with 2
+DEAL:0::0_3:012 with 1
+DEAL:0::0_3:013 with 1
 DEAL:0::0_6:002221 with 2
 DEAL:0::0_6:002222 with 2
 DEAL:0::0_6:002223 with 2
@@ -96,6 +95,7 @@ DEAL:0::0_5:02013 with 2
 DEAL:0::0_4:0210 with 2
 DEAL:0::0_4:0202 with 3
 DEAL:0::0_4:0203 with 3
+DEAL:0::0_3:022 with 4
 DEAL:0::
 DEAL:0::Number of cell batches: 6
 DEAL:0::0_4:0000 with 100000000
@@ -111,9 +111,9 @@ DEAL:0::0_4:0012 with 100000000
 DEAL:0::0_4:0013 with 100000000
 DEAL:0::0_4:0020 with 100000000
 DEAL:0::0_4:0021 with 100000000
-DEAL:0::0_3:012 with 100000000
-DEAL:0::0_3:013 with 100000000
-DEAL:0::0_3:022 with 100000000
+DEAL:0::0_5:00220 with 100000000
+DEAL:0::0_5:00221 with 100000000
+DEAL:0::0_6:002220 with 100000000
 DEAL:0::0_4:0033 with 100000000
 DEAL:0::0_3:010 with 100000000
 DEAL:0::0_4:0110 with 100000000
@@ -122,9 +122,6 @@ DEAL:0::0_4:0113 with 100000000
 DEAL:0::0_4:0211 with 100000000
 DEAL:0::0_4:0212 with 100000000
 DEAL:0::0_4:0213 with 100000000
-DEAL:0::0_5:00220 with 100000000
-DEAL:0::0_5:00221 with 100000000
-DEAL:0::0_6:002220 with 100000000
 DEAL:0::0_6:002221 with 100000000
 DEAL:0::0_6:002222 with 100000000
 DEAL:0::0_6:002223 with 100000000
@@ -134,6 +131,8 @@ DEAL:0::0_4:0030 with 100000000
 DEAL:0::0_4:0031 with 100000000
 DEAL:0::0_4:0032 with 100000000
 DEAL:0::0_4:0112 with 100000000
+DEAL:0::0_3:012 with 100000000
+DEAL:0::0_3:013 with 100000000
 DEAL:0::0_5:02000 with 100000000
 DEAL:0::0_5:02001 with 100000000
 DEAL:0::0_5:02002 with 100000000
@@ -145,6 +144,7 @@ DEAL:0::0_5:02013 with 100000000
 DEAL:0::0_4:0202 with 100000000
 DEAL:0::0_4:0203 with 100000000
 DEAL:0::0_4:0210 with 100000000
+DEAL:0::0_3:022 with 100000000
 DEAL:0::
 DEAL:0::Number of cell batches: 2
 DEAL:0::0_2:02 with 3
@@ -199,14 +199,14 @@ DEAL:0::0_2:07 with 100000000
 DEAL:0::
 
 DEAL:1::Number of cell batches: 6
-DEAL:1::0_3:213 with 6
-DEAL:1::0_4:2002 with 6
-DEAL:1::0_3:132 with 6
-DEAL:1::0_3:123 with 6
-DEAL:1::0_3:130 with 6
-DEAL:1::0_3:120 with 6
-DEAL:1::0_2:11 with 6
-DEAL:1::0_3:103 with 6
+DEAL:1::0_4:2002 with 5
+DEAL:1::0_4:2003 with 5
+DEAL:1::0_3:132 with 5
+DEAL:1::0_3:123 with 5
+DEAL:1::0_3:130 with 5
+DEAL:1::0_3:120 with 5
+DEAL:1::0_2:11 with 5
+DEAL:1::0_3:103 with 5
 DEAL:1::0_3:030 with 3
 DEAL:1::0_4:0312 with 3
 DEAL:1::0_4:0313 with 3
@@ -240,14 +240,14 @@ DEAL:1::0_5:20303 with 6
 DEAL:1::0_4:2031 with 6
 DEAL:1::0_4:2120 with 6
 DEAL:1::0_4:2121 with 6
+DEAL:1::0_3:213 with 6
 DEAL:1::0_3:210 with 6
 DEAL:1::0_4:2013 with 6
 DEAL:1::0_4:2012 with 6
 DEAL:1::0_4:2011 with 6
 DEAL:1::0_4:2010 with 6
-DEAL:1::0_4:2003 with 6
 DEAL:1::
-DEAL:1::Number of cell batches: 15
+DEAL:1::Number of cell batches: 14
 DEAL:1::0_3:103 with 1
 DEAL:1::0_2:11 with 1
 DEAL:1::0_3:120 with 3
@@ -255,7 +255,7 @@ DEAL:1::0_3:130 with 3
 DEAL:1::0_3:123 with 4
 DEAL:1::0_3:132 with 4
 DEAL:1::0_4:2002 with 5
-DEAL:1::0_3:213 with 6
+DEAL:1::0_4:2003 with 5
 DEAL:1::0_3:100 with 0
 DEAL:1::0_3:101 with 0
 DEAL:1::0_3:102 with 1
@@ -280,7 +280,6 @@ DEAL:1::0_4:2032 with 7
 DEAL:1::0_4:2033 with 7
 DEAL:1::0_4:2122 with 7
 DEAL:1::0_4:2123 with 7
-DEAL:1::0_4:2003 with 5
 DEAL:1::0_4:2010 with 5
 DEAL:1::0_4:2011 with 5
 DEAL:1::0_4:2012 with 5
@@ -295,6 +294,7 @@ DEAL:1::0_5:20303 with 6
 DEAL:1::0_4:2031 with 6
 DEAL:1::0_4:2120 with 6
 DEAL:1::0_4:2121 with 6
+DEAL:1::0_3:213 with 6
 DEAL:1::
 DEAL:1::Number of cell batches: 6
 DEAL:1::0_3:103 with 100000000
@@ -304,7 +304,7 @@ DEAL:1::0_3:123 with 100000000
 DEAL:1::0_3:130 with 100000000
 DEAL:1::0_3:132 with 100000000
 DEAL:1::0_4:2002 with 100000000
-DEAL:1::0_3:213 with 100000000
+DEAL:1::0_4:2003 with 100000000
 DEAL:1::0_3:023 with 100000000
 DEAL:1::0_3:030 with 100000000
 DEAL:1::0_4:0310 with 100000000
@@ -329,7 +329,6 @@ DEAL:1::0_4:2033 with 100000000
 DEAL:1::0_3:211 with 100000000
 DEAL:1::0_4:2122 with 100000000
 DEAL:1::0_4:2123 with 100000000
-DEAL:1::0_4:2003 with 100000000
 DEAL:1::0_4:2010 with 100000000
 DEAL:1::0_4:2011 with 100000000
 DEAL:1::0_4:2012 with 100000000
@@ -344,6 +343,7 @@ DEAL:1::0_4:2031 with 100000000
 DEAL:1::0_3:210 with 100000000
 DEAL:1::0_4:2120 with 100000000
 DEAL:1::0_4:2121 with 100000000
+DEAL:1::0_3:213 with 100000000
 DEAL:1::
 DEAL:1::Number of cell batches: 3
 DEAL:1::0_2:21 with 6
@@ -430,9 +430,9 @@ DEAL:2::0_3:232 with 9
 DEAL:2::0_4:2330 with 9
 DEAL:2::0_4:2331 with 9
 DEAL:2::0_4:2332 with 9
-DEAL:2::0_4:3323 with 9
-DEAL:2::0_4:3313 with 9
+DEAL:2::0_4:2333 with 9
 DEAL:2::0_3:220 with 9
+DEAL:2::0_3:303 with 9
 DEAL:2::0_3:300 with 9
 DEAL:2::0_3:221 with 8
 DEAL:2::0_3:230 with 8
@@ -452,9 +452,9 @@ DEAL:2::0_4:3312 with 9
 DEAL:2::0_3:231 with 9
 DEAL:2::0_4:3210 with 7
 DEAL:2::0_4:3211 with 7
+DEAL:2::0_4:3300 with 7
 DEAL:2::0_3:313 with 7
 DEAL:2::0_3:312 with 7
-DEAL:2::0_3:303 with 7
 DEAL:2::0_4:3103 with 7
 DEAL:2::0_4:3102 with 7
 DEAL:2::0_3:320 with 8
@@ -462,27 +462,27 @@ DEAL:2::0_4:3212 with 8
 DEAL:2::0_4:3213 with 8
 DEAL:2::0_4:3302 with 8
 DEAL:2::0_5:33030 with 8
+DEAL:2::0_5:33031 with 8
 DEAL:2::0_4:3310 with 8
 DEAL:2::0_4:3301 with 8
-DEAL:2::0_4:3300 with 8
-DEAL:2::0_4:2333 with 9
 DEAL:2::0_3:322 with 9
 DEAL:2::0_3:323 with 9
 DEAL:2::0_4:3320 with 9
 DEAL:2::0_4:3322 with 9
+DEAL:2::0_4:3323 with 9
+DEAL:2::0_4:3313 with 9
 DEAL:2::0_5:33033 with 9
 DEAL:2::0_5:33032 with 9
-DEAL:2::0_5:33031 with 9
 DEAL:2::
-DEAL:2::Number of cell batches: 13
+DEAL:2::Number of cell batches: 15
 DEAL:2::0_3:300 with 5
+DEAL:2::0_3:303 with 6
 DEAL:2::0_3:220 with 8
-DEAL:2::0_4:3313 with 8
 DEAL:2::0_3:232 with 9
 DEAL:2::0_4:2330 with 9
 DEAL:2::0_4:2331 with 9
 DEAL:2::0_4:2332 with 9
-DEAL:2::0_4:3323 with 9
+DEAL:2::0_4:2333 with 9
 DEAL:2::0_3:301 with 5
 DEAL:2::0_4:3100 with 5
 DEAL:2::0_4:3101 with 5
@@ -501,7 +501,6 @@ DEAL:2::0_4:2233 with 9
 DEAL:2::0_4:3321 with 9
 DEAL:2::0_4:3102 with 5
 DEAL:2::0_4:3103 with 5
-DEAL:2::0_3:303 with 6
 DEAL:2::0_3:312 with 6
 DEAL:2::0_3:313 with 6
 DEAL:2::0_4:3210 with 7
@@ -517,11 +516,12 @@ DEAL:2::0_5:33030 with 8
 DEAL:2::0_5:33031 with 8
 DEAL:2::0_5:33032 with 8
 DEAL:2::0_5:33033 with 8
-DEAL:2::0_4:2333 with 9
+DEAL:2::0_4:3313 with 8
 DEAL:2::0_3:322 with 9
 DEAL:2::0_3:323 with 9
 DEAL:2::0_4:3320 with 9
 DEAL:2::0_4:3322 with 9
+DEAL:2::0_4:3323 with 9
 DEAL:2::
 DEAL:2::Number of cell batches: 6
 DEAL:2::0_3:220 with 100000000
@@ -529,9 +529,9 @@ DEAL:2::0_3:232 with 100000000
 DEAL:2::0_4:2330 with 100000000
 DEAL:2::0_4:2331 with 100000000
 DEAL:2::0_4:2332 with 100000000
+DEAL:2::0_4:2333 with 100000000
 DEAL:2::0_3:300 with 100000000
-DEAL:2::0_4:3313 with 100000000
-DEAL:2::0_4:3323 with 100000000
+DEAL:2::0_3:303 with 100000000
 DEAL:2::0_3:221 with 100000000
 DEAL:2::0_3:222 with 100000000
 DEAL:2::0_4:2230 with 100000000
@@ -548,8 +548,6 @@ DEAL:2::0_3:311 with 100000000
 DEAL:2::0_4:3311 with 100000000
 DEAL:2::0_4:3312 with 100000000
 DEAL:2::0_4:3321 with 100000000
-DEAL:2::0_4:2333 with 100000000
-DEAL:2::0_3:303 with 100000000
 DEAL:2::0_4:3102 with 100000000
 DEAL:2::0_4:3103 with 100000000
 DEAL:2::0_3:312 with 100000000
@@ -569,8 +567,10 @@ DEAL:2::0_5:33031 with 100000000
 DEAL:2::0_5:33032 with 100000000
 DEAL:2::0_5:33033 with 100000000
 DEAL:2::0_4:3310 with 100000000
+DEAL:2::0_4:3313 with 100000000
 DEAL:2::0_4:3320 with 100000000
 DEAL:2::0_4:3322 with 100000000
+DEAL:2::0_4:3323 with 100000000
 DEAL:2::
 DEAL:2::Number of cell batches: 2
 DEAL:2::0_2:40 with 1
@@ -629,14 +629,14 @@ DEAL:2::
 
 
 DEAL:3::Number of cell batches: 6
-DEAL:3::1_4:2023 with 7
-DEAL:3::1_4:2033 with 7
-DEAL:3::1_3:213 with 7
-DEAL:3::1_3:212 with 7
-DEAL:3::1_3:200 with 7
-DEAL:3::1_3:022 with 7
-DEAL:3::1_3:020 with 7
-DEAL:3::1_3:001 with 7
+DEAL:3::1_3:022 with 4
+DEAL:3::1_4:0230 with 4
+DEAL:3::1_4:0231 with 4
+DEAL:3::1_3:021 with 4
+DEAL:3::1_3:020 with 4
+DEAL:3::1_2:01 with 4
+DEAL:3::1_3:003 with 4
+DEAL:3::1_3:001 with 4
 DEAL:3::1_4:2111 with 5
 DEAL:3::1_4:2113 with 5
 DEAL:3::1_3:123 with 5
@@ -653,39 +653,39 @@ DEAL:3::1_5:20323 with 9
 DEAL:3::1_5:20322 with 9
 DEAL:3::1_4:2022 with 9
 DEAL:3::1_4:2020 with 9
-DEAL:3::1_3:021 with 3
-DEAL:3::1_3:030 with 3
-DEAL:3::1_3:031 with 3
-DEAL:3::1_3:120 with 3
-DEAL:3::1_2:10 with 3
-DEAL:3::1_2:01 with 3
-DEAL:3::1_3:003 with 3
-DEAL:3::1_3:201 with 5
-DEAL:3::1_3:033 with 5
-DEAL:3::1_3:032 with 5
-DEAL:3::1_4:0233 with 5
-DEAL:3::1_4:0232 with 5
-DEAL:3::1_4:0231 with 5
-DEAL:3::1_4:0230 with 5
-DEAL:3::1_3:121 with 5
+DEAL:3::1_4:0232 with 4
+DEAL:3::1_4:0233 with 4
+DEAL:3::1_3:121 with 4
+DEAL:3::1_3:120 with 4
+DEAL:3::1_3:031 with 4
+DEAL:3::1_3:030 with 4
+DEAL:3::1_2:10 with 4
+DEAL:3::1_4:2021 with 6
+DEAL:3::1_4:2112 with 6
+DEAL:3::1_4:2110 with 6
+DEAL:3::1_3:210 with 6
+DEAL:3::1_3:201 with 6
+DEAL:3::1_3:200 with 6
+DEAL:3::1_3:033 with 6
+DEAL:3::1_3:032 with 6
+DEAL:3::1_4:2023 with 7
 DEAL:3::1_5:20320 with 7
 DEAL:3::1_5:20321 with 7
+DEAL:3::1_4:2033 with 7
+DEAL:3::1_3:213 with 7
+DEAL:3::1_3:212 with 7
 DEAL:3::1_4:2031 with 7
 DEAL:3::1_4:2030 with 7
-DEAL:3::1_4:2021 with 7
-DEAL:3::1_4:2112 with 7
-DEAL:3::1_4:2110 with 7
-DEAL:3::1_3:210 with 7
 DEAL:3::
-DEAL:3::Number of cell batches: 20
+DEAL:3::Number of cell batches: 18
 DEAL:3::1_3:001 with 0
+DEAL:3::1_3:003 with 1
+DEAL:3::1_2:01 with 1
 DEAL:3::1_3:020 with 3
+DEAL:3::1_3:021 with 3
 DEAL:3::1_3:022 with 4
-DEAL:3::1_3:200 with 5
-DEAL:3::1_3:212 with 6
-DEAL:3::1_3:213 with 6
-DEAL:3::1_4:2023 with 7
-DEAL:3::1_4:2033 with 7
+DEAL:3::1_4:0230 with 4
+DEAL:3::1_4:0231 with 4
 DEAL:3::1_3:000 with 0
 DEAL:3::1_3:002 with 1
 DEAL:3::1_2:11 with 1
@@ -702,20 +702,16 @@ DEAL:3::0_4:3330 with 9
 DEAL:3::0_4:3331 with 9
 DEAL:3::0_4:3332 with 9
 DEAL:3::0_4:3333 with 9
-DEAL:3::1_3:003 with 1
-DEAL:3::1_2:01 with 1
 DEAL:3::1_2:10 with 1
-DEAL:3::1_3:021 with 3
 DEAL:3::1_3:030 with 3
 DEAL:3::1_3:031 with 3
 DEAL:3::1_3:120 with 3
 DEAL:3::1_3:121 with 3
-DEAL:3::1_4:0230 with 4
-DEAL:3::1_4:0231 with 4
 DEAL:3::1_4:0232 with 4
 DEAL:3::1_4:0233 with 4
 DEAL:3::1_3:032 with 4
 DEAL:3::1_3:033 with 4
+DEAL:3::1_3:200 with 5
 DEAL:3::1_3:201 with 5
 DEAL:3::1_3:210 with 5
 DEAL:3::1_4:2110 with 5
@@ -723,18 +719,22 @@ DEAL:3::1_4:2112 with 5
 DEAL:3::1_4:2021 with 6
 DEAL:3::1_4:2030 with 6
 DEAL:3::1_4:2031 with 6
+DEAL:3::1_3:212 with 6
+DEAL:3::1_3:213 with 6
+DEAL:3::1_4:2023 with 7
 DEAL:3::1_5:20320 with 7
 DEAL:3::1_5:20321 with 7
+DEAL:3::1_4:2033 with 7
 DEAL:3::
 DEAL:3::Number of cell batches: 6
 DEAL:3::1_3:001 with 100000000
+DEAL:3::1_3:003 with 100000000
+DEAL:3::1_2:01 with 100000000
 DEAL:3::1_3:020 with 100000000
+DEAL:3::1_3:021 with 100000000
 DEAL:3::1_3:022 with 100000000
-DEAL:3::1_3:200 with 100000000
-DEAL:3::1_4:2023 with 100000000
-DEAL:3::1_4:2033 with 100000000
-DEAL:3::1_3:212 with 100000000
-DEAL:3::1_3:213 with 100000000
+DEAL:3::1_4:0230 with 100000000
+DEAL:3::1_4:0231 with 100000000
 DEAL:3::0_4:3330 with 100000000
 DEAL:3::0_4:3331 with 100000000
 DEAL:3::0_4:3332 with 100000000
@@ -751,11 +751,6 @@ DEAL:3::1_5:20322 with 100000000
 DEAL:3::1_5:20323 with 100000000
 DEAL:3::1_4:2111 with 100000000
 DEAL:3::1_4:2113 with 100000000
-DEAL:3::1_3:003 with 100000000
-DEAL:3::1_2:01 with 100000000
-DEAL:3::1_3:021 with 100000000
-DEAL:3::1_4:0230 with 100000000
-DEAL:3::1_4:0231 with 100000000
 DEAL:3::1_4:0232 with 100000000
 DEAL:3::1_4:0233 with 100000000
 DEAL:3::1_3:030 with 100000000
@@ -765,15 +760,20 @@ DEAL:3::1_3:033 with 100000000
 DEAL:3::1_2:10 with 100000000
 DEAL:3::1_3:120 with 100000000
 DEAL:3::1_3:121 with 100000000
+DEAL:3::1_3:200 with 100000000
 DEAL:3::1_3:201 with 100000000
 DEAL:3::1_4:2021 with 100000000
+DEAL:3::1_4:2023 with 100000000
 DEAL:3::1_4:2030 with 100000000
 DEAL:3::1_4:2031 with 100000000
 DEAL:3::1_5:20320 with 100000000
 DEAL:3::1_5:20321 with 100000000
+DEAL:3::1_4:2033 with 100000000
 DEAL:3::1_3:210 with 100000000
 DEAL:3::1_4:2110 with 100000000
 DEAL:3::1_4:2112 with 100000000
+DEAL:3::1_3:212 with 100000000
+DEAL:3::1_3:213 with 100000000
 DEAL:3::
 DEAL:3::Number of cell batches: 2
 DEAL:3::0_2:66 with 8
@@ -829,14 +829,14 @@ DEAL:3::
 
 
 DEAL:4::Number of cell batches: 6
-DEAL:4::2_3:121 with 10
-DEAL:4::1_4:2220 with 10
-DEAL:4::1_4:2203 with 10
-DEAL:4::2_2:03 with 10
-DEAL:4::1_4:2210 with 10
-DEAL:4::1_3:301 with 10
-DEAL:4::1_3:300 with 10
-DEAL:4::2_2:00 with 10
+DEAL:4::1_4:2220 with 9
+DEAL:4::1_4:2221 with 9
+DEAL:4::1_5:22221 with 9
+DEAL:4::1_5:22223 with 9
+DEAL:4::1_4:2213 with 9
+DEAL:4::1_4:2212 with 9
+DEAL:4::1_4:2203 with 9
+DEAL:4::1_4:2210 with 9
 DEAL:4::1_4:2200 with 7
 DEAL:4::1_4:2201 with 7
 DEAL:4::1_4:2211 with 7
@@ -853,38 +853,38 @@ DEAL:4::1_2:33 with 11
 DEAL:4::1_3:231 with 11
 DEAL:4::1_3:230 with 11
 DEAL:4::1_4:2202 with 11
-DEAL:4::1_4:2212 with 8
-DEAL:4::1_4:2213 with 8
-DEAL:4::2_2:10 with 8
-DEAL:4::1_3:312 with 8
-DEAL:4::1_3:303 with 8
-DEAL:4::2_2:01 with 8
-DEAL:4::1_4:2221 with 9
-DEAL:4::1_5:22221 with 9
-DEAL:4::1_5:22223 with 9
+DEAL:4::1_3:303 with 6
+DEAL:4::1_3:312 with 6
+DEAL:4::2_2:01 with 6
+DEAL:4::1_3:301 with 6
+DEAL:4::1_3:300 with 6
+DEAL:4::2_2:00 with 6
 DEAL:4::1_4:2223 with 9
 DEAL:4::1_3:223 with 9
+DEAL:4::1_3:232 with 9
 DEAL:4::2_3:120 with 9
 DEAL:4::1_3:321 with 9
 DEAL:4::1_3:320 with 9
+DEAL:4::2_2:10 with 9
+DEAL:4::2_2:03 with 9
 DEAL:4::2_2:11 with 10
+DEAL:4::2_3:121 with 10
 DEAL:4::1_3:323 with 10
 DEAL:4::1_3:322 with 10
 DEAL:4::1_4:2333 with 10
 DEAL:4::1_4:2332 with 10
 DEAL:4::1_4:2331 with 10
 DEAL:4::1_4:2330 with 10
-DEAL:4::1_3:232 with 10
 DEAL:4::
-DEAL:4::Number of cell batches: 20
-DEAL:4::2_2:00 with 2
-DEAL:4::1_3:300 with 5
-DEAL:4::1_3:301 with 5
+DEAL:4::Number of cell batches: 18
 DEAL:4::1_4:2210 with 7
-DEAL:4::2_2:03 with 7
 DEAL:4::1_4:2203 with 8
+DEAL:4::1_4:2212 with 8
+DEAL:4::1_4:2213 with 8
 DEAL:4::1_4:2220 with 9
-DEAL:4::2_3:121 with 10
+DEAL:4::1_4:2221 with 9
+DEAL:4::1_5:22221 with 9
+DEAL:4::1_5:22223 with 9
 DEAL:4::1_3:310 with 5
 DEAL:4::1_3:311 with 5
 DEAL:4::2_2:02 with 5
@@ -901,18 +901,17 @@ DEAL:4::1_5:22220 with 9
 DEAL:4::1_5:22222 with 9
 DEAL:4::2_3:122 with 10
 DEAL:4::2_3:123 with 11
+DEAL:4::2_2:00 with 2
+DEAL:4::1_3:300 with 5
+DEAL:4::1_3:301 with 5
 DEAL:4::2_2:01 with 5
 DEAL:4::1_3:303 with 6
 DEAL:4::1_3:312 with 6
+DEAL:4::2_2:03 with 7
 DEAL:4::2_2:10 with 7
-DEAL:4::1_4:2212 with 8
-DEAL:4::1_4:2213 with 8
 DEAL:4::1_3:320 with 8
 DEAL:4::1_3:321 with 8
 DEAL:4::2_3:120 with 8
-DEAL:4::1_4:2221 with 9
-DEAL:4::1_5:22221 with 9
-DEAL:4::1_5:22223 with 9
 DEAL:4::1_4:2223 with 9
 DEAL:4::1_3:223 with 9
 DEAL:4::1_3:232 with 9
@@ -923,16 +922,17 @@ DEAL:4::1_4:2333 with 9
 DEAL:4::1_3:322 with 9
 DEAL:4::1_3:323 with 9
 DEAL:4::2_2:11 with 10
+DEAL:4::2_3:121 with 10
 DEAL:4::
 DEAL:4::Number of cell batches: 6
 DEAL:4::1_4:2203 with 100000000
 DEAL:4::1_4:2210 with 100000000
+DEAL:4::1_4:2212 with 100000000
+DEAL:4::1_4:2213 with 100000000
 DEAL:4::1_4:2220 with 100000000
-DEAL:4::1_3:300 with 100000000
-DEAL:4::1_3:301 with 100000000
-DEAL:4::2_2:00 with 100000000
-DEAL:4::2_2:03 with 100000000
-DEAL:4::2_3:121 with 100000000
+DEAL:4::1_4:2221 with 100000000
+DEAL:4::1_5:22221 with 100000000
+DEAL:4::1_5:22223 with 100000000
 DEAL:4::1_4:2200 with 100000000
 DEAL:4::1_4:2201 with 100000000
 DEAL:4::1_4:2202 with 100000000
@@ -949,11 +949,6 @@ DEAL:4::1_2:33 with 100000000
 DEAL:4::2_2:02 with 100000000
 DEAL:4::2_3:122 with 100000000
 DEAL:4::2_3:123 with 100000000
-DEAL:4::1_4:2212 with 100000000
-DEAL:4::1_4:2213 with 100000000
-DEAL:4::1_4:2221 with 100000000
-DEAL:4::1_5:22221 with 100000000
-DEAL:4::1_5:22223 with 100000000
 DEAL:4::1_4:2223 with 100000000
 DEAL:4::1_3:223 with 100000000
 DEAL:4::1_3:232 with 100000000
@@ -961,16 +956,21 @@ DEAL:4::1_4:2330 with 100000000
 DEAL:4::1_4:2331 with 100000000
 DEAL:4::1_4:2332 with 100000000
 DEAL:4::1_4:2333 with 100000000
+DEAL:4::1_3:300 with 100000000
+DEAL:4::1_3:301 with 100000000
 DEAL:4::1_3:303 with 100000000
 DEAL:4::1_3:312 with 100000000
 DEAL:4::1_3:320 with 100000000
 DEAL:4::1_3:321 with 100000000
 DEAL:4::1_3:322 with 100000000
 DEAL:4::1_3:323 with 100000000
+DEAL:4::2_2:00 with 100000000
 DEAL:4::2_2:01 with 100000000
+DEAL:4::2_2:03 with 100000000
 DEAL:4::2_2:10 with 100000000
 DEAL:4::2_2:11 with 100000000
 DEAL:4::2_3:120 with 100000000
+DEAL:4::2_3:121 with 100000000
 DEAL:4::
 DEAL:4::Number of cell batches: 3
 DEAL:4::0_3:770 with 8
@@ -1047,22 +1047,22 @@ DEAL:4::
 
 
 DEAL:5::Number of cell batches: 6
-DEAL:5::2_3:233 with 13
-DEAL:5::2_2:30 with 13
-DEAL:5::2_3:232 with 13
-DEAL:5::2_3:231 with 13
-DEAL:5::3_3:003 with 13
-DEAL:5::2_3:230 with 13
-DEAL:5::3_3:001 with 13
-DEAL:5::2_2:22 with 13
+DEAL:5::2_3:231 with 12
+DEAL:5::2_3:232 with 12
+DEAL:5::2_2:30 with 12
+DEAL:5::3_2:01 with 12
+DEAL:5::3_3:003 with 12
+DEAL:5::2_3:230 with 12
+DEAL:5::3_3:001 with 12
+DEAL:5::2_2:22 with 12
 DEAL:5::2_3:332 with 17
 DEAL:5::2_3:330 with 17
 DEAL:5::2_3:313 with 17
 DEAL:5::2_2:32 with 17
 DEAL:5::2_3:312 with 17
 DEAL:5::2_3:311 with 17
-DEAL:5::3_3:133 with 17
 DEAL:5::2_3:310 with 17
+DEAL:5::2_3:233 with 17
 DEAL:5::2_3:131 with 12
 DEAL:5::3_3:113 with 12
 DEAL:5::3_3:002 with 12
@@ -1080,33 +1080,33 @@ DEAL:5::3_3:122 with 18
 DEAL:5::2_3:133 with 18
 DEAL:5::2_3:132 with 18
 DEAL:5::3_4:1300 with 12
+DEAL:5::3_4:1301 with 12
 DEAL:5::3_3:112 with 12
 DEAL:5::3_3:103 with 12
 DEAL:5::3_3:102 with 12
-DEAL:5::3_2:01 with 12
 DEAL:5::3_3:110 with 12
 DEAL:5::3_3:101 with 12
 DEAL:5::3_3:100 with 12
-DEAL:5::3_2:02 with 13
-DEAL:5::3_2:03 with 13
-DEAL:5::3_3:120 with 13
-DEAL:5::3_3:121 with 13
-DEAL:5::3_4:1302 with 13
-DEAL:5::3_4:1303 with 13
-DEAL:5::3_3:131 with 13
-DEAL:5::3_4:1301 with 13
+DEAL:5::3_3:133 with 14
+DEAL:5::3_3:131 with 14
+DEAL:5::3_4:1303 with 14
+DEAL:5::3_4:1302 with 14
+DEAL:5::3_3:121 with 14
+DEAL:5::3_3:120 with 14
+DEAL:5::3_2:03 with 14
+DEAL:5::3_2:02 with 14
 DEAL:5::
 DEAL:5::Number of cell batches: 21
 DEAL:5::2_2:22 with 10
 DEAL:5::3_3:001 with 10
 DEAL:5::2_3:230 with 11
 DEAL:5::3_3:003 with 11
+DEAL:5::3_2:01 with 11
 DEAL:5::2_3:231 with 12
 DEAL:5::2_3:232 with 12
 DEAL:5::2_2:30 with 12
 DEAL:5::2_3:233 with 13
 DEAL:5::2_3:310 with 13
-DEAL:5::3_3:133 with 14
 DEAL:5::2_3:311 with 15
 DEAL:5::2_3:312 with 15
 DEAL:5::2_2:32 with 15
@@ -1132,7 +1132,6 @@ DEAL:5::2_3:333 with 18
 DEAL:5::3_3:100 with 10
 DEAL:5::3_3:101 with 10
 DEAL:5::3_3:110 with 10
-DEAL:5::3_2:01 with 11
 DEAL:5::3_3:102 with 11
 DEAL:5::3_3:103 with 11
 DEAL:5::3_3:112 with 11
@@ -1145,6 +1144,7 @@ DEAL:5::3_3:121 with 13
 DEAL:5::3_4:1302 with 13
 DEAL:5::3_4:1303 with 13
 DEAL:5::3_3:131 with 13
+DEAL:5::3_3:133 with 14
 DEAL:5::
 DEAL:5::Number of cell batches: 6
 DEAL:5::2_2:22 with 100000000
@@ -1162,7 +1162,7 @@ DEAL:5::2_3:330 with 100000000
 DEAL:5::2_3:332 with 100000000
 DEAL:5::3_3:001 with 100000000
 DEAL:5::3_3:003 with 100000000
-DEAL:5::3_3:133 with 100000000
+DEAL:5::3_2:01 with 100000000
 DEAL:5::2_3:130 with 100000000
 DEAL:5::2_3:131 with 100000000
 DEAL:5::2_3:132 with 100000000
@@ -1179,7 +1179,6 @@ DEAL:5::3_3:122 with 100000000
 DEAL:5::3_3:123 with 100000000
 DEAL:5::3_3:132 with 100000000
 DEAL:5::3_2:20 with 100000000
-DEAL:5::3_2:01 with 100000000
 DEAL:5::3_2:02 with 100000000
 DEAL:5::3_2:03 with 100000000
 DEAL:5::3_3:100 with 100000000
@@ -1195,6 +1194,7 @@ DEAL:5::3_4:1301 with 100000000
 DEAL:5::3_4:1302 with 100000000
 DEAL:5::3_4:1303 with 100000000
 DEAL:5::3_3:131 with 100000000
+DEAL:5::3_3:133 with 100000000
 DEAL:5::
 DEAL:5::Number of cell batches: 3
 DEAL:5::3_1:3 with 17
index 0a699d1303847f96c00a5387aa0ecf09c119afdb..43fc6692d28140c000fd097f73ea3cb033df1193 100644 (file)
@@ -13,14 +13,14 @@ DEAL:0::0_4:0012 with 0
 DEAL:0::0_4:0013 with 0
 DEAL:0::0_4:0020 with 1
 DEAL:0::0_4:0021 with 1
-DEAL:0::0_3:012 with 1
-DEAL:0::0_3:013 with 1
 DEAL:0::0_5:00220 with 2
 DEAL:0::0_5:00221 with 2
 DEAL:0::0_6:002220 with 2
 DEAL:0::0_6:002221 with 2
 DEAL:0::0_6:002222 with 2
-DEAL:0::0_3:022 with 4
+DEAL:0::0_6:002223 with 2
+DEAL:0::0_5:00223 with 2
+DEAL:0::0_4:0023 with 2
 DEAL:0::0_4:0111 with 0
 DEAL:0::0_4:0113 with 0
 DEAL:0::0_4:0211 with 2
@@ -31,9 +31,8 @@ DEAL:0::0_4:0110 with 0
 DEAL:0::0_4:0112 with 0
 DEAL:0::0_4:0030 with 1
 DEAL:0::0_4:0031 with 1
-DEAL:0::0_6:002223 with 2
-DEAL:0::0_5:00223 with 2
-DEAL:0::0_4:0023 with 2
+DEAL:0::0_3:012 with 1
+DEAL:0::0_3:013 with 1
 DEAL:0::0_4:0032 with 2
 DEAL:0::0_4:0033 with 2
 DEAL:0::0_5:02000 with 2
@@ -47,6 +46,7 @@ DEAL:0::0_5:02013 with 2
 DEAL:0::0_4:0210 with 2
 DEAL:0::0_4:0202 with 3
 DEAL:0::0_4:0203 with 3
+DEAL:0::0_3:022 with 4
 DEAL:0::
 DEAL:0::Number of cell batches: 47
 DEAL:0::0_4:0000 with 0
@@ -62,14 +62,14 @@ DEAL:0::0_4:0012 with 0
 DEAL:0::0_4:0013 with 0
 DEAL:0::0_4:0020 with 1
 DEAL:0::0_4:0021 with 1
-DEAL:0::0_3:012 with 1
-DEAL:0::0_3:013 with 1
 DEAL:0::0_5:00220 with 2
 DEAL:0::0_5:00221 with 2
 DEAL:0::0_6:002220 with 2
 DEAL:0::0_6:002221 with 2
 DEAL:0::0_6:002222 with 2
-DEAL:0::0_3:022 with 4
+DEAL:0::0_6:002223 with 2
+DEAL:0::0_5:00223 with 2
+DEAL:0::0_4:0023 with 2
 DEAL:0::0_4:0111 with 0
 DEAL:0::0_4:0113 with 0
 DEAL:0::0_4:0211 with 2
@@ -80,9 +80,8 @@ DEAL:0::0_4:0110 with 0
 DEAL:0::0_4:0112 with 0
 DEAL:0::0_4:0030 with 1
 DEAL:0::0_4:0031 with 1
-DEAL:0::0_6:002223 with 2
-DEAL:0::0_5:00223 with 2
-DEAL:0::0_4:0023 with 2
+DEAL:0::0_3:012 with 1
+DEAL:0::0_3:013 with 1
 DEAL:0::0_4:0032 with 2
 DEAL:0::0_4:0033 with 2
 DEAL:0::0_5:02000 with 2
@@ -96,6 +95,7 @@ DEAL:0::0_5:02013 with 2
 DEAL:0::0_4:0210 with 2
 DEAL:0::0_4:0202 with 3
 DEAL:0::0_4:0203 with 3
+DEAL:0::0_3:022 with 4
 DEAL:0::
 DEAL:0::Number of cell batches: 47
 DEAL:0::0_4:0000 with 100000000
@@ -116,17 +116,14 @@ DEAL:0::0_5:00221 with 100000000
 DEAL:0::0_6:002220 with 100000000
 DEAL:0::0_6:002221 with 100000000
 DEAL:0::0_6:002222 with 100000000
-DEAL:0::0_3:012 with 100000000
-DEAL:0::0_3:013 with 100000000
-DEAL:0::0_3:022 with 100000000
+DEAL:0::0_6:002223 with 100000000
+DEAL:0::0_5:00223 with 100000000
+DEAL:0::0_4:0023 with 100000000
 DEAL:0::0_4:0111 with 100000000
 DEAL:0::0_4:0113 with 100000000
 DEAL:0::0_4:0211 with 100000000
 DEAL:0::0_4:0212 with 100000000
 DEAL:0::0_4:0213 with 100000000
-DEAL:0::0_6:002223 with 100000000
-DEAL:0::0_5:00223 with 100000000
-DEAL:0::0_4:0023 with 100000000
 DEAL:0::0_4:0030 with 100000000
 DEAL:0::0_4:0031 with 100000000
 DEAL:0::0_4:0032 with 100000000
@@ -134,6 +131,8 @@ DEAL:0::0_4:0033 with 100000000
 DEAL:0::0_3:010 with 100000000
 DEAL:0::0_4:0110 with 100000000
 DEAL:0::0_4:0112 with 100000000
+DEAL:0::0_3:012 with 100000000
+DEAL:0::0_3:013 with 100000000
 DEAL:0::0_5:02000 with 100000000
 DEAL:0::0_5:02001 with 100000000
 DEAL:0::0_5:02002 with 100000000
@@ -145,57 +144,58 @@ DEAL:0::0_5:02013 with 100000000
 DEAL:0::0_4:0202 with 100000000
 DEAL:0::0_4:0203 with 100000000
 DEAL:0::0_4:0210 with 100000000
+DEAL:0::0_3:022 with 100000000
 DEAL:0::
 DEAL:0::Number of cell batches: 15
 DEAL:0::0_3:000 with 0
 DEAL:0::0_3:001 with 0
+DEAL:0::0_3:004 with 0
 DEAL:0::0_3:002 with 1
-DEAL:0::0_2:03 with 3
-DEAL:0::0_2:07 with 3
+DEAL:0::0_3:003 with 1
 DEAL:0::0_2:01 with 1
 DEAL:0::0_2:04 with 1
 DEAL:0::0_2:05 with 1
 DEAL:0::0_2:02 with 3
 DEAL:0::0_2:06 with 3
-DEAL:0::0_3:004 with 0
 DEAL:0::0_3:005 with 0
-DEAL:0::0_3:003 with 1
 DEAL:0::0_3:006 with 1
 DEAL:0::0_3:007 with 1
+DEAL:0::0_2:03 with 3
+DEAL:0::0_2:07 with 3
 DEAL:0::
 DEAL:0::Number of cell batches: 15
 DEAL:0::0_3:000 with 0
 DEAL:0::0_3:001 with 0
+DEAL:0::0_3:004 with 0
 DEAL:0::0_3:002 with 1
-DEAL:0::0_2:03 with 3
-DEAL:0::0_2:07 with 3
+DEAL:0::0_3:003 with 1
 DEAL:0::0_2:01 with 1
 DEAL:0::0_2:04 with 1
 DEAL:0::0_2:05 with 1
 DEAL:0::0_2:02 with 3
 DEAL:0::0_2:06 with 3
-DEAL:0::0_3:004 with 0
 DEAL:0::0_3:005 with 0
-DEAL:0::0_3:003 with 1
 DEAL:0::0_3:006 with 1
 DEAL:0::0_3:007 with 1
+DEAL:0::0_2:03 with 3
+DEAL:0::0_2:07 with 3
 DEAL:0::
 DEAL:0::Number of cell batches: 15
 DEAL:0::0_3:000 with 100000000
 DEAL:0::0_3:001 with 100000000
 DEAL:0::0_3:002 with 100000000
-DEAL:0::0_2:03 with 100000000
-DEAL:0::0_2:07 with 100000000
+DEAL:0::0_3:003 with 100000000
+DEAL:0::0_3:004 with 100000000
 DEAL:0::0_2:01 with 100000000
 DEAL:0::0_2:02 with 100000000
 DEAL:0::0_2:04 with 100000000
 DEAL:0::0_2:05 with 100000000
 DEAL:0::0_2:06 with 100000000
-DEAL:0::0_3:003 with 100000000
-DEAL:0::0_3:004 with 100000000
 DEAL:0::0_3:005 with 100000000
 DEAL:0::0_3:006 with 100000000
 DEAL:0::0_3:007 with 100000000
+DEAL:0::0_2:03 with 100000000
+DEAL:0::0_2:07 with 100000000
 DEAL:0::
 
 DEAL:1::Number of cell batches: 47
@@ -213,7 +213,7 @@ DEAL:1::0_3:033 with 4
 DEAL:1::0_3:123 with 4
 DEAL:1::0_3:132 with 4
 DEAL:1::0_4:2002 with 5
-DEAL:1::0_3:213 with 6
+DEAL:1::0_4:2003 with 5
 DEAL:1::0_3:102 with 1
 DEAL:1::0_4:0310 with 2
 DEAL:1::0_4:0311 with 2
@@ -231,7 +231,6 @@ DEAL:1::0_4:2032 with 7
 DEAL:1::0_4:2033 with 7
 DEAL:1::0_4:2122 with 7
 DEAL:1::0_4:2123 with 7
-DEAL:1::0_4:2003 with 5
 DEAL:1::0_4:2010 with 5
 DEAL:1::0_4:2011 with 5
 DEAL:1::0_4:2012 with 5
@@ -246,6 +245,7 @@ DEAL:1::0_5:20303 with 6
 DEAL:1::0_4:2031 with 6
 DEAL:1::0_4:2120 with 6
 DEAL:1::0_4:2121 with 6
+DEAL:1::0_3:213 with 6
 DEAL:1::
 DEAL:1::Number of cell batches: 47
 DEAL:1::0_3:100 with 0
@@ -262,7 +262,7 @@ DEAL:1::0_3:033 with 4
 DEAL:1::0_3:123 with 4
 DEAL:1::0_3:132 with 4
 DEAL:1::0_4:2002 with 5
-DEAL:1::0_3:213 with 6
+DEAL:1::0_4:2003 with 5
 DEAL:1::0_3:102 with 1
 DEAL:1::0_4:0310 with 2
 DEAL:1::0_4:0311 with 2
@@ -280,7 +280,6 @@ DEAL:1::0_4:2032 with 7
 DEAL:1::0_4:2033 with 7
 DEAL:1::0_4:2122 with 7
 DEAL:1::0_4:2123 with 7
-DEAL:1::0_4:2003 with 5
 DEAL:1::0_4:2010 with 5
 DEAL:1::0_4:2011 with 5
 DEAL:1::0_4:2012 with 5
@@ -295,6 +294,7 @@ DEAL:1::0_5:20303 with 6
 DEAL:1::0_4:2031 with 6
 DEAL:1::0_4:2120 with 6
 DEAL:1::0_4:2121 with 6
+DEAL:1::0_3:213 with 6
 DEAL:1::
 DEAL:1::Number of cell batches: 47
 DEAL:1::0_4:0312 with 100000000
@@ -311,7 +311,7 @@ DEAL:1::0_3:123 with 100000000
 DEAL:1::0_3:130 with 100000000
 DEAL:1::0_3:132 with 100000000
 DEAL:1::0_4:2002 with 100000000
-DEAL:1::0_3:213 with 100000000
+DEAL:1::0_4:2003 with 100000000
 DEAL:1::0_3:023 with 100000000
 DEAL:1::0_3:030 with 100000000
 DEAL:1::0_4:0310 with 100000000
@@ -329,7 +329,6 @@ DEAL:1::0_4:2033 with 100000000
 DEAL:1::0_3:211 with 100000000
 DEAL:1::0_4:2122 with 100000000
 DEAL:1::0_4:2123 with 100000000
-DEAL:1::0_4:2003 with 100000000
 DEAL:1::0_4:2010 with 100000000
 DEAL:1::0_4:2011 with 100000000
 DEAL:1::0_4:2012 with 100000000
@@ -344,12 +343,13 @@ DEAL:1::0_4:2031 with 100000000
 DEAL:1::0_3:210 with 100000000
 DEAL:1::0_4:2120 with 100000000
 DEAL:1::0_4:2121 with 100000000
+DEAL:1::0_3:213 with 100000000
 DEAL:1::
 DEAL:1::Number of cell batches: 24
 DEAL:1::0_2:10 with 1
 DEAL:1::0_2:20 with 6
-DEAL:1::0_2:34 with 6
-DEAL:1::0_2:36 with 8
+DEAL:1::0_2:22 with 8
+DEAL:1::0_2:23 with 8
 DEAL:1::0_2:11 with 1
 DEAL:1::0_2:14 with 1
 DEAL:1::0_2:15 with 1
@@ -367,15 +367,15 @@ DEAL:1::0_2:27 with 8
 DEAL:1::0_2:33 with 8
 DEAL:1::0_2:37 with 8
 DEAL:1::0_2:30 with 6
-DEAL:1::0_2:22 with 8
-DEAL:1::0_2:23 with 8
+DEAL:1::0_2:34 with 6
 DEAL:1::0_2:32 with 8
+DEAL:1::0_2:36 with 8
 DEAL:1::
 DEAL:1::Number of cell batches: 24
 DEAL:1::0_2:10 with 1
 DEAL:1::0_2:20 with 6
-DEAL:1::0_2:34 with 6
-DEAL:1::0_2:36 with 8
+DEAL:1::0_2:22 with 8
+DEAL:1::0_2:23 with 8
 DEAL:1::0_2:11 with 1
 DEAL:1::0_2:14 with 1
 DEAL:1::0_2:15 with 1
@@ -393,15 +393,15 @@ DEAL:1::0_2:27 with 8
 DEAL:1::0_2:33 with 8
 DEAL:1::0_2:37 with 8
 DEAL:1::0_2:30 with 6
-DEAL:1::0_2:22 with 8
-DEAL:1::0_2:23 with 8
+DEAL:1::0_2:34 with 6
 DEAL:1::0_2:32 with 8
+DEAL:1::0_2:36 with 8
 DEAL:1::
 DEAL:1::Number of cell batches: 24
 DEAL:1::0_2:10 with 100000000
 DEAL:1::0_2:20 with 100000000
-DEAL:1::0_2:34 with 100000000
-DEAL:1::0_2:36 with 100000000
+DEAL:1::0_2:22 with 100000000
+DEAL:1::0_2:23 with 100000000
 DEAL:1::0_2:11 with 100000000
 DEAL:1::0_2:12 with 100000000
 DEAL:1::0_2:13 with 100000000
@@ -418,10 +418,10 @@ DEAL:1::0_2:31 with 100000000
 DEAL:1::0_2:33 with 100000000
 DEAL:1::0_2:35 with 100000000
 DEAL:1::0_2:37 with 100000000
-DEAL:1::0_2:22 with 100000000
-DEAL:1::0_2:23 with 100000000
 DEAL:1::0_2:30 with 100000000
 DEAL:1::0_2:32 with 100000000
+DEAL:1::0_2:34 with 100000000
+DEAL:1::0_2:36 with 100000000
 DEAL:1::
 
 
@@ -430,10 +430,11 @@ DEAL:2::0_3:300 with 5
 DEAL:2::0_4:3102 with 5
 DEAL:2::0_4:3103 with 5
 DEAL:2::0_3:303 with 6
+DEAL:2::0_3:312 with 6
+DEAL:2::0_3:313 with 6
 DEAL:2::0_3:220 with 8
 DEAL:2::0_3:221 with 8
 DEAL:2::0_3:230 with 8
-DEAL:2::0_4:3313 with 8
 DEAL:2::0_3:222 with 9
 DEAL:2::0_4:2230 with 9
 DEAL:2::0_4:2231 with 9
@@ -444,7 +445,6 @@ DEAL:2::0_4:2330 with 9
 DEAL:2::0_4:2331 with 9
 DEAL:2::0_4:2332 with 9
 DEAL:2::0_4:2333 with 9
-DEAL:2::0_4:3323 with 9
 DEAL:2::0_3:301 with 5
 DEAL:2::0_4:3100 with 5
 DEAL:2::0_4:3101 with 5
@@ -454,8 +454,6 @@ DEAL:2::0_4:3311 with 7
 DEAL:2::0_3:231 with 8
 DEAL:2::0_4:3312 with 8
 DEAL:2::0_4:3321 with 9
-DEAL:2::0_3:312 with 6
-DEAL:2::0_3:313 with 6
 DEAL:2::0_4:3210 with 7
 DEAL:2::0_4:3211 with 7
 DEAL:2::0_4:3300 with 7
@@ -469,20 +467,23 @@ DEAL:2::0_5:33030 with 8
 DEAL:2::0_5:33031 with 8
 DEAL:2::0_5:33032 with 8
 DEAL:2::0_5:33033 with 8
+DEAL:2::0_4:3313 with 8
 DEAL:2::0_3:322 with 9
 DEAL:2::0_3:323 with 9
 DEAL:2::0_4:3320 with 9
 DEAL:2::0_4:3322 with 9
+DEAL:2::0_4:3323 with 9
 DEAL:2::
 DEAL:2::Number of cell batches: 47
 DEAL:2::0_3:300 with 5
 DEAL:2::0_4:3102 with 5
 DEAL:2::0_4:3103 with 5
 DEAL:2::0_3:303 with 6
+DEAL:2::0_3:312 with 6
+DEAL:2::0_3:313 with 6
 DEAL:2::0_3:220 with 8
 DEAL:2::0_3:221 with 8
 DEAL:2::0_3:230 with 8
-DEAL:2::0_4:3313 with 8
 DEAL:2::0_3:222 with 9
 DEAL:2::0_4:2230 with 9
 DEAL:2::0_4:2231 with 9
@@ -493,7 +494,6 @@ DEAL:2::0_4:2330 with 9
 DEAL:2::0_4:2331 with 9
 DEAL:2::0_4:2332 with 9
 DEAL:2::0_4:2333 with 9
-DEAL:2::0_4:3323 with 9
 DEAL:2::0_3:301 with 5
 DEAL:2::0_4:3100 with 5
 DEAL:2::0_4:3101 with 5
@@ -503,8 +503,6 @@ DEAL:2::0_4:3311 with 7
 DEAL:2::0_3:231 with 8
 DEAL:2::0_4:3312 with 8
 DEAL:2::0_4:3321 with 9
-DEAL:2::0_3:312 with 6
-DEAL:2::0_3:313 with 6
 DEAL:2::0_4:3210 with 7
 DEAL:2::0_4:3211 with 7
 DEAL:2::0_4:3300 with 7
@@ -518,10 +516,12 @@ DEAL:2::0_5:33030 with 8
 DEAL:2::0_5:33031 with 8
 DEAL:2::0_5:33032 with 8
 DEAL:2::0_5:33033 with 8
+DEAL:2::0_4:3313 with 8
 DEAL:2::0_3:322 with 9
 DEAL:2::0_3:323 with 9
 DEAL:2::0_4:3320 with 9
 DEAL:2::0_4:3322 with 9
+DEAL:2::0_4:3323 with 9
 DEAL:2::
 DEAL:2::Number of cell batches: 47
 DEAL:2::0_3:220 with 100000000
@@ -541,8 +541,8 @@ DEAL:2::0_3:300 with 100000000
 DEAL:2::0_3:303 with 100000000
 DEAL:2::0_4:3102 with 100000000
 DEAL:2::0_4:3103 with 100000000
-DEAL:2::0_4:3313 with 100000000
-DEAL:2::0_4:3323 with 100000000
+DEAL:2::0_3:312 with 100000000
+DEAL:2::0_3:313 with 100000000
 DEAL:2::0_3:231 with 100000000
 DEAL:2::0_3:301 with 100000000
 DEAL:2::0_3:302 with 100000000
@@ -552,8 +552,6 @@ DEAL:2::0_3:311 with 100000000
 DEAL:2::0_4:3311 with 100000000
 DEAL:2::0_4:3312 with 100000000
 DEAL:2::0_4:3321 with 100000000
-DEAL:2::0_3:312 with 100000000
-DEAL:2::0_3:313 with 100000000
 DEAL:2::0_3:320 with 100000000
 DEAL:2::0_4:3210 with 100000000
 DEAL:2::0_4:3211 with 100000000
@@ -569,13 +567,15 @@ DEAL:2::0_5:33031 with 100000000
 DEAL:2::0_5:33032 with 100000000
 DEAL:2::0_5:33033 with 100000000
 DEAL:2::0_4:3310 with 100000000
+DEAL:2::0_4:3313 with 100000000
 DEAL:2::0_4:3320 with 100000000
 DEAL:2::0_4:3322 with 100000000
+DEAL:2::0_4:3323 with 100000000
 DEAL:2::
 DEAL:2::Number of cell batches: 16
 DEAL:2::0_2:40 with 1
 DEAL:2::0_2:41 with 1
-DEAL:2::0_2:50 with 1
+DEAL:2::0_2:44 with 1
 DEAL:2::0_2:51 with 1
 DEAL:2::0_2:55 with 1
 DEAL:2::0_2:42 with 3
@@ -585,15 +585,15 @@ DEAL:2::0_2:47 with 3
 DEAL:2::0_2:52 with 3
 DEAL:2::0_2:53 with 3
 DEAL:2::0_2:57 with 3
-DEAL:2::0_2:44 with 1
 DEAL:2::0_2:45 with 1
+DEAL:2::0_2:50 with 1
 DEAL:2::0_2:54 with 1
 DEAL:2::0_2:56 with 3
 DEAL:2::
 DEAL:2::Number of cell batches: 16
 DEAL:2::0_2:40 with 1
 DEAL:2::0_2:41 with 1
-DEAL:2::0_2:50 with 1
+DEAL:2::0_2:44 with 1
 DEAL:2::0_2:51 with 1
 DEAL:2::0_2:55 with 1
 DEAL:2::0_2:42 with 3
@@ -603,15 +603,15 @@ DEAL:2::0_2:47 with 3
 DEAL:2::0_2:52 with 3
 DEAL:2::0_2:53 with 3
 DEAL:2::0_2:57 with 3
-DEAL:2::0_2:44 with 1
 DEAL:2::0_2:45 with 1
+DEAL:2::0_2:50 with 1
 DEAL:2::0_2:54 with 1
 DEAL:2::0_2:56 with 3
 DEAL:2::
 DEAL:2::Number of cell batches: 16
 DEAL:2::0_2:40 with 100000000
 DEAL:2::0_2:41 with 100000000
-DEAL:2::0_2:50 with 100000000
+DEAL:2::0_2:44 with 100000000
 DEAL:2::0_2:42 with 100000000
 DEAL:2::0_2:43 with 100000000
 DEAL:2::0_2:46 with 100000000
@@ -621,8 +621,8 @@ DEAL:2::0_2:52 with 100000000
 DEAL:2::0_2:53 with 100000000
 DEAL:2::0_2:55 with 100000000
 DEAL:2::0_2:57 with 100000000
-DEAL:2::0_2:44 with 100000000
 DEAL:2::0_2:45 with 100000000
+DEAL:2::0_2:50 with 100000000
 DEAL:2::0_2:54 with 100000000
 DEAL:2::0_2:56 with 100000000
 DEAL:2::
@@ -634,15 +634,15 @@ DEAL:3::1_3:003 with 1
 DEAL:3::1_2:01 with 1
 DEAL:3::1_3:020 with 3
 DEAL:3::1_3:021 with 3
+DEAL:3::1_3:030 with 3
+DEAL:3::1_3:031 with 3
 DEAL:3::1_3:022 with 4
 DEAL:3::1_4:0230 with 4
 DEAL:3::1_4:0231 with 4
 DEAL:3::1_4:0232 with 4
-DEAL:3::1_3:200 with 5
-DEAL:3::1_3:212 with 6
-DEAL:3::1_3:213 with 6
-DEAL:3::1_4:2023 with 7
-DEAL:3::1_4:2033 with 7
+DEAL:3::1_4:0233 with 4
+DEAL:3::1_3:032 with 4
+DEAL:3::1_3:033 with 4
 DEAL:3::0_4:3330 with 9
 DEAL:3::0_4:3333 with 9
 DEAL:3::1_3:000 with 0
@@ -660,13 +660,9 @@ DEAL:3::1_5:20323 with 7
 DEAL:3::0_4:3331 with 9
 DEAL:3::0_4:3332 with 9
 DEAL:3::1_2:10 with 1
-DEAL:3::1_3:030 with 3
-DEAL:3::1_3:031 with 3
 DEAL:3::1_3:120 with 3
 DEAL:3::1_3:121 with 3
-DEAL:3::1_4:0233 with 4
-DEAL:3::1_3:032 with 4
-DEAL:3::1_3:033 with 4
+DEAL:3::1_3:200 with 5
 DEAL:3::1_3:201 with 5
 DEAL:3::1_3:210 with 5
 DEAL:3::1_4:2110 with 5
@@ -674,8 +670,12 @@ DEAL:3::1_4:2112 with 5
 DEAL:3::1_4:2021 with 6
 DEAL:3::1_4:2030 with 6
 DEAL:3::1_4:2031 with 6
+DEAL:3::1_3:212 with 6
+DEAL:3::1_3:213 with 6
+DEAL:3::1_4:2023 with 7
 DEAL:3::1_5:20320 with 7
 DEAL:3::1_5:20321 with 7
+DEAL:3::1_4:2033 with 7
 DEAL:3::
 DEAL:3::Number of cell batches: 47
 DEAL:3::1_3:001 with 0
@@ -683,15 +683,15 @@ DEAL:3::1_3:003 with 1
 DEAL:3::1_2:01 with 1
 DEAL:3::1_3:020 with 3
 DEAL:3::1_3:021 with 3
+DEAL:3::1_3:030 with 3
+DEAL:3::1_3:031 with 3
 DEAL:3::1_3:022 with 4
 DEAL:3::1_4:0230 with 4
 DEAL:3::1_4:0231 with 4
 DEAL:3::1_4:0232 with 4
-DEAL:3::1_3:200 with 5
-DEAL:3::1_3:212 with 6
-DEAL:3::1_3:213 with 6
-DEAL:3::1_4:2023 with 7
-DEAL:3::1_4:2033 with 7
+DEAL:3::1_4:0233 with 4
+DEAL:3::1_3:032 with 4
+DEAL:3::1_3:033 with 4
 DEAL:3::0_4:3330 with 9
 DEAL:3::0_4:3333 with 9
 DEAL:3::1_3:000 with 0
@@ -709,13 +709,9 @@ DEAL:3::1_5:20323 with 7
 DEAL:3::0_4:3331 with 9
 DEAL:3::0_4:3332 with 9
 DEAL:3::1_2:10 with 1
-DEAL:3::1_3:030 with 3
-DEAL:3::1_3:031 with 3
 DEAL:3::1_3:120 with 3
 DEAL:3::1_3:121 with 3
-DEAL:3::1_4:0233 with 4
-DEAL:3::1_3:032 with 4
-DEAL:3::1_3:033 with 4
+DEAL:3::1_3:200 with 5
 DEAL:3::1_3:201 with 5
 DEAL:3::1_3:210 with 5
 DEAL:3::1_4:2110 with 5
@@ -723,8 +719,12 @@ DEAL:3::1_4:2112 with 5
 DEAL:3::1_4:2021 with 6
 DEAL:3::1_4:2030 with 6
 DEAL:3::1_4:2031 with 6
+DEAL:3::1_3:212 with 6
+DEAL:3::1_3:213 with 6
+DEAL:3::1_4:2023 with 7
 DEAL:3::1_5:20320 with 7
 DEAL:3::1_5:20321 with 7
+DEAL:3::1_4:2033 with 7
 DEAL:3::
 DEAL:3::Number of cell batches: 47
 DEAL:3::0_4:3330 with 100000000
@@ -738,11 +738,11 @@ DEAL:3::1_3:022 with 100000000
 DEAL:3::1_4:0230 with 100000000
 DEAL:3::1_4:0231 with 100000000
 DEAL:3::1_4:0232 with 100000000
-DEAL:3::1_3:200 with 100000000
-DEAL:3::1_4:2023 with 100000000
-DEAL:3::1_4:2033 with 100000000
-DEAL:3::1_3:212 with 100000000
-DEAL:3::1_3:213 with 100000000
+DEAL:3::1_4:0233 with 100000000
+DEAL:3::1_3:030 with 100000000
+DEAL:3::1_3:031 with 100000000
+DEAL:3::1_3:032 with 100000000
+DEAL:3::1_3:033 with 100000000
 DEAL:3::0_4:3331 with 100000000
 DEAL:3::0_4:3332 with 100000000
 DEAL:3::1_3:000 with 100000000
@@ -757,23 +757,23 @@ DEAL:3::1_5:20322 with 100000000
 DEAL:3::1_5:20323 with 100000000
 DEAL:3::1_4:2111 with 100000000
 DEAL:3::1_4:2113 with 100000000
-DEAL:3::1_4:0233 with 100000000
-DEAL:3::1_3:030 with 100000000
-DEAL:3::1_3:031 with 100000000
-DEAL:3::1_3:032 with 100000000
-DEAL:3::1_3:033 with 100000000
 DEAL:3::1_2:10 with 100000000
 DEAL:3::1_3:120 with 100000000
 DEAL:3::1_3:121 with 100000000
+DEAL:3::1_3:200 with 100000000
 DEAL:3::1_3:201 with 100000000
 DEAL:3::1_4:2021 with 100000000
+DEAL:3::1_4:2023 with 100000000
 DEAL:3::1_4:2030 with 100000000
 DEAL:3::1_4:2031 with 100000000
 DEAL:3::1_5:20320 with 100000000
 DEAL:3::1_5:20321 with 100000000
+DEAL:3::1_4:2033 with 100000000
 DEAL:3::1_3:210 with 100000000
 DEAL:3::1_4:2110 with 100000000
 DEAL:3::1_4:2112 with 100000000
+DEAL:3::1_3:212 with 100000000
+DEAL:3::1_3:213 with 100000000
 DEAL:3::
 DEAL:3::Number of cell batches: 15
 DEAL:3::0_2:60 with 6
@@ -829,11 +829,7 @@ DEAL:3::
 
 
 DEAL:4::Number of cell batches: 46
-DEAL:4::2_2:00 with 2
-DEAL:4::1_3:300 with 5
-DEAL:4::1_3:301 with 5
 DEAL:4::1_4:2210 with 7
-DEAL:4::2_2:03 with 7
 DEAL:4::1_4:2203 with 8
 DEAL:4::1_4:2212 with 8
 DEAL:4::1_4:2213 with 8
@@ -843,7 +839,11 @@ DEAL:4::1_5:22221 with 9
 DEAL:4::1_5:22223 with 9
 DEAL:4::1_4:2223 with 9
 DEAL:4::1_3:223 with 9
-DEAL:4::2_3:121 with 10
+DEAL:4::1_3:232 with 9
+DEAL:4::1_4:2330 with 9
+DEAL:4::1_4:2331 with 9
+DEAL:4::1_4:2332 with 9
+DEAL:4::1_4:2333 with 9
 DEAL:4::1_3:310 with 5
 DEAL:4::1_3:311 with 5
 DEAL:4::2_2:02 with 5
@@ -860,28 +860,24 @@ DEAL:4::1_5:22220 with 9
 DEAL:4::1_5:22222 with 9
 DEAL:4::2_3:122 with 10
 DEAL:4::2_3:123 with 11
+DEAL:4::2_2:00 with 2
+DEAL:4::1_3:300 with 5
+DEAL:4::1_3:301 with 5
 DEAL:4::2_2:01 with 5
 DEAL:4::1_3:303 with 6
 DEAL:4::1_3:312 with 6
+DEAL:4::2_2:03 with 7
 DEAL:4::2_2:10 with 7
 DEAL:4::1_3:320 with 8
 DEAL:4::1_3:321 with 8
 DEAL:4::2_3:120 with 8
-DEAL:4::1_3:232 with 9
-DEAL:4::1_4:2330 with 9
-DEAL:4::1_4:2331 with 9
-DEAL:4::1_4:2332 with 9
-DEAL:4::1_4:2333 with 9
 DEAL:4::1_3:322 with 9
 DEAL:4::1_3:323 with 9
 DEAL:4::2_2:11 with 10
+DEAL:4::2_3:121 with 10
 DEAL:4::
 DEAL:4::Number of cell batches: 46
-DEAL:4::2_2:00 with 2
-DEAL:4::1_3:300 with 5
-DEAL:4::1_3:301 with 5
 DEAL:4::1_4:2210 with 7
-DEAL:4::2_2:03 with 7
 DEAL:4::1_4:2203 with 8
 DEAL:4::1_4:2212 with 8
 DEAL:4::1_4:2213 with 8
@@ -891,7 +887,11 @@ DEAL:4::1_5:22221 with 9
 DEAL:4::1_5:22223 with 9
 DEAL:4::1_4:2223 with 9
 DEAL:4::1_3:223 with 9
-DEAL:4::2_3:121 with 10
+DEAL:4::1_3:232 with 9
+DEAL:4::1_4:2330 with 9
+DEAL:4::1_4:2331 with 9
+DEAL:4::1_4:2332 with 9
+DEAL:4::1_4:2333 with 9
 DEAL:4::1_3:310 with 5
 DEAL:4::1_3:311 with 5
 DEAL:4::2_2:02 with 5
@@ -908,21 +908,21 @@ DEAL:4::1_5:22220 with 9
 DEAL:4::1_5:22222 with 9
 DEAL:4::2_3:122 with 10
 DEAL:4::2_3:123 with 11
+DEAL:4::2_2:00 with 2
+DEAL:4::1_3:300 with 5
+DEAL:4::1_3:301 with 5
 DEAL:4::2_2:01 with 5
 DEAL:4::1_3:303 with 6
 DEAL:4::1_3:312 with 6
+DEAL:4::2_2:03 with 7
 DEAL:4::2_2:10 with 7
 DEAL:4::1_3:320 with 8
 DEAL:4::1_3:321 with 8
 DEAL:4::2_3:120 with 8
-DEAL:4::1_3:232 with 9
-DEAL:4::1_4:2330 with 9
-DEAL:4::1_4:2331 with 9
-DEAL:4::1_4:2332 with 9
-DEAL:4::1_4:2333 with 9
 DEAL:4::1_3:322 with 9
 DEAL:4::1_3:323 with 9
 DEAL:4::2_2:11 with 10
+DEAL:4::2_3:121 with 10
 DEAL:4::
 DEAL:4::Number of cell batches: 46
 DEAL:4::1_4:2203 with 100000000
@@ -935,11 +935,11 @@ DEAL:4::1_5:22221 with 100000000
 DEAL:4::1_5:22223 with 100000000
 DEAL:4::1_4:2223 with 100000000
 DEAL:4::1_3:223 with 100000000
-DEAL:4::1_3:300 with 100000000
-DEAL:4::1_3:301 with 100000000
-DEAL:4::2_2:00 with 100000000
-DEAL:4::2_2:03 with 100000000
-DEAL:4::2_3:121 with 100000000
+DEAL:4::1_3:232 with 100000000
+DEAL:4::1_4:2330 with 100000000
+DEAL:4::1_4:2331 with 100000000
+DEAL:4::1_4:2332 with 100000000
+DEAL:4::1_4:2333 with 100000000
 DEAL:4::1_4:2200 with 100000000
 DEAL:4::1_4:2201 with 100000000
 DEAL:4::1_4:2202 with 100000000
@@ -956,28 +956,28 @@ DEAL:4::1_2:33 with 100000000
 DEAL:4::2_2:02 with 100000000
 DEAL:4::2_3:122 with 100000000
 DEAL:4::2_3:123 with 100000000
-DEAL:4::1_3:232 with 100000000
-DEAL:4::1_4:2330 with 100000000
-DEAL:4::1_4:2331 with 100000000
-DEAL:4::1_4:2332 with 100000000
-DEAL:4::1_4:2333 with 100000000
+DEAL:4::1_3:300 with 100000000
+DEAL:4::1_3:301 with 100000000
 DEAL:4::1_3:303 with 100000000
 DEAL:4::1_3:312 with 100000000
 DEAL:4::1_3:320 with 100000000
 DEAL:4::1_3:321 with 100000000
 DEAL:4::1_3:322 with 100000000
 DEAL:4::1_3:323 with 100000000
+DEAL:4::2_2:00 with 100000000
 DEAL:4::2_2:01 with 100000000
+DEAL:4::2_2:03 with 100000000
 DEAL:4::2_2:10 with 100000000
 DEAL:4::2_2:11 with 100000000
 DEAL:4::2_3:120 with 100000000
+DEAL:4::2_3:121 with 100000000
 DEAL:4::
 DEAL:4::Number of cell batches: 22
+DEAL:4::1_1:0 with 2
 DEAL:4::1_1:1 with 2
-DEAL:4::1_2:60 with 6
-DEAL:4::1_2:64 with 6
+DEAL:4::1_1:2 with 7
 DEAL:4::1_1:3 with 7
-DEAL:4::1_2:62 with 8
+DEAL:4::0_3:777 with 9
 DEAL:4::1_1:5 with 2
 DEAL:4::1_2:61 with 6
 DEAL:4::1_2:65 with 6
@@ -990,18 +990,18 @@ DEAL:4::1_2:67 with 8
 DEAL:4::0_3:772 with 9
 DEAL:4::0_3:773 with 9
 DEAL:4::0_3:776 with 9
-DEAL:4::1_1:0 with 2
 DEAL:4::1_1:4 with 2
-DEAL:4::1_1:2 with 7
+DEAL:4::1_2:60 with 6
+DEAL:4::1_2:64 with 6
+DEAL:4::1_2:62 with 8
 DEAL:4::1_2:66 with 8
-DEAL:4::0_3:777 with 9
 DEAL:4::
 DEAL:4::Number of cell batches: 22
+DEAL:4::1_1:0 with 2
 DEAL:4::1_1:1 with 2
-DEAL:4::1_2:60 with 6
-DEAL:4::1_2:64 with 6
+DEAL:4::1_1:2 with 7
 DEAL:4::1_1:3 with 7
-DEAL:4::1_2:62 with 8
+DEAL:4::0_3:777 with 9
 DEAL:4::1_1:5 with 2
 DEAL:4::1_2:61 with 6
 DEAL:4::1_2:65 with 6
@@ -1014,18 +1014,18 @@ DEAL:4::1_2:67 with 8
 DEAL:4::0_3:772 with 9
 DEAL:4::0_3:773 with 9
 DEAL:4::0_3:776 with 9
-DEAL:4::1_1:0 with 2
 DEAL:4::1_1:4 with 2
-DEAL:4::1_1:2 with 7
+DEAL:4::1_2:60 with 6
+DEAL:4::1_2:64 with 6
+DEAL:4::1_2:62 with 8
 DEAL:4::1_2:66 with 8
-DEAL:4::0_3:777 with 9
 DEAL:4::
 DEAL:4::Number of cell batches: 22
+DEAL:4::0_3:777 with 100000000
+DEAL:4::1_1:0 with 100000000
 DEAL:4::1_1:1 with 100000000
+DEAL:4::1_1:2 with 100000000
 DEAL:4::1_1:3 with 100000000
-DEAL:4::1_2:60 with 100000000
-DEAL:4::1_2:62 with 100000000
-DEAL:4::1_2:64 with 100000000
 DEAL:4::0_3:770 with 100000000
 DEAL:4::0_3:771 with 100000000
 DEAL:4::0_3:772 with 100000000
@@ -1038,10 +1038,10 @@ DEAL:4::1_2:61 with 100000000
 DEAL:4::1_2:63 with 100000000
 DEAL:4::1_2:65 with 100000000
 DEAL:4::1_2:67 with 100000000
-DEAL:4::0_3:777 with 100000000
-DEAL:4::1_1:0 with 100000000
-DEAL:4::1_1:2 with 100000000
 DEAL:4::1_1:4 with 100000000
+DEAL:4::1_2:60 with 100000000
+DEAL:4::1_2:62 with 100000000
+DEAL:4::1_2:64 with 100000000
 DEAL:4::1_2:66 with 100000000
 DEAL:4::
 
@@ -1051,13 +1051,13 @@ DEAL:5::2_2:20 with 7
 DEAL:5::2_2:22 with 10
 DEAL:5::3_3:001 with 10
 DEAL:5::2_3:230 with 11
+DEAL:5::3_3:003 with 11
 DEAL:5::2_3:231 with 12
 DEAL:5::2_3:232 with 12
 DEAL:5::2_2:30 with 12
 DEAL:5::2_3:133 with 13
 DEAL:5::2_3:233 with 13
 DEAL:5::2_3:310 with 13
-DEAL:5::3_3:133 with 14
 DEAL:5::2_3:311 with 15
 DEAL:5::2_3:312 with 15
 DEAL:5::2_2:32 with 15
@@ -1081,7 +1081,6 @@ DEAL:5::2_3:333 with 18
 DEAL:5::3_3:100 with 10
 DEAL:5::3_3:101 with 10
 DEAL:5::3_3:110 with 10
-DEAL:5::3_3:003 with 11
 DEAL:5::3_2:01 with 11
 DEAL:5::3_3:102 with 11
 DEAL:5::3_3:103 with 11
@@ -1095,19 +1094,20 @@ DEAL:5::3_3:121 with 13
 DEAL:5::3_4:1302 with 13
 DEAL:5::3_4:1303 with 13
 DEAL:5::3_3:131 with 13
+DEAL:5::3_3:133 with 14
 DEAL:5::
 DEAL:5::Number of cell batches: 48
 DEAL:5::2_2:20 with 7
 DEAL:5::2_2:22 with 10
 DEAL:5::3_3:001 with 10
 DEAL:5::2_3:230 with 11
+DEAL:5::3_3:003 with 11
 DEAL:5::2_3:231 with 12
 DEAL:5::2_3:232 with 12
 DEAL:5::2_2:30 with 12
 DEAL:5::2_3:133 with 13
 DEAL:5::2_3:233 with 13
 DEAL:5::2_3:310 with 13
-DEAL:5::3_3:133 with 14
 DEAL:5::2_3:311 with 15
 DEAL:5::2_3:312 with 15
 DEAL:5::2_2:32 with 15
@@ -1131,7 +1131,6 @@ DEAL:5::2_3:333 with 18
 DEAL:5::3_3:100 with 10
 DEAL:5::3_3:101 with 10
 DEAL:5::3_3:110 with 10
-DEAL:5::3_3:003 with 11
 DEAL:5::3_2:01 with 11
 DEAL:5::3_3:102 with 11
 DEAL:5::3_3:103 with 11
@@ -1145,6 +1144,7 @@ DEAL:5::3_3:121 with 13
 DEAL:5::3_4:1302 with 13
 DEAL:5::3_4:1303 with 13
 DEAL:5::3_3:131 with 13
+DEAL:5::3_3:133 with 14
 DEAL:5::
 DEAL:5::Number of cell batches: 48
 DEAL:5::2_3:133 with 100000000
@@ -1163,7 +1163,7 @@ DEAL:5::2_2:32 with 100000000
 DEAL:5::2_3:330 with 100000000
 DEAL:5::2_3:332 with 100000000
 DEAL:5::3_3:001 with 100000000
-DEAL:5::3_3:133 with 100000000
+DEAL:5::3_3:003 with 100000000
 DEAL:5::2_3:130 with 100000000
 DEAL:5::2_3:131 with 100000000
 DEAL:5::2_3:132 with 100000000
@@ -1178,7 +1178,6 @@ DEAL:5::3_3:122 with 100000000
 DEAL:5::3_3:123 with 100000000
 DEAL:5::3_3:132 with 100000000
 DEAL:5::3_2:20 with 100000000
-DEAL:5::3_3:003 with 100000000
 DEAL:5::3_2:01 with 100000000
 DEAL:5::3_2:02 with 100000000
 DEAL:5::3_2:03 with 100000000
@@ -1195,63 +1194,64 @@ DEAL:5::3_4:1301 with 100000000
 DEAL:5::3_4:1302 with 100000000
 DEAL:5::3_4:1303 with 100000000
 DEAL:5::3_3:131 with 100000000
+DEAL:5::3_3:133 with 100000000
 DEAL:5::
 DEAL:5::Number of cell batches: 17
 DEAL:5::2_1:1 with 10
 DEAL:5::2_1:5 with 10
-DEAL:5::3_1:5 with 12
+DEAL:5::2_1:6 with 10
 DEAL:5::2_1:3 with 15
-DEAL:5::3_1:7 with 17
+DEAL:5::2_1:7 with 15
 DEAL:5::2_1:0 with 5
 DEAL:5::2_1:4 with 5
 DEAL:5::1_1:7 with 7
 DEAL:5::2_1:2 with 10
 DEAL:5::3_1:1 with 12
 DEAL:5::3_1:3 with 17
-DEAL:5::2_1:6 with 10
 DEAL:5::3_1:0 with 12
 DEAL:5::3_1:4 with 12
-DEAL:5::2_1:7 with 15
+DEAL:5::3_1:5 with 12
 DEAL:5::3_1:2 with 17
 DEAL:5::3_1:6 with 17
+DEAL:5::3_1:7 with 17
 DEAL:5::
 DEAL:5::Number of cell batches: 17
 DEAL:5::2_1:1 with 10
 DEAL:5::2_1:5 with 10
-DEAL:5::3_1:5 with 12
+DEAL:5::2_1:6 with 10
 DEAL:5::2_1:3 with 15
-DEAL:5::3_1:7 with 17
+DEAL:5::2_1:7 with 15
 DEAL:5::2_1:0 with 5
 DEAL:5::2_1:4 with 5
 DEAL:5::1_1:7 with 7
 DEAL:5::2_1:2 with 10
 DEAL:5::3_1:1 with 12
 DEAL:5::3_1:3 with 17
-DEAL:5::2_1:6 with 10
 DEAL:5::3_1:0 with 12
 DEAL:5::3_1:4 with 12
-DEAL:5::2_1:7 with 15
+DEAL:5::3_1:5 with 12
 DEAL:5::3_1:2 with 17
 DEAL:5::3_1:6 with 17
+DEAL:5::3_1:7 with 17
 DEAL:5::
 DEAL:5::Number of cell batches: 17
 DEAL:5::2_1:1 with 100000000
 DEAL:5::2_1:3 with 100000000
 DEAL:5::2_1:5 with 100000000
-DEAL:5::3_1:5 with 100000000
-DEAL:5::3_1:7 with 100000000
+DEAL:5::2_1:6 with 100000000
+DEAL:5::2_1:7 with 100000000
 DEAL:5::1_1:7 with 100000000
 DEAL:5::2_1:0 with 100000000
 DEAL:5::2_1:2 with 100000000
 DEAL:5::2_1:4 with 100000000
 DEAL:5::3_1:1 with 100000000
 DEAL:5::3_1:3 with 100000000
-DEAL:5::2_1:6 with 100000000
-DEAL:5::2_1:7 with 100000000
 DEAL:5::3_1:0 with 100000000
 DEAL:5::3_1:2 with 100000000
 DEAL:5::3_1:4 with 100000000
+DEAL:5::3_1:5 with 100000000
 DEAL:5::3_1:6 with 100000000
+DEAL:5::3_1:7 with 100000000
 DEAL:5::
 
 
index 5ec0230276e450684ec38b36cd85f0d4ff943143..8b651223f3922651e112fd4ace39ae3d07bb04ce 100644 (file)
@@ -12,24 +12,24 @@ DEAL:0:2d::Interior faces: 2 1 1 3
 DEAL:0:2d::Exterior faces: 1 2 3 1 
 DEAL:0:2d::Boundary faces: 0 0 3 0 
 DEAL:0:2d::Level: 3
-DEAL:0:2d::Interior faces: 10 7 7 8 
-DEAL:0:2d::Exterior faces: 7 10 8 7 
+DEAL:0:2d::Interior faces: 15 2 10 5 
+DEAL:0:2d::Exterior faces: 2 15 5 10 
 DEAL:0:2d::Boundary faces: 0 0 6 0 
 DEAL:0:2d::Level: 4
-DEAL:0:2d::Interior faces: 56 16 47 19 
-DEAL:0:2d::Exterior faces: 16 56 19 47 
+DEAL:0:2d::Interior faces: 63 9 53 13 
+DEAL:0:2d::Exterior faces: 9 63 13 53 
 DEAL:0:2d::Boundary faces: 0 0 12 0 
 DEAL:0:3d::Level: 0
 DEAL:0:3d::Interior faces: 0 0 0 0 0 1 
 DEAL:0:3d::Exterior faces: 0 0 0 0 1 0 
 DEAL:0:3d::Boundary faces: 0 0 1 1 0 0 
 DEAL:0:3d::Level: 1
-DEAL:0:3d::Interior faces: 0 1 0 1 0 0 
-DEAL:0:3d::Exterior faces: 1 0 1 0 0 0 
+DEAL:0:3d::Interior faces: 1 0 0 1 0 0 
+DEAL:0:3d::Exterior faces: 0 1 1 0 0 0 
 DEAL:0:3d::Boundary faces: 0 0 2 0 0 0 
 DEAL:0:3d::Level: 2
-DEAL:0:3d::Interior faces: 13 3 4 8 12 4 
-DEAL:0:3d::Exterior faces: 3 13 8 4 4 12 
+DEAL:0:3d::Interior faces: 14 2 4 8 12 4 
+DEAL:0:3d::Exterior faces: 2 14 8 4 4 12 
 DEAL:0:3d::Boundary faces: 0 0 8 0 0 0 
 
 DEAL:1:2d::Level: 0
@@ -41,16 +41,16 @@ DEAL:1:2d::Interior faces: 0 0 1 0
 DEAL:1:2d::Exterior faces: 0 0 0 1 
 DEAL:1:2d::Boundary faces: 0 0 0 1 
 DEAL:1:2d::Level: 2
-DEAL:1:2d::Interior faces: 3 3 2 1 
-DEAL:1:2d::Exterior faces: 3 3 1 2 
+DEAL:1:2d::Interior faces: 4 2 2 1 
+DEAL:1:2d::Exterior faces: 2 4 1 2 
 DEAL:1:2d::Boundary faces: 0 0 1 0 
 DEAL:1:2d::Level: 3
-DEAL:1:2d::Interior faces: 12 6 10 8 
-DEAL:1:2d::Exterior faces: 6 12 8 10 
+DEAL:1:2d::Interior faces: 14 4 11 7 
+DEAL:1:2d::Exterior faces: 4 14 7 11 
 DEAL:1:2d::Boundary faces: 0 0 2 0 
 DEAL:1:2d::Level: 4
-DEAL:1:2d::Interior faces: 56 19 48 27 
-DEAL:1:2d::Exterior faces: 19 56 27 48 
+DEAL:1:2d::Interior faces: 62 13 56 19 
+DEAL:1:2d::Exterior faces: 13 62 19 56 
 DEAL:1:2d::Boundary faces: 0 0 4 0 
 DEAL:1:3d::Level: 0
 DEAL:1:3d::Interior faces: 0 0 0 0 0 0 
@@ -79,12 +79,12 @@ DEAL:2:2d::Interior faces: 2 1 3 1
 DEAL:2:2d::Exterior faces: 1 2 1 3 
 DEAL:2:2d::Boundary faces: 0 0 0 2 
 DEAL:2:2d::Level: 3
-DEAL:2:2d::Interior faces: 11 8 10 6 
-DEAL:2:2d::Exterior faces: 8 11 6 10 
+DEAL:2:2d::Interior faces: 13 6 8 8 
+DEAL:2:2d::Exterior faces: 6 13 8 8 
 DEAL:2:2d::Boundary faces: 0 0 0 4 
 DEAL:2:2d::Level: 4
-DEAL:2:2d::Interior faces: 56 19 48 17 
-DEAL:2:2d::Exterior faces: 19 56 17 48 
+DEAL:2:2d::Interior faces: 59 16 52 13 
+DEAL:2:2d::Exterior faces: 16 59 13 52 
 DEAL:2:2d::Boundary faces: 0 0 0 8 
 DEAL:2:3d::Level: 0
 DEAL:2:3d::Interior faces: 0 0 0 0 0 0 
@@ -113,12 +113,12 @@ DEAL:3:2d::Interior faces: 2 3 1 1
 DEAL:3:2d::Exterior faces: 3 2 1 1 
 DEAL:3:2d::Boundary faces: 0 0 2 2 
 DEAL:3:2d::Level: 3
-DEAL:3:2d::Interior faces: 12 6 9 4 
-DEAL:3:2d::Exterior faces: 6 12 4 9 
+DEAL:3:2d::Interior faces: 12 6 7 6 
+DEAL:3:2d::Exterior faces: 6 12 6 7 
 DEAL:3:2d::Boundary faces: 0 0 4 4 
 DEAL:3:2d::Level: 4
-DEAL:3:2d::Interior faces: 53 17 46 20 
-DEAL:3:2d::Exterior faces: 17 53 20 46 
+DEAL:3:2d::Interior faces: 60 10 49 17 
+DEAL:3:2d::Exterior faces: 10 60 17 49 
 DEAL:3:2d::Boundary faces: 0 0 8 8 
 DEAL:3:3d::Level: 0
 DEAL:3:3d::Interior faces: 1 1 0 0 0 1 
@@ -129,8 +129,8 @@ DEAL:3:3d::Interior faces: 2 1 0 0 1 1
 DEAL:3:3d::Exterior faces: 1 2 0 0 1 1 
 DEAL:3:3d::Boundary faces: 0 0 1 1 0 0 
 DEAL:3:3d::Level: 2
-DEAL:3:3d::Interior faces: 11 5 9 3 16 0 
-DEAL:3:3d::Exterior faces: 5 11 3 9 0 16 
+DEAL:3:3d::Interior faces: 12 4 10 2 16 0 
+DEAL:3:3d::Exterior faces: 4 12 2 10 0 16 
 DEAL:3:3d::Boundary faces: 0 0 4 4 0 0 
 
 
@@ -147,12 +147,12 @@ DEAL:4:2d::Interior faces: 3 2 2 1
 DEAL:4:2d::Exterior faces: 2 3 1 2 
 DEAL:4:2d::Boundary faces: 0 0 2 0 
 DEAL:4:2d::Level: 3
-DEAL:4:2d::Interior faces: 12 6 7 9 
-DEAL:4:2d::Exterior faces: 6 12 9 7 
+DEAL:4:2d::Interior faces: 14 4 8 8 
+DEAL:4:2d::Exterior faces: 4 14 8 8 
 DEAL:4:2d::Boundary faces: 0 0 4 0 
 DEAL:4:2d::Level: 4
-DEAL:4:2d::Interior faces: 54 18 44 24 
-DEAL:4:2d::Exterior faces: 18 54 24 44 
+DEAL:4:2d::Interior faces: 57 15 50 18 
+DEAL:4:2d::Exterior faces: 15 57 18 50 
 DEAL:4:2d::Boundary faces: 0 0 8 0 
 DEAL:4:3d::Level: 0
 DEAL:4:3d::Interior faces: 0 0 0 0 0 0 
@@ -163,8 +163,8 @@ DEAL:4:3d::Interior faces: 1 2 1 0 0 0
 DEAL:4:3d::Exterior faces: 2 1 0 1 0 0 
 DEAL:4:3d::Boundary faces: 0 0 1 1 0 0 
 DEAL:4:3d::Level: 2
-DEAL:4:3d::Interior faces: 12 6 10 0 13 3 
-DEAL:4:3d::Exterior faces: 6 12 0 10 3 13 
+DEAL:4:3d::Interior faces: 12 6 10 0 14 2 
+DEAL:4:3d::Exterior faces: 6 12 0 10 2 14 
 DEAL:4:3d::Boundary faces: 0 0 4 4 0 0 
 
 
@@ -177,16 +177,16 @@ DEAL:5:2d::Interior faces: 1 0 1 0
 DEAL:5:2d::Exterior faces: 0 1 0 1 
 DEAL:5:2d::Boundary faces: 0 0 0 1 
 DEAL:5:2d::Level: 2
-DEAL:5:2d::Interior faces: 3 1 3 2 
-DEAL:5:2d::Exterior faces: 1 3 2 3 
+DEAL:5:2d::Interior faces: 3 1 4 1 
+DEAL:5:2d::Exterior faces: 1 3 1 4 
 DEAL:5:2d::Boundary faces: 0 0 0 2 
 DEAL:5:2d::Level: 3
-DEAL:5:2d::Interior faces: 14 5 13 6 
-DEAL:5:2d::Exterior faces: 5 14 6 13 
+DEAL:5:2d::Interior faces: 15 4 13 6 
+DEAL:5:2d::Exterior faces: 4 15 6 13 
 DEAL:5:2d::Boundary faces: 0 0 0 2 
 DEAL:5:2d::Level: 4
-DEAL:5:2d::Interior faces: 57 17 57 19 
-DEAL:5:2d::Exterior faces: 17 57 19 57 
+DEAL:5:2d::Interior faces: 65 9 59 17 
+DEAL:5:2d::Exterior faces: 9 65 17 59 
 DEAL:5:2d::Boundary faces: 0 0 0 4 
 DEAL:5:3d::Level: 0
 DEAL:5:3d::Interior faces: 0 0 0 0 0 0 
@@ -215,12 +215,12 @@ DEAL:6:2d::Interior faces: 4 2 3 0
 DEAL:6:2d::Exterior faces: 2 4 0 3 
 DEAL:6:2d::Boundary faces: 0 0 0 2 
 DEAL:6:2d::Level: 3
-DEAL:6:2d::Interior faces: 11 8 14 1 
-DEAL:6:2d::Exterior faces: 8 11 1 14 
+DEAL:6:2d::Interior faces: 14 5 14 1 
+DEAL:6:2d::Exterior faces: 5 14 1 14 
 DEAL:6:2d::Boundary faces: 0 0 0 6 
 DEAL:6:2d::Level: 4
-DEAL:6:2d::Interior faces: 58 16 59 5 
-DEAL:6:2d::Exterior faces: 16 58 5 59 
+DEAL:6:2d::Interior faces: 61 13 59 5 
+DEAL:6:2d::Exterior faces: 13 61 5 59 
 DEAL:6:2d::Boundary faces: 0 0 0 12 
 DEAL:6:3d::Level: 0
 DEAL:6:3d::Interior faces: 0 0 0 0 0 0 
index ba93f2bed9fc34ac6bf69428572a8ebbbe18261d..91047957a4fa310c32ec2829631e33574c14efa6 100644 (file)
@@ -8,28 +8,28 @@ DEAL:0:2d::Interior faces: 1 0 0 0
 DEAL:0:2d::Exterior faces: 0 1 0 0 
 DEAL:0:2d::Boundary faces: 0 0 2 0 
 DEAL:0:2d::Level: 2
-DEAL:0:2d::Interior faces: 2 1 1 3 
-DEAL:0:2d::Exterior faces: 1 2 3 1 
+DEAL:0:2d::Interior faces: 3 0 2 2 
+DEAL:0:2d::Exterior faces: 0 3 2 2 
 DEAL:0:2d::Boundary faces: 0 0 3 0 
 DEAL:0:2d::Level: 3
-DEAL:0:2d::Interior faces: 12 5 7 8 
-DEAL:0:2d::Exterior faces: 5 12 8 7 
+DEAL:0:2d::Interior faces: 15 2 10 5 
+DEAL:0:2d::Exterior faces: 2 15 5 10 
 DEAL:0:2d::Boundary faces: 0 0 6 0 
 DEAL:0:2d::Level: 4
-DEAL:0:2d::Interior faces: 55 17 44 22 
-DEAL:0:2d::Exterior faces: 17 55 22 44 
+DEAL:0:2d::Interior faces: 61 11 51 15 
+DEAL:0:2d::Exterior faces: 11 61 15 51 
 DEAL:0:2d::Boundary faces: 0 0 12 0 
 DEAL:0:3d::Level: 0
 DEAL:0:3d::Interior faces: 0 0 0 0 0 1 
 DEAL:0:3d::Exterior faces: 0 0 0 0 1 0 
 DEAL:0:3d::Boundary faces: 0 0 1 1 0 0 
 DEAL:0:3d::Level: 1
-DEAL:0:3d::Interior faces: 0 1 0 1 0 0 
-DEAL:0:3d::Exterior faces: 1 0 1 0 0 0 
+DEAL:0:3d::Interior faces: 1 0 0 1 0 0 
+DEAL:0:3d::Exterior faces: 0 1 1 0 0 0 
 DEAL:0:3d::Boundary faces: 0 0 2 0 0 0 
 DEAL:0:3d::Level: 2
-DEAL:0:3d::Interior faces: 12 4 6 6 14 2 
-DEAL:0:3d::Exterior faces: 4 12 6 6 2 14 
+DEAL:0:3d::Interior faces: 13 3 6 6 14 2 
+DEAL:0:3d::Exterior faces: 3 13 6 6 2 14 
 DEAL:0:3d::Boundary faces: 0 0 8 0 0 0 
 
 DEAL:1:2d::Level: 0
@@ -41,16 +41,16 @@ DEAL:1:2d::Interior faces: 0 0 1 0
 DEAL:1:2d::Exterior faces: 0 0 0 1 
 DEAL:1:2d::Boundary faces: 0 0 0 1 
 DEAL:1:2d::Level: 2
-DEAL:1:2d::Interior faces: 3 3 2 1 
-DEAL:1:2d::Exterior faces: 3 3 1 2 
+DEAL:1:2d::Interior faces: 4 2 2 1 
+DEAL:1:2d::Exterior faces: 2 4 1 2 
 DEAL:1:2d::Boundary faces: 0 0 1 0 
 DEAL:1:2d::Level: 3
-DEAL:1:2d::Interior faces: 13 5 11 7 
-DEAL:1:2d::Exterior faces: 5 13 7 11 
+DEAL:1:2d::Interior faces: 16 2 12 6 
+DEAL:1:2d::Exterior faces: 2 16 6 12 
 DEAL:1:2d::Boundary faces: 0 0 2 0 
 DEAL:1:2d::Level: 4
-DEAL:1:2d::Interior faces: 56 19 48 27 
-DEAL:1:2d::Exterior faces: 19 56 27 48 
+DEAL:1:2d::Interior faces: 62 13 54 21 
+DEAL:1:2d::Exterior faces: 13 62 21 54 
 DEAL:1:2d::Boundary faces: 0 0 4 0 
 DEAL:1:3d::Level: 0
 DEAL:1:3d::Interior faces: 0 0 0 0 0 0 
@@ -61,8 +61,8 @@ DEAL:1:3d::Interior faces: 2 0 1 0 2 2
 DEAL:1:3d::Exterior faces: 0 2 0 1 2 2 
 DEAL:1:3d::Boundary faces: 0 0 1 2 0 0 
 DEAL:1:3d::Level: 2
-DEAL:1:3d::Interior faces: 17 5 12 7 16 9 
-DEAL:1:3d::Exterior faces: 5 17 7 12 9 16 
+DEAL:1:3d::Interior faces: 18 4 12 7 17 8 
+DEAL:1:3d::Exterior faces: 4 18 7 12 8 17 
 DEAL:1:3d::Boundary faces: 0 0 4 8 0 0 
 
 
@@ -79,12 +79,12 @@ DEAL:2:2d::Interior faces: 2 1 3 1
 DEAL:2:2d::Exterior faces: 1 2 1 3 
 DEAL:2:2d::Boundary faces: 0 0 0 2 
 DEAL:2:2d::Level: 3
-DEAL:2:2d::Interior faces: 11 8 10 6 
-DEAL:2:2d::Exterior faces: 8 11 6 10 
+DEAL:2:2d::Interior faces: 13 6 8 8 
+DEAL:2:2d::Exterior faces: 6 13 8 8 
 DEAL:2:2d::Boundary faces: 0 0 0 4 
 DEAL:2:2d::Level: 4
-DEAL:2:2d::Interior faces: 55 20 47 18 
-DEAL:2:2d::Exterior faces: 20 55 18 47 
+DEAL:2:2d::Interior faces: 60 15 52 13 
+DEAL:2:2d::Exterior faces: 15 60 13 52 
 DEAL:2:2d::Boundary faces: 0 0 0 8 
 DEAL:2:3d::Level: 0
 DEAL:2:3d::Interior faces: 0 0 0 0 0 0 
@@ -109,16 +109,16 @@ DEAL:3:2d::Interior faces: 1 0 0 0
 DEAL:3:2d::Exterior faces: 0 1 0 0 
 DEAL:3:2d::Boundary faces: 0 0 1 0 
 DEAL:3:2d::Level: 2
-DEAL:3:2d::Interior faces: 1 4 1 1 
-DEAL:3:2d::Exterior faces: 4 1 1 1 
+DEAL:3:2d::Interior faces: 2 3 1 1 
+DEAL:3:2d::Exterior faces: 3 2 1 1 
 DEAL:3:2d::Boundary faces: 0 0 2 2 
 DEAL:3:2d::Level: 3
-DEAL:3:2d::Interior faces: 12 6 9 4 
-DEAL:3:2d::Exterior faces: 6 12 4 9 
+DEAL:3:2d::Interior faces: 12 6 7 6 
+DEAL:3:2d::Exterior faces: 6 12 6 7 
 DEAL:3:2d::Boundary faces: 0 0 4 4 
 DEAL:3:2d::Level: 4
-DEAL:3:2d::Interior faces: 53 17 48 18 
-DEAL:3:2d::Exterior faces: 17 53 18 48 
+DEAL:3:2d::Interior faces: 60 10 49 17 
+DEAL:3:2d::Exterior faces: 10 60 17 49 
 DEAL:3:2d::Boundary faces: 0 0 8 8 
 DEAL:3:3d::Level: 0
 DEAL:3:3d::Interior faces: 1 1 0 0 0 1 
@@ -129,8 +129,8 @@ DEAL:3:3d::Interior faces: 2 1 0 0 1 1
 DEAL:3:3d::Exterior faces: 1 2 0 0 1 1 
 DEAL:3:3d::Boundary faces: 0 0 1 1 0 0 
 DEAL:3:3d::Level: 2
-DEAL:3:3d::Interior faces: 11 5 9 3 16 0 
-DEAL:3:3d::Exterior faces: 5 11 3 9 0 16 
+DEAL:3:3d::Interior faces: 12 4 10 2 16 0 
+DEAL:3:3d::Exterior faces: 4 12 2 10 0 16 
 DEAL:3:3d::Boundary faces: 0 0 4 4 0 0 
 
 
@@ -147,12 +147,12 @@ DEAL:4:2d::Interior faces: 3 2 2 1
 DEAL:4:2d::Exterior faces: 2 3 1 2 
 DEAL:4:2d::Boundary faces: 0 0 2 0 
 DEAL:4:2d::Level: 3
-DEAL:4:2d::Interior faces: 12 6 7 9 
-DEAL:4:2d::Exterior faces: 6 12 9 7 
+DEAL:4:2d::Interior faces: 14 4 8 8 
+DEAL:4:2d::Exterior faces: 4 14 8 8 
 DEAL:4:2d::Boundary faces: 0 0 4 0 
 DEAL:4:2d::Level: 4
-DEAL:4:2d::Interior faces: 54 18 44 24 
-DEAL:4:2d::Exterior faces: 18 54 24 44 
+DEAL:4:2d::Interior faces: 58 14 50 18 
+DEAL:4:2d::Exterior faces: 14 58 18 50 
 DEAL:4:2d::Boundary faces: 0 0 8 0 
 DEAL:4:3d::Level: 0
 DEAL:4:3d::Interior faces: 0 0 0 0 0 0 
@@ -163,8 +163,8 @@ DEAL:4:3d::Interior faces: 1 2 1 0 0 0
 DEAL:4:3d::Exterior faces: 2 1 0 1 0 0 
 DEAL:4:3d::Boundary faces: 0 0 1 1 0 0 
 DEAL:4:3d::Level: 2
-DEAL:4:3d::Interior faces: 12 6 10 0 13 3 
-DEAL:4:3d::Exterior faces: 6 12 0 10 3 13 
+DEAL:4:3d::Interior faces: 12 6 10 0 14 2 
+DEAL:4:3d::Exterior faces: 6 12 0 10 2 14 
 DEAL:4:3d::Boundary faces: 0 0 4 4 0 0 
 
 
@@ -177,16 +177,16 @@ DEAL:5:2d::Interior faces: 1 0 1 0
 DEAL:5:2d::Exterior faces: 0 1 0 1 
 DEAL:5:2d::Boundary faces: 0 0 0 1 
 DEAL:5:2d::Level: 2
-DEAL:5:2d::Interior faces: 3 1 3 2 
-DEAL:5:2d::Exterior faces: 1 3 2 3 
+DEAL:5:2d::Interior faces: 3 1 4 1 
+DEAL:5:2d::Exterior faces: 1 3 1 4 
 DEAL:5:2d::Boundary faces: 0 0 0 2 
 DEAL:5:2d::Level: 3
-DEAL:5:2d::Interior faces: 14 5 13 6 
-DEAL:5:2d::Exterior faces: 5 14 6 13 
+DEAL:5:2d::Interior faces: 15 4 13 6 
+DEAL:5:2d::Exterior faces: 4 15 6 13 
 DEAL:5:2d::Boundary faces: 0 0 0 2 
 DEAL:5:2d::Level: 4
-DEAL:5:2d::Interior faces: 56 18 56 20 
-DEAL:5:2d::Exterior faces: 18 56 20 56 
+DEAL:5:2d::Interior faces: 65 9 59 17 
+DEAL:5:2d::Exterior faces: 9 65 17 59 
 DEAL:5:2d::Boundary faces: 0 0 0 4 
 DEAL:5:3d::Level: 0
 DEAL:5:3d::Interior faces: 0 0 0 0 0 0 
@@ -215,12 +215,12 @@ DEAL:6:2d::Interior faces: 4 2 3 0
 DEAL:6:2d::Exterior faces: 2 4 0 3 
 DEAL:6:2d::Boundary faces: 0 0 0 2 
 DEAL:6:2d::Level: 3
-DEAL:6:2d::Interior faces: 10 9 13 2 
-DEAL:6:2d::Exterior faces: 9 10 2 13 
+DEAL:6:2d::Interior faces: 14 5 14 1 
+DEAL:6:2d::Exterior faces: 5 14 1 14 
 DEAL:6:2d::Boundary faces: 0 0 0 6 
 DEAL:6:2d::Level: 4
-DEAL:6:2d::Interior faces: 57 17 58 6 
-DEAL:6:2d::Exterior faces: 17 57 6 58 
+DEAL:6:2d::Interior faces: 63 11 60 4 
+DEAL:6:2d::Exterior faces: 11 63 4 60 
 DEAL:6:2d::Boundary faces: 0 0 0 12 
 DEAL:6:3d::Level: 0
 DEAL:6:3d::Interior faces: 0 0 0 0 0 0 
index 8c6b9f912fec61e01c2681a0b9e012264d8c1280..e8365185247fbf2c6d742fc1d68093904061d5ea 100644 (file)
@@ -8,28 +8,28 @@ DEAL:0:2d::Interior faces: 1 0 0 0
 DEAL:0:2d::Exterior faces: 0 1 0 0 
 DEAL:0:2d::Boundary faces: 0 0 2 0 
 DEAL:0:2d::Level: 2
-DEAL:0:2d::Interior faces: 2 1 1 3 
-DEAL:0:2d::Exterior faces: 1 2 3 1 
+DEAL:0:2d::Interior faces: 3 0 2 2 
+DEAL:0:2d::Exterior faces: 0 3 2 2 
 DEAL:0:2d::Boundary faces: 0 0 3 0 
 DEAL:0:2d::Level: 3
-DEAL:0:2d::Interior faces: 12 5 9 6 
-DEAL:0:2d::Exterior faces: 5 12 6 9 
+DEAL:0:2d::Interior faces: 14 3 9 6 
+DEAL:0:2d::Exterior faces: 3 14 6 9 
 DEAL:0:2d::Boundary faces: 0 0 6 0 
 DEAL:0:2d::Level: 4
-DEAL:0:2d::Interior faces: 55 17 44 22 
-DEAL:0:2d::Exterior faces: 17 55 22 44 
+DEAL:0:2d::Interior faces: 62 10 52 14 
+DEAL:0:2d::Exterior faces: 10 62 14 52 
 DEAL:0:2d::Boundary faces: 0 0 12 0 
 DEAL:0:3d::Level: 0
 DEAL:0:3d::Interior faces: 0 0 0 0 0 1 
 DEAL:0:3d::Exterior faces: 0 0 0 0 1 0 
 DEAL:0:3d::Boundary faces: 0 0 1 1 0 0 
 DEAL:0:3d::Level: 1
-DEAL:0:3d::Interior faces: 0 1 0 1 0 0 
-DEAL:0:3d::Exterior faces: 1 0 1 0 0 0 
+DEAL:0:3d::Interior faces: 1 0 0 1 0 0 
+DEAL:0:3d::Exterior faces: 0 1 1 0 0 0 
 DEAL:0:3d::Boundary faces: 0 0 2 0 0 0 
 DEAL:0:3d::Level: 2
-DEAL:0:3d::Interior faces: 10 6 6 6 13 3 
-DEAL:0:3d::Exterior faces: 6 10 6 6 3 13 
+DEAL:0:3d::Interior faces: 14 2 8 4 14 2 
+DEAL:0:3d::Exterior faces: 2 14 4 8 2 14 
 DEAL:0:3d::Boundary faces: 0 0 8 0 0 0 
 
 DEAL:1:2d::Level: 0
@@ -41,16 +41,16 @@ DEAL:1:2d::Interior faces: 0 0 1 0
 DEAL:1:2d::Exterior faces: 0 0 0 1 
 DEAL:1:2d::Boundary faces: 0 0 0 1 
 DEAL:1:2d::Level: 2
-DEAL:1:2d::Interior faces: 3 3 2 1 
-DEAL:1:2d::Exterior faces: 3 3 1 2 
+DEAL:1:2d::Interior faces: 4 2 2 1 
+DEAL:1:2d::Exterior faces: 2 4 1 2 
 DEAL:1:2d::Boundary faces: 0 0 1 0 
 DEAL:1:2d::Level: 3
-DEAL:1:2d::Interior faces: 15 3 11 7 
-DEAL:1:2d::Exterior faces: 3 15 7 11 
+DEAL:1:2d::Interior faces: 16 2 14 4 
+DEAL:1:2d::Exterior faces: 2 16 4 14 
 DEAL:1:2d::Boundary faces: 0 0 2 0 
 DEAL:1:2d::Level: 4
-DEAL:1:2d::Interior faces: 56 19 48 27 
-DEAL:1:2d::Exterior faces: 19 56 27 48 
+DEAL:1:2d::Interior faces: 62 13 54 21 
+DEAL:1:2d::Exterior faces: 13 62 21 54 
 DEAL:1:2d::Boundary faces: 0 0 4 0 
 DEAL:1:3d::Level: 0
 DEAL:1:3d::Interior faces: 0 0 0 0 0 0 
@@ -61,8 +61,8 @@ DEAL:1:3d::Interior faces: 2 0 1 0 2 2
 DEAL:1:3d::Exterior faces: 0 2 0 1 2 2 
 DEAL:1:3d::Boundary faces: 0 0 1 2 0 0 
 DEAL:1:3d::Level: 2
-DEAL:1:3d::Interior faces: 19 3 12 7 20 5 
-DEAL:1:3d::Exterior faces: 3 19 7 12 5 20 
+DEAL:1:3d::Interior faces: 20 2 12 7 21 4 
+DEAL:1:3d::Exterior faces: 2 20 7 12 4 21 
 DEAL:1:3d::Boundary faces: 0 0 4 8 0 0 
 
 
@@ -79,12 +79,12 @@ DEAL:2:2d::Interior faces: 2 1 3 1
 DEAL:2:2d::Exterior faces: 1 2 1 3 
 DEAL:2:2d::Boundary faces: 0 0 0 2 
 DEAL:2:2d::Level: 3
-DEAL:2:2d::Interior faces: 10 9 10 6 
-DEAL:2:2d::Exterior faces: 9 10 6 10 
+DEAL:2:2d::Interior faces: 13 6 11 5 
+DEAL:2:2d::Exterior faces: 6 13 5 11 
 DEAL:2:2d::Boundary faces: 0 0 0 4 
 DEAL:2:2d::Level: 4
-DEAL:2:2d::Interior faces: 53 22 49 16 
-DEAL:2:2d::Exterior faces: 22 53 16 49 
+DEAL:2:2d::Interior faces: 63 12 53 12 
+DEAL:2:2d::Exterior faces: 12 63 12 53 
 DEAL:2:2d::Boundary faces: 0 0 0 8 
 DEAL:2:3d::Level: 0
 DEAL:2:3d::Interior faces: 0 0 0 0 0 0 
@@ -95,8 +95,8 @@ DEAL:2:3d::Interior faces: 1 0 1 1 1 1
 DEAL:2:3d::Exterior faces: 0 1 1 1 1 1 
 DEAL:2:3d::Boundary faces: 0 0 1 1 0 0 
 DEAL:2:3d::Level: 2
-DEAL:2:3d::Interior faces: 12 6 7 4 14 1 
-DEAL:2:3d::Exterior faces: 6 12 4 7 1 14 
+DEAL:2:3d::Interior faces: 14 4 9 2 14 1 
+DEAL:2:3d::Exterior faces: 4 14 2 9 1 14 
 DEAL:2:3d::Boundary faces: 0 0 4 4 0 0 
 
 
@@ -109,16 +109,16 @@ DEAL:3:2d::Interior faces: 1 0 0 0
 DEAL:3:2d::Exterior faces: 0 1 0 0 
 DEAL:3:2d::Boundary faces: 0 0 1 0 
 DEAL:3:2d::Level: 2
-DEAL:3:2d::Interior faces: 1 4 1 1 
-DEAL:3:2d::Exterior faces: 4 1 1 1 
+DEAL:3:2d::Interior faces: 3 2 2 0 
+DEAL:3:2d::Exterior faces: 2 3 0 2 
 DEAL:3:2d::Boundary faces: 0 0 2 2 
 DEAL:3:2d::Level: 3
-DEAL:3:2d::Interior faces: 11 7 9 4 
-DEAL:3:2d::Exterior faces: 7 11 4 9 
+DEAL:3:2d::Interior faces: 13 5 9 4 
+DEAL:3:2d::Exterior faces: 5 13 4 9 
 DEAL:3:2d::Boundary faces: 0 0 4 4 
 DEAL:3:2d::Level: 4
-DEAL:3:2d::Interior faces: 49 21 43 23 
-DEAL:3:2d::Exterior faces: 21 49 23 43 
+DEAL:3:2d::Interior faces: 58 12 48 18 
+DEAL:3:2d::Exterior faces: 12 58 18 48 
 DEAL:3:2d::Boundary faces: 0 0 8 8 
 DEAL:3:3d::Level: 0
 DEAL:3:3d::Interior faces: 1 1 0 0 0 1 
@@ -129,8 +129,8 @@ DEAL:3:3d::Interior faces: 2 1 0 0 1 1
 DEAL:3:3d::Exterior faces: 1 2 0 0 1 1 
 DEAL:3:3d::Boundary faces: 0 0 1 1 0 0 
 DEAL:3:3d::Level: 2
-DEAL:3:3d::Interior faces: 11 5 9 3 16 0 
-DEAL:3:3d::Exterior faces: 5 11 3 9 0 16 
+DEAL:3:3d::Interior faces: 12 4 10 2 16 0 
+DEAL:3:3d::Exterior faces: 4 12 2 10 0 16 
 DEAL:3:3d::Boundary faces: 0 0 4 4 0 0 
 
 
@@ -147,12 +147,12 @@ DEAL:4:2d::Interior faces: 3 2 2 1
 DEAL:4:2d::Exterior faces: 2 3 1 2 
 DEAL:4:2d::Boundary faces: 0 0 2 0 
 DEAL:4:2d::Level: 3
-DEAL:4:2d::Interior faces: 12 6 8 8 
-DEAL:4:2d::Exterior faces: 6 12 8 8 
+DEAL:4:2d::Interior faces: 13 5 8 8 
+DEAL:4:2d::Exterior faces: 5 13 8 8 
 DEAL:4:2d::Boundary faces: 0 0 4 0 
 DEAL:4:2d::Level: 4
-DEAL:4:2d::Interior faces: 52 20 44 24 
-DEAL:4:2d::Exterior faces: 20 52 24 44 
+DEAL:4:2d::Interior faces: 56 16 52 16 
+DEAL:4:2d::Exterior faces: 16 56 16 52 
 DEAL:4:2d::Boundary faces: 0 0 8 0 
 DEAL:4:3d::Level: 0
 DEAL:4:3d::Interior faces: 0 0 0 0 0 0 
@@ -163,8 +163,8 @@ DEAL:4:3d::Interior faces: 1 2 1 0 0 0
 DEAL:4:3d::Exterior faces: 2 1 0 1 0 0 
 DEAL:4:3d::Boundary faces: 0 0 1 1 0 0 
 DEAL:4:3d::Level: 2
-DEAL:4:3d::Interior faces: 12 6 10 0 13 3 
-DEAL:4:3d::Exterior faces: 6 12 0 10 3 13 
+DEAL:4:3d::Interior faces: 12 6 10 0 14 2 
+DEAL:4:3d::Exterior faces: 6 12 0 10 2 14 
 DEAL:4:3d::Boundary faces: 0 0 4 4 0 0 
 
 
@@ -177,16 +177,16 @@ DEAL:5:2d::Interior faces: 1 0 1 0
 DEAL:5:2d::Exterior faces: 0 1 0 1 
 DEAL:5:2d::Boundary faces: 0 0 0 1 
 DEAL:5:2d::Level: 2
-DEAL:5:2d::Interior faces: 2 2 4 1 
-DEAL:5:2d::Exterior faces: 2 2 1 4 
+DEAL:5:2d::Interior faces: 3 1 4 1 
+DEAL:5:2d::Exterior faces: 1 3 1 4 
 DEAL:5:2d::Boundary faces: 0 0 0 2 
 DEAL:5:2d::Level: 3
-DEAL:5:2d::Interior faces: 13 6 12 7 
-DEAL:5:2d::Exterior faces: 6 13 7 12 
+DEAL:5:2d::Interior faces: 15 4 14 5 
+DEAL:5:2d::Exterior faces: 4 15 5 14 
 DEAL:5:2d::Boundary faces: 0 0 0 2 
 DEAL:5:2d::Level: 4
-DEAL:5:2d::Interior faces: 56 18 56 20 
-DEAL:5:2d::Exterior faces: 18 56 20 56 
+DEAL:5:2d::Interior faces: 65 9 59 17 
+DEAL:5:2d::Exterior faces: 9 65 17 59 
 DEAL:5:2d::Boundary faces: 0 0 0 4 
 DEAL:5:3d::Level: 0
 DEAL:5:3d::Interior faces: 0 0 0 0 0 0 
@@ -215,12 +215,12 @@ DEAL:6:2d::Interior faces: 4 2 3 0
 DEAL:6:2d::Exterior faces: 2 4 0 3 
 DEAL:6:2d::Boundary faces: 0 0 0 2 
 DEAL:6:2d::Level: 3
-DEAL:6:2d::Interior faces: 13 6 14 1 
-DEAL:6:2d::Exterior faces: 6 13 1 14 
+DEAL:6:2d::Interior faces: 14 5 14 1 
+DEAL:6:2d::Exterior faces: 5 14 1 14 
 DEAL:6:2d::Boundary faces: 0 0 0 6 
 DEAL:6:2d::Level: 4
-DEAL:6:2d::Interior faces: 57 17 58 6 
-DEAL:6:2d::Exterior faces: 17 57 6 58 
+DEAL:6:2d::Interior faces: 61 13 60 4 
+DEAL:6:2d::Exterior faces: 13 61 4 60 
 DEAL:6:2d::Boundary faces: 0 0 0 12 
 DEAL:6:3d::Level: 0
 DEAL:6:3d::Interior faces: 0 0 0 0 0 0 
@@ -231,7 +231,7 @@ DEAL:6:3d::Interior faces: 2 1 2 0 1 1
 DEAL:6:3d::Exterior faces: 1 2 0 2 1 1 
 DEAL:6:3d::Boundary faces: 0 0 0 2 0 0 
 DEAL:6:3d::Level: 2
-DEAL:6:3d::Interior faces: 11 5 9 3 12 4 
-DEAL:6:3d::Exterior faces: 5 11 3 9 4 12 
+DEAL:6:3d::Interior faces: 14 2 12 0 14 2 
+DEAL:6:3d::Exterior faces: 2 14 0 12 2 14 
 DEAL:6:3d::Boundary faces: 0 0 0 8 0 0 
 

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.