]> https://gitweb.dealii.org/ - dealii.git/commitdiff
change distribute interface dofs for p::s::T 5436/head
authortcclevenger <tcleven@clemson.edu>
Fri, 10 Nov 2017 14:28:06 +0000 (09:28 -0500)
committertcclevenger <tcleven@clemson.edu>
Mon, 13 Nov 2017 19:39:27 +0000 (14:39 -0500)
20 files changed:
doc/news/changes/incompatibilities/20171113ConradClevenger [new file with mode: 0644]
source/dofs/dof_handler_policy.cc
tests/sharedtria/communicate_active_fe_indices_01.with_metis=true.mpirun=3.output
tests/sharedtria/communicate_active_fe_indices_01.with_metis=true.mpirun=3.output.2
tests/sharedtria/communicate_active_fe_indices_01.with_metis=true.with_64bit_indices=off.mpirun=3.output.clang9_sierra
tests/sharedtria/communicate_active_fe_indices_02.with_metis=true.mpirun=3.output
tests/sharedtria/dof_05.cc [new file with mode: 0644]
tests/sharedtria/dof_05.with_p4est=true.mpirun=3.output [new file with mode: 0644]
tests/sharedtria/dof_06.cc [new file with mode: 0644]
tests/sharedtria/dof_06.mpirun=3.output [new file with mode: 0644]
tests/sharedtria/hp_no_cells_01.with_metis=true.mpirun=3.output
tests/sharedtria/hp_no_cells_01.with_metis=true.mpirun=5.output
tests/sharedtria/hp_no_cells_01.with_metis=true.mpirun=9.output
tests/sharedtria/mg_dof_01.cc [moved from tests/sharedtria/tria_mg_dof_01.cc with 100% similarity]
tests/sharedtria/mg_dof_01.mpirun=3.with_p4est=true.output [moved from tests/sharedtria/tria_mg_dof_01.mpirun=3.with_p4est=true.output with 100% similarity]
tests/sharedtria/mg_dof_02.cc [moved from tests/sharedtria/tria_mg_dof_02.cc with 100% similarity]
tests/sharedtria/mg_dof_02.mpirun=3.output [moved from tests/sharedtria/tria_mg_dof_02.mpirun=3.output with 100% similarity]
tests/sharedtria/no_cells_01.with_metis=true.mpirun=3.output
tests/sharedtria/no_cells_01.with_metis=true.mpirun=5.output
tests/sharedtria/no_cells_01.with_metis=true.mpirun=9.output

diff --git a/doc/news/changes/incompatibilities/20171113ConradClevenger b/doc/news/changes/incompatibilities/20171113ConradClevenger
new file mode 100644 (file)
index 0000000..ba6717f
--- /dev/null
@@ -0,0 +1,3 @@
+Changed: The distribution of degrees of freedom along a refinement edge for a parallel::shared::Triangulation has been changed to mimic that of a parallel::distributed::Triangulation, that is, they are now all given to the processor with the smallest subdomain_id.
+<br>
+(Conrad Clevenger, 2017/11/13)
index 1db96a4fab36b25732c57ff06c7f908adf6af8a4..e9fbdcb2feb68f77a2d6241ec58b60af855df2de 100644 (file)
@@ -2371,12 +2371,8 @@ namespace internal
           std::vector<types::global_dof_index> local_dof_indices;
           local_dof_indices.reserve (DoFTools::max_dofs_per_cell(dof_handler));
 
-          // pseudo-randomly assign variables which lie on the interface between
-          // subdomains to each of the two or more
-          bool coin_flip = true;
-
           // loop over all cells and record which subdomain a DoF belongs to.
-          // toss a coin in case it is on an interface
+          // give to the smaller subdomain_id in case it is on an interface
           typename DoFHandlerType::active_cell_iterator
           cell = dof_handler.begin_active(),
           endc = dof_handler.end();
@@ -2391,18 +2387,15 @@ namespace internal
               cell->get_dof_indices (local_dof_indices);
 
               // set subdomain ids. if dofs already have their values set then
-              // they must be on partition interfaces. in that case randomly
-              // assign them to either the previous association or the current
-              // one, where we take "random" to be "once this way once that way"
+              // they must be on partition interfaces. In that case assign them to the
+              // processor with the smaller subdomain id.
               for (unsigned int i=0; i<dofs_per_cell; ++i)
                 if (subdomain_association[local_dof_indices[i]] ==
                     numbers::invalid_subdomain_id)
                   subdomain_association[local_dof_indices[i]] = subdomain_id;
-                else
+                else if (subdomain_association[local_dof_indices[i]] > subdomain_id)
                   {
-                    if (coin_flip == true)
-                      subdomain_association[local_dof_indices[i]] = subdomain_id;
-                    coin_flip = !coin_flip;
+                    subdomain_association[local_dof_indices[i]] = subdomain_id;
                   }
             }
 
@@ -2456,8 +2449,8 @@ namespace internal
               cell->get_mg_dof_indices (local_dof_indices);
 
               // set level subdomain ids. if dofs already have their values set then
-              // they must be on partition interfaces. in that case assign them to the
-              // processor wit the smaller subdomain id.
+              // they must be on partition interfaces. In that case assign them to the
+              // processor with the smaller subdomain id.
               for (unsigned int i=0; i<dofs_per_cell; ++i)
                 if (level_subdomain_association[local_dof_indices[i]] ==
                     numbers::invalid_subdomain_id)
index 9f7fa6057a954330ec5431b36af173acec3ff4ed..67051f933cd0245313411d5bf915a08b88f9dcec 100644 (file)
@@ -1,23 +1,23 @@
 
 DEAL:0:1d::n_dofs: 9
-DEAL:0:1d::n_locally_owned_dofs: 3
+DEAL:0:1d::n_locally_owned_dofs: 4
 DEAL:0:2d::n_dofs: 81
-DEAL:0:2d::n_locally_owned_dofs: 26
+DEAL:0:2d::n_locally_owned_dofs: 32
 DEAL:0:3d::n_dofs: 729
-DEAL:0:3d::n_locally_owned_dofs: 239
+DEAL:0:3d::n_locally_owned_dofs: 304
 
 DEAL:1:1d::n_dofs: 9
 DEAL:1:1d::n_locally_owned_dofs: 4
 DEAL:1:2d::n_dofs: 81
-DEAL:1:2d::n_locally_owned_dofs: 28
+DEAL:1:2d::n_locally_owned_dofs: 27
 DEAL:1:3d::n_dofs: 729
-DEAL:1:3d::n_locally_owned_dofs: 241
+DEAL:1:3d::n_locally_owned_dofs: 246
 
 
 DEAL:2:1d::n_dofs: 9
-DEAL:2:1d::n_locally_owned_dofs: 2
+DEAL:2:1d::n_locally_owned_dofs: 1
 DEAL:2:2d::n_dofs: 81
-DEAL:2:2d::n_locally_owned_dofs: 27
+DEAL:2:2d::n_locally_owned_dofs: 22
 DEAL:2:3d::n_dofs: 729
-DEAL:2:3d::n_locally_owned_dofs: 249
+DEAL:2:3d::n_locally_owned_dofs: 179
 
index c750ba40bb5b3e188c4df8940575671b3f42f709..67051f933cd0245313411d5bf915a08b88f9dcec 100644 (file)
@@ -2,22 +2,22 @@
 DEAL:0:1d::n_dofs: 9
 DEAL:0:1d::n_locally_owned_dofs: 4
 DEAL:0:2d::n_dofs: 81
-DEAL:0:2d::n_locally_owned_dofs: 28
+DEAL:0:2d::n_locally_owned_dofs: 32
 DEAL:0:3d::n_dofs: 729
-DEAL:0:3d::n_locally_owned_dofs: 244
+DEAL:0:3d::n_locally_owned_dofs: 304
 
 DEAL:1:1d::n_dofs: 9
-DEAL:1:1d::n_locally_owned_dofs: 3
+DEAL:1:1d::n_locally_owned_dofs: 4
 DEAL:1:2d::n_dofs: 81
-DEAL:1:2d::n_locally_owned_dofs: 26
+DEAL:1:2d::n_locally_owned_dofs: 27
 DEAL:1:3d::n_dofs: 729
-DEAL:1:3d::n_locally_owned_dofs: 240
+DEAL:1:3d::n_locally_owned_dofs: 246
 
 
 DEAL:2:1d::n_dofs: 9
-DEAL:2:1d::n_locally_owned_dofs: 2
+DEAL:2:1d::n_locally_owned_dofs: 1
 DEAL:2:2d::n_dofs: 81
-DEAL:2:2d::n_locally_owned_dofs: 27
+DEAL:2:2d::n_locally_owned_dofs: 22
 DEAL:2:3d::n_dofs: 729
-DEAL:2:3d::n_locally_owned_dofs: 245
+DEAL:2:3d::n_locally_owned_dofs: 179
 
index 52e7c422bdf7d4f0722526469c38899a3654e610..67051f933cd0245313411d5bf915a08b88f9dcec 100644 (file)
@@ -1,23 +1,23 @@
 
 DEAL:0:1d::n_dofs: 9
-DEAL:0:1d::n_locally_owned_dofs: 3
+DEAL:0:1d::n_locally_owned_dofs: 4
 DEAL:0:2d::n_dofs: 81
-DEAL:0:2d::n_locally_owned_dofs: 27
+DEAL:0:2d::n_locally_owned_dofs: 32
 DEAL:0:3d::n_dofs: 729
-DEAL:0:3d::n_locally_owned_dofs: 255
+DEAL:0:3d::n_locally_owned_dofs: 304
 
 DEAL:1:1d::n_dofs: 9
 DEAL:1:1d::n_locally_owned_dofs: 4
 DEAL:1:2d::n_dofs: 81
-DEAL:1:2d::n_locally_owned_dofs: 28
+DEAL:1:2d::n_locally_owned_dofs: 27
 DEAL:1:3d::n_dofs: 729
-DEAL:1:3d::n_locally_owned_dofs: 238
+DEAL:1:3d::n_locally_owned_dofs: 246
 
 
 DEAL:2:1d::n_dofs: 9
-DEAL:2:1d::n_locally_owned_dofs: 2
+DEAL:2:1d::n_locally_owned_dofs: 1
 DEAL:2:2d::n_dofs: 81
-DEAL:2:2d::n_locally_owned_dofs: 26
+DEAL:2:2d::n_locally_owned_dofs: 22
 DEAL:2:3d::n_dofs: 729
-DEAL:2:3d::n_locally_owned_dofs: 236
+DEAL:2:3d::n_locally_owned_dofs: 179
 
index 9f7fa6057a954330ec5431b36af173acec3ff4ed..67051f933cd0245313411d5bf915a08b88f9dcec 100644 (file)
@@ -1,23 +1,23 @@
 
 DEAL:0:1d::n_dofs: 9
-DEAL:0:1d::n_locally_owned_dofs: 3
+DEAL:0:1d::n_locally_owned_dofs: 4
 DEAL:0:2d::n_dofs: 81
-DEAL:0:2d::n_locally_owned_dofs: 26
+DEAL:0:2d::n_locally_owned_dofs: 32
 DEAL:0:3d::n_dofs: 729
-DEAL:0:3d::n_locally_owned_dofs: 239
+DEAL:0:3d::n_locally_owned_dofs: 304
 
 DEAL:1:1d::n_dofs: 9
 DEAL:1:1d::n_locally_owned_dofs: 4
 DEAL:1:2d::n_dofs: 81
-DEAL:1:2d::n_locally_owned_dofs: 28
+DEAL:1:2d::n_locally_owned_dofs: 27
 DEAL:1:3d::n_dofs: 729
-DEAL:1:3d::n_locally_owned_dofs: 241
+DEAL:1:3d::n_locally_owned_dofs: 246
 
 
 DEAL:2:1d::n_dofs: 9
-DEAL:2:1d::n_locally_owned_dofs: 2
+DEAL:2:1d::n_locally_owned_dofs: 1
 DEAL:2:2d::n_dofs: 81
-DEAL:2:2d::n_locally_owned_dofs: 27
+DEAL:2:2d::n_locally_owned_dofs: 22
 DEAL:2:3d::n_dofs: 729
-DEAL:2:3d::n_locally_owned_dofs: 249
+DEAL:2:3d::n_locally_owned_dofs: 179
 
diff --git a/tests/sharedtria/dof_05.cc b/tests/sharedtria/dof_05.cc
new file mode 100644 (file)
index 0000000..298a904
--- /dev/null
@@ -0,0 +1,117 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2008 - 2017 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+
+// distibute dofs on a shared and distributed triangulation and compare
+// Note: this doesnt pass for all meshes since, for some complicated refinement
+//       schemes, cells may be traversed in different order in a distributed
+//       triangulation as opposed to a shared triangulation.
+
+#include "../tests.h"
+#include <deal.II/base/tensor.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/distributed/tria.h>
+#include <deal.II/distributed/shared_tria.h>
+#include <deal.II/grid/tria_accessor.h>
+#include <deal.II/grid/grid_out.h>
+#include <deal.II/grid/tria_iterator.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/dofs/dof_accessor.h>
+#include <deal.II/dofs/dof_tools.h>
+#include <deal.II/base/index_set.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/fe/fe_q.h>
+#include <deal.II/fe/fe_dgq.h>
+
+template <int dim>
+void compare_meshes (DoFHandler<dim> &shared_dof_handler, DoFHandler<dim> &distributed_dof_handler)
+{
+  FE_Q<dim> fe (2);
+
+  shared_dof_handler.distribute_dofs(fe);
+  distributed_dof_handler.distribute_dofs(fe);
+
+  IndexSet shared_dofs = shared_dof_handler.locally_owned_dofs();
+  IndexSet distributed_dofs = distributed_dof_handler.locally_owned_dofs();
+  Assert(shared_dofs==distributed_dofs, ExcInternalError());
+  shared_dofs.print(deallog.get_file_stream());
+
+  std::vector<IndexSet> shared_dofs_per_proc = shared_dof_handler.locally_owned_dofs_per_processor();
+  std::vector<IndexSet> distributed_dofs_per_proc = distributed_dof_handler.locally_owned_dofs_per_processor();
+  for (unsigned int i=0; i<Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD); ++i)
+    Assert(shared_dofs_per_proc[i]==distributed_dofs_per_proc[i], ExcInternalError());
+
+  typename DoFHandler<dim>::active_cell_iterator
+  cell = distributed_dof_handler.begin_active(),
+  endc = distributed_dof_handler.end();
+  for (; cell!=endc; ++cell)
+    {
+      if (cell->subdomain_id() == numbers::artificial_subdomain_id)
+        continue;
+
+      typename Triangulation<dim>::active_cell_iterator
+      tria_shared_cell = cell->id().to_cell(shared_dof_handler.get_triangulation());
+      typename DoFHandler<dim>::active_cell_iterator dof_shared_cell(&shared_dof_handler.get_triangulation(),
+          tria_shared_cell->level(),
+          tria_shared_cell->index(),
+          &shared_dof_handler);
+
+      std::vector<types::global_dof_index> distributed_cell_dofs(fe.dofs_per_cell);
+      std::vector<types::global_dof_index> shared_cell_dofs(fe.dofs_per_cell);
+      cell->get_dof_indices(distributed_cell_dofs);
+      dof_shared_cell->get_dof_indices(shared_cell_dofs);
+      for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
+        Assert(distributed_cell_dofs[i]==shared_cell_dofs[i], ExcInternalError());
+    }
+}
+
+
+
+template <int dim>
+void test()
+{
+  parallel::shared::Triangulation<dim> shared_tria(MPI_COMM_WORLD,typename Triangulation<dim>::MeshSmoothing
+                                                   (Triangulation<dim>::limit_level_difference_at_vertices), true,
+                                                   typename parallel::shared::Triangulation<dim>::Settings
+                                                   (parallel::shared::Triangulation<dim>::partition_zorder));
+  DoFHandler<dim> shared_dof_handler(shared_tria);
+
+  parallel::distributed::Triangulation<dim> distributed_tria(MPI_COMM_WORLD,Triangulation<dim>::
+                                                             limit_level_difference_at_vertices);
+  DoFHandler<dim> distributed_dof_handler(distributed_tria);
+
+  GridGenerator::subdivided_hyper_cube(shared_tria,3,-1,1);
+  GridGenerator::subdivided_hyper_cube(distributed_tria,3,-1,1);
+
+  compare_meshes(shared_dof_handler,distributed_dof_handler);
+}
+
+int main(int argc, char *argv[])
+{
+  Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
+  MPILogInitAll all;
+
+  deallog.push("2d");
+  test<2>();
+  deallog.pop();
+  deallog.push("3d");
+  test<3>();
+  deallog.pop();
+
+  deallog << "OK" << std::endl;
+}
+
+
diff --git a/tests/sharedtria/dof_05.with_p4est=true.mpirun=3.output b/tests/sharedtria/dof_05.with_p4est=true.mpirun=3.output
new file mode 100644 (file)
index 0000000..c3d18aa
--- /dev/null
@@ -0,0 +1,14 @@
+
+{[0,20]}
+{[0,142]}
+DEAL:0::OK
+
+{[21,34]}
+{[143,244]}
+DEAL:1::OK
+
+
+{[35,48]}
+{[245,342]}
+DEAL:2::OK
+
diff --git a/tests/sharedtria/dof_06.cc b/tests/sharedtria/dof_06.cc
new file mode 100644 (file)
index 0000000..a2e2dec
--- /dev/null
@@ -0,0 +1,103 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2008 - 2017 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+
+// distibute dofs on a shared triangulation. Tests the change
+// from coin_flip to smallest proc index method of distribution
+// along partition interface
+
+#include "../tests.h"
+#include <deal.II/base/tensor.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/distributed/tria.h>
+#include <deal.II/distributed/shared_tria.h>
+#include <deal.II/grid/tria_accessor.h>
+#include <deal.II/grid/grid_out.h>
+#include <deal.II/grid/tria_iterator.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/dofs/dof_accessor.h>
+#include <deal.II/dofs/dof_tools.h>
+#include <deal.II/base/index_set.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/fe/fe_q.h>
+#include <deal.II/fe/fe_dgq.h>
+
+
+template <int dim>
+void test()
+{
+  parallel::shared::Triangulation<dim> tria(MPI_COMM_WORLD,typename Triangulation<dim>::MeshSmoothing
+                                            (Triangulation<dim>::limit_level_difference_at_vertices), true,
+                                            typename parallel::shared::Triangulation<dim>::Settings
+                                            (parallel::shared::Triangulation<dim>::partition_zorder));
+  DoFHandler<dim> dof_handler(tria);
+  GridGenerator::subdivided_hyper_cube(tria,3,-1,1);
+  {
+    typename Triangulation<dim>::active_cell_iterator
+    cell = tria.begin_active(),
+    endc = tria.end();
+    for (; cell!=endc; ++cell)
+      {
+        if (cell->index() == 0 ||
+            cell->index() == 5 ||
+            cell->index() == 6)
+          cell->set_refine_flag();
+      }
+    tria.execute_coarsening_and_refinement();
+  }
+
+  FE_Q<dim> fe (2);
+  dof_handler.distribute_dofs(fe);
+
+  deallog << "Number of locally owned dofs: " << dof_handler.n_locally_owned_dofs() << std::endl;
+
+  std::vector<IndexSet> shared_dofs_per_proc = dof_handler.locally_owned_dofs_per_processor();
+  for (unsigned int i=0; i<Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD); ++i)
+    shared_dofs_per_proc[i].print(deallog.get_file_stream());
+
+  typename DoFHandler<dim>::active_cell_iterator
+  cell = dof_handler.begin_active(),
+  endc = dof_handler.end();
+  for (; cell!=endc; ++cell)
+    {
+      if (cell->subdomain_id() == numbers::artificial_subdomain_id)
+        continue;
+
+      std::vector<types::global_dof_index> local_dof_indices(fe.dofs_per_cell);
+      cell->get_dof_indices(local_dof_indices);
+      deallog << "cell" << cell->index() << " has dofs: ";
+      for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
+        deallog << local_dof_indices[i] << " ";
+      deallog << std::endl;
+    }
+}
+
+int main(int argc, char *argv[])
+{
+  Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
+  MPILogInitAll all;
+
+  deallog.push("2d");
+  test<2>();
+  deallog.pop();
+  deallog.push("3d");
+  test<3>();
+  deallog.pop();
+
+  deallog << "OK" << std::endl;
+}
+
+
diff --git a/tests/sharedtria/dof_06.mpirun=3.output b/tests/sharedtria/dof_06.mpirun=3.output
new file mode 100644 (file)
index 0000000..feb49c4
--- /dev/null
@@ -0,0 +1,176 @@
+
+DEAL:0:2d::Number of locally owned dofs: 39
+{[0,38]}
+{[39,70]}
+{[71,103]}
+DEAL:0:2d::cell1 has dofs: 0 1 2 3 4 5 6 7 8 
+DEAL:0:2d::cell2 has dofs: 1 39 3 40 5 41 42 43 44 
+DEAL:0:2d::cell3 has dofs: 9 2 10 11 12 13 14 15 16 
+DEAL:0:2d::cell4 has dofs: 2 3 11 45 13 46 7 47 48 
+DEAL:0:2d::cell7 has dofs: 11 45 71 72 73 74 47 75 76 
+DEAL:0:2d::cell0 has dofs: 17 18 19 20 21 22 23 24 25 
+DEAL:0:2d::cell1 has dofs: 18 0 20 26 22 27 28 29 30 
+DEAL:0:2d::cell2 has dofs: 19 20 9 31 32 33 24 34 35 
+DEAL:0:2d::cell3 has dofs: 20 26 31 2 33 36 29 37 38 
+DEAL:0:2d::cell4 has dofs: 3 50 51 52 53 54 55 56 57 
+DEAL:0:2d::cell8 has dofs: 10 82 83 84 85 86 87 88 89 
+DEAL:0:2d::cell9 has dofs: 82 11 84 90 86 91 92 93 94 
+DEAL:0:3d::Number of locally owned dofs: 253
+{[0,252]}
+{[253,515]}
+{[516,675]}
+DEAL:0:3d::cell1 has dofs: 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 
+DEAL:0:3d::cell2 has dofs: 1 27 3 28 5 29 7 30 9 31 32 33 13 34 35 36 17 37 19 38 21 39 40 41 42 43 44 
+DEAL:0:3d::cell3 has dofs: 45 2 46 47 48 6 49 50 51 52 53 54 55 56 57 58 59 18 60 61 62 63 64 65 66 67 68 
+DEAL:0:3d::cell4 has dofs: 2 3 47 69 6 7 50 70 52 71 11 72 56 73 15 74 18 19 61 75 63 76 23 77 78 79 80 
+DEAL:0:3d::cell7 has dofs: 47 69 253 516 50 70 254 517 518 519 72 520 521 522 74 523 61 75 524 525 526 527 77 528 529 530 531 
+DEAL:0:3d::cell8 has dofs: 69 255 516 532 70 256 517 533 519 534 535 536 522 537 257 538 75 539 525 540 527 541 542 543 544 545 546 
+DEAL:0:3d::cell9 has dofs: 81 4 48 6 82 83 84 85 86 12 87 57 88 89 90 91 92 93 94 95 96 97 98 99 100 101 102 
+DEAL:0:3d::cell10 has dofs: 4 5 6 7 83 103 85 104 12 13 14 15 89 105 106 107 93 108 95 109 97 110 111 112 25 113 114 
+DEAL:0:3d::cell11 has dofs: 5 29 7 30 103 258 104 259 13 34 35 36 105 260 261 262 108 263 109 264 110 265 266 267 43 268 269 
+DEAL:0:3d::cell12 has dofs: 48 6 49 50 84 85 115 116 55 56 57 58 117 118 91 119 94 95 120 121 122 123 99 124 67 125 126 
+DEAL:0:3d::cell13 has dofs: 6 7 50 70 85 104 116 127 56 73 15 74 118 128 107 129 95 109 121 130 123 131 112 132 79 133 134 
+DEAL:0:3d::cell14 has dofs: 7 30 70 256 104 259 127 270 73 271 36 257 128 272 262 273 109 264 130 274 131 275 267 276 277 278 279 
+DEAL:0:3d::cell15 has dofs: 49 50 280 254 115 116 547 548 549 521 58 550 551 552 119 553 120 121 554 555 556 557 124 558 559 560 561 
+DEAL:0:3d::cell16 has dofs: 50 70 254 517 116 127 548 562 521 522 74 523 552 563 129 564 121 130 555 565 557 566 132 567 530 568 569 
+DEAL:0:3d::cell17 has dofs: 70 256 517 533 127 270 562 570 522 537 257 538 563 571 273 572 130 274 565 573 566 574 276 575 545 576 577 
+DEAL:0:3d::cell18 has dofs: 82 83 84 85 578 579 580 581 88 89 90 91 582 583 584 585 586 587 588 589 590 591 592 593 101 594 595 
+DEAL:0:3d::cell19 has dofs: 83 103 85 104 579 596 581 597 89 105 106 107 583 598 599 600 587 601 589 602 591 603 604 605 113 606 607 
+DEAL:0:3d::cell20 has dofs: 103 258 104 259 596 608 597 609 105 260 261 262 598 610 611 612 601 613 602 614 603 615 616 617 268 618 619 
+DEAL:0:3d::cell21 has dofs: 84 85 115 116 580 581 620 621 117 118 91 119 622 623 585 624 588 589 625 626 627 628 593 629 125 630 631 
+DEAL:0:3d::cell22 has dofs: 85 104 116 127 581 597 621 632 118 128 107 129 623 633 600 634 589 602 626 635 628 636 605 637 133 638 639 
+DEAL:0:3d::cell23 has dofs: 104 259 127 270 597 609 632 640 128 272 262 273 633 641 612 642 602 614 635 643 636 644 617 645 278 646 647 
+DEAL:0:3d::cell24 has dofs: 115 116 547 548 620 621 648 649 551 552 119 553 650 651 624 652 625 626 653 654 655 656 629 657 560 658 659 
+DEAL:0:3d::cell25 has dofs: 116 127 548 562 621 632 649 660 552 563 129 564 651 661 634 662 626 635 654 663 656 664 637 665 568 666 667 
+DEAL:0:3d::cell26 has dofs: 127 270 562 570 632 640 660 668 563 571 273 572 661 669 642 670 635 643 663 671 664 672 645 673 576 674 675 
+DEAL:0:3d::cell0 has dofs: 135 136 137 138 139 140 141 142 143 144 145 146 147 148 149 150 151 152 153 154 155 156 157 158 159 160 161 
+DEAL:0:3d::cell1 has dofs: 136 0 138 162 140 163 142 164 144 165 166 167 148 168 169 170 152 171 154 172 156 173 174 175 176 177 178 
+DEAL:0:3d::cell2 has dofs: 137 138 45 179 141 142 180 181 182 183 146 184 185 186 150 187 153 154 188 189 190 191 158 192 193 194 195 
+DEAL:0:3d::cell3 has dofs: 138 162 179 2 142 164 181 196 183 197 167 198 186 199 170 200 154 172 189 201 191 202 175 203 204 205 206 
+DEAL:0:3d::cell4 has dofs: 139 140 141 142 81 207 208 209 147 148 149 150 210 211 212 213 214 215 216 217 218 219 220 221 160 222 223 
+DEAL:0:3d::cell5 has dofs: 140 163 142 164 207 4 209 224 148 168 169 170 211 225 226 227 215 228 217 229 219 230 231 232 177 233 234 
+DEAL:0:3d::cell6 has dofs: 141 142 180 181 208 209 48 235 185 186 150 187 236 237 213 238 216 217 239 240 241 242 221 243 194 244 245 
+DEAL:0:3d::cell7 has dofs: 142 164 181 196 209 224 235 6 186 199 170 200 237 246 227 247 217 229 240 248 242 249 232 250 205 251 252 
+DEAL:0:3d::cell8 has dofs: 3 281 282 283 284 285 286 287 288 289 290 291 292 293 294 295 296 297 298 299 300 301 302 303 304 305 306 
+DEAL:0:3d::cell9 has dofs: 281 28 283 307 285 308 287 309 289 310 311 312 293 313 314 315 297 316 299 317 301 318 319 320 321 322 323 
+DEAL:0:3d::cell10 has dofs: 282 283 69 324 286 287 325 326 327 328 291 329 330 331 295 332 298 299 333 334 335 336 303 337 338 339 340 
+DEAL:0:3d::cell12 has dofs: 284 285 286 287 7 352 353 354 292 293 294 295 355 356 357 358 359 360 361 362 363 364 365 366 305 367 368 
+DEAL:0:3d::cell13 has dofs: 285 308 287 309 352 30 354 369 293 313 314 315 356 370 371 372 360 373 362 374 364 375 376 377 322 378 379 
+DEAL:0:3d::cell14 has dofs: 286 287 325 326 353 354 70 380 330 331 295 332 381 382 358 383 361 362 384 385 386 387 366 388 339 389 390 
+DEAL:0:3d::cell16 has dofs: 46 398 399 400 401 402 403 404 405 406 407 408 409 410 411 412 413 414 415 416 417 418 419 420 421 422 423 
+DEAL:0:3d::cell17 has dofs: 398 47 400 424 402 425 404 426 406 427 428 429 410 430 431 432 414 433 416 434 418 435 436 437 438 439 440 
+DEAL:0:3d::cell20 has dofs: 401 402 403 404 49 470 471 472 409 410 411 412 473 474 475 476 477 478 479 480 481 482 483 484 422 485 486 
+DEAL:0:3d::cell21 has dofs: 402 425 404 426 470 50 472 487 410 430 431 432 474 488 489 490 478 491 480 492 482 493 494 495 439 496 497 
+DEAL:0::OK
+
+DEAL:1:2d::Number of locally owned dofs: 32
+{[0,38]}
+{[39,70]}
+{[71,103]}
+DEAL:1:2d::cell1 has dofs: 0 1 2 3 4 5 6 7 8 
+DEAL:1:2d::cell2 has dofs: 1 39 3 40 5 41 42 43 44 
+DEAL:1:2d::cell3 has dofs: 9 2 10 11 12 13 14 15 16 
+DEAL:1:2d::cell4 has dofs: 2 3 11 45 13 46 7 47 48 
+DEAL:1:2d::cell7 has dofs: 11 45 71 72 73 74 47 75 76 
+DEAL:1:2d::cell8 has dofs: 45 49 72 77 74 78 79 80 81 
+DEAL:1:2d::cell3 has dofs: 20 26 31 2 33 36 29 37 38 
+DEAL:1:2d::cell4 has dofs: 3 50 51 52 53 54 55 56 57 
+DEAL:1:2d::cell5 has dofs: 50 40 52 58 54 59 60 61 62 
+DEAL:1:2d::cell6 has dofs: 51 52 45 63 64 65 56 66 67 
+DEAL:1:2d::cell7 has dofs: 52 58 63 49 65 68 61 69 70 
+DEAL:1:2d::cell9 has dofs: 82 11 84 90 86 91 92 93 94 
+DEAL:1:3d::Number of locally owned dofs: 263
+{[0,252]}
+{[253,515]}
+{[516,675]}
+DEAL:1:3d::cell1 has dofs: 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 
+DEAL:1:3d::cell2 has dofs: 1 27 3 28 5 29 7 30 9 31 32 33 13 34 35 36 17 37 19 38 21 39 40 41 42 43 44 
+DEAL:1:3d::cell3 has dofs: 45 2 46 47 48 6 49 50 51 52 53 54 55 56 57 58 59 18 60 61 62 63 64 65 66 67 68 
+DEAL:1:3d::cell4 has dofs: 2 3 47 69 6 7 50 70 52 71 11 72 56 73 15 74 18 19 61 75 63 76 23 77 78 79 80 
+DEAL:1:3d::cell7 has dofs: 47 69 253 516 50 70 254 517 518 519 72 520 521 522 74 523 61 75 524 525 526 527 77 528 529 530 531 
+DEAL:1:3d::cell8 has dofs: 69 255 516 532 70 256 517 533 519 534 535 536 522 537 257 538 75 539 525 540 527 541 542 543 544 545 546 
+DEAL:1:3d::cell10 has dofs: 4 5 6 7 83 103 85 104 12 13 14 15 89 105 106 107 93 108 95 109 97 110 111 112 25 113 114 
+DEAL:1:3d::cell11 has dofs: 5 29 7 30 103 258 104 259 13 34 35 36 105 260 261 262 108 263 109 264 110 265 266 267 43 268 269 
+DEAL:1:3d::cell12 has dofs: 48 6 49 50 84 85 115 116 55 56 57 58 117 118 91 119 94 95 120 121 122 123 99 124 67 125 126 
+DEAL:1:3d::cell13 has dofs: 6 7 50 70 85 104 116 127 56 73 15 74 118 128 107 129 95 109 121 130 123 131 112 132 79 133 134 
+DEAL:1:3d::cell14 has dofs: 7 30 70 256 104 259 127 270 73 271 36 257 128 272 262 273 109 264 130 274 131 275 267 276 277 278 279 
+DEAL:1:3d::cell15 has dofs: 49 50 280 254 115 116 547 548 549 521 58 550 551 552 119 553 120 121 554 555 556 557 124 558 559 560 561 
+DEAL:1:3d::cell16 has dofs: 50 70 254 517 116 127 548 562 521 522 74 523 552 563 129 564 121 130 555 565 557 566 132 567 530 568 569 
+DEAL:1:3d::cell17 has dofs: 70 256 517 533 127 270 562 570 522 537 257 538 563 571 273 572 130 274 565 573 566 574 276 575 545 576 577 
+DEAL:1:3d::cell19 has dofs: 83 103 85 104 579 596 581 597 89 105 106 107 583 598 599 600 587 601 589 602 591 603 604 605 113 606 607 
+DEAL:1:3d::cell20 has dofs: 103 258 104 259 596 608 597 609 105 260 261 262 598 610 611 612 601 613 602 614 603 615 616 617 268 618 619 
+DEAL:1:3d::cell22 has dofs: 85 104 116 127 581 597 621 632 118 128 107 129 623 633 600 634 589 602 626 635 628 636 605 637 133 638 639 
+DEAL:1:3d::cell23 has dofs: 104 259 127 270 597 609 632 640 128 272 262 273 633 641 612 642 602 614 635 643 636 644 617 645 278 646 647 
+DEAL:1:3d::cell25 has dofs: 116 127 548 562 621 632 649 660 552 563 129 564 651 661 634 662 626 635 654 663 656 664 637 665 568 666 667 
+DEAL:1:3d::cell26 has dofs: 127 270 562 570 632 640 660 668 563 571 273 572 661 669 642 670 635 643 663 671 664 672 645 673 576 674 675 
+DEAL:1:3d::cell8 has dofs: 3 281 282 283 284 285 286 287 288 289 290 291 292 293 294 295 296 297 298 299 300 301 302 303 304 305 306 
+DEAL:1:3d::cell9 has dofs: 281 28 283 307 285 308 287 309 289 310 311 312 293 313 314 315 297 316 299 317 301 318 319 320 321 322 323 
+DEAL:1:3d::cell10 has dofs: 282 283 69 324 286 287 325 326 327 328 291 329 330 331 295 332 298 299 333 334 335 336 303 337 338 339 340 
+DEAL:1:3d::cell11 has dofs: 283 307 324 255 287 309 326 341 328 342 312 343 331 344 315 345 299 317 334 346 336 347 320 348 349 350 351 
+DEAL:1:3d::cell12 has dofs: 284 285 286 287 7 352 353 354 292 293 294 295 355 356 357 358 359 360 361 362 363 364 365 366 305 367 368 
+DEAL:1:3d::cell13 has dofs: 285 308 287 309 352 30 354 369 293 313 314 315 356 370 371 372 360 373 362 374 364 375 376 377 322 378 379 
+DEAL:1:3d::cell14 has dofs: 286 287 325 326 353 354 70 380 330 331 295 332 381 382 358 383 361 362 384 385 386 387 366 388 339 389 390 
+DEAL:1:3d::cell15 has dofs: 287 309 326 341 354 369 380 256 331 344 315 345 382 391 372 392 362 374 385 393 387 394 377 395 350 396 397 
+DEAL:1:3d::cell16 has dofs: 46 398 399 400 401 402 403 404 405 406 407 408 409 410 411 412 413 414 415 416 417 418 419 420 421 422 423 
+DEAL:1:3d::cell17 has dofs: 398 47 400 424 402 425 404 426 406 427 428 429 410 430 431 432 414 433 416 434 418 435 436 437 438 439 440 
+DEAL:1:3d::cell18 has dofs: 399 400 441 442 403 404 443 444 445 446 408 447 448 449 412 450 415 416 451 452 453 454 420 455 456 457 458 
+DEAL:1:3d::cell19 has dofs: 400 424 442 253 404 426 444 459 446 460 429 461 449 462 432 463 416 434 452 464 454 465 437 466 467 468 469 
+DEAL:1:3d::cell20 has dofs: 401 402 403 404 49 470 471 472 409 410 411 412 473 474 475 476 477 478 479 480 481 482 483 484 422 485 486 
+DEAL:1:3d::cell21 has dofs: 402 425 404 426 470 50 472 487 410 430 431 432 474 488 489 490 478 491 480 492 482 493 494 495 439 496 497 
+DEAL:1:3d::cell22 has dofs: 403 404 443 444 471 472 280 498 448 449 412 450 499 500 476 501 479 480 502 503 504 505 484 506 457 507 508 
+DEAL:1:3d::cell23 has dofs: 404 426 444 459 472 487 498 254 449 462 432 463 500 509 490 510 480 492 503 511 505 512 495 513 468 514 515 
+DEAL:1::OK
+
+
+DEAL:2:2d::Number of locally owned dofs: 33
+{[0,38]}
+{[39,70]}
+{[71,103]}
+DEAL:2:2d::cell3 has dofs: 9 2 10 11 12 13 14 15 16 
+DEAL:2:2d::cell4 has dofs: 2 3 11 45 13 46 7 47 48 
+DEAL:2:2d::cell7 has dofs: 11 45 71 72 73 74 47 75 76 
+DEAL:2:2d::cell8 has dofs: 45 49 72 77 74 78 79 80 81 
+DEAL:2:2d::cell6 has dofs: 51 52 45 63 64 65 56 66 67 
+DEAL:2:2d::cell7 has dofs: 52 58 63 49 65 68 61 69 70 
+DEAL:2:2d::cell8 has dofs: 10 82 83 84 85 86 87 88 89 
+DEAL:2:2d::cell9 has dofs: 82 11 84 90 86 91 92 93 94 
+DEAL:2:2d::cell10 has dofs: 83 84 95 96 97 98 88 99 100 
+DEAL:2:2d::cell11 has dofs: 84 90 96 71 98 101 93 102 103 
+DEAL:2:3d::Number of locally owned dofs: 160
+{[0,252]}
+{[253,515]}
+{[516,675]}
+DEAL:2:3d::cell3 has dofs: 45 2 46 47 48 6 49 50 51 52 53 54 55 56 57 58 59 18 60 61 62 63 64 65 66 67 68 
+DEAL:2:3d::cell4 has dofs: 2 3 47 69 6 7 50 70 52 71 11 72 56 73 15 74 18 19 61 75 63 76 23 77 78 79 80 
+DEAL:2:3d::cell7 has dofs: 47 69 253 516 50 70 254 517 518 519 72 520 521 522 74 523 61 75 524 525 526 527 77 528 529 530 531 
+DEAL:2:3d::cell8 has dofs: 69 255 516 532 70 256 517 533 519 534 535 536 522 537 257 538 75 539 525 540 527 541 542 543 544 545 546 
+DEAL:2:3d::cell9 has dofs: 81 4 48 6 82 83 84 85 86 12 87 57 88 89 90 91 92 93 94 95 96 97 98 99 100 101 102 
+DEAL:2:3d::cell10 has dofs: 4 5 6 7 83 103 85 104 12 13 14 15 89 105 106 107 93 108 95 109 97 110 111 112 25 113 114 
+DEAL:2:3d::cell11 has dofs: 5 29 7 30 103 258 104 259 13 34 35 36 105 260 261 262 108 263 109 264 110 265 266 267 43 268 269 
+DEAL:2:3d::cell12 has dofs: 48 6 49 50 84 85 115 116 55 56 57 58 117 118 91 119 94 95 120 121 122 123 99 124 67 125 126 
+DEAL:2:3d::cell13 has dofs: 6 7 50 70 85 104 116 127 56 73 15 74 118 128 107 129 95 109 121 130 123 131 112 132 79 133 134 
+DEAL:2:3d::cell14 has dofs: 7 30 70 256 104 259 127 270 73 271 36 257 128 272 262 273 109 264 130 274 131 275 267 276 277 278 279 
+DEAL:2:3d::cell15 has dofs: 49 50 280 254 115 116 547 548 549 521 58 550 551 552 119 553 120 121 554 555 556 557 124 558 559 560 561 
+DEAL:2:3d::cell16 has dofs: 50 70 254 517 116 127 548 562 521 522 74 523 552 563 129 564 121 130 555 565 557 566 132 567 530 568 569 
+DEAL:2:3d::cell17 has dofs: 70 256 517 533 127 270 562 570 522 537 257 538 563 571 273 572 130 274 565 573 566 574 276 575 545 576 577 
+DEAL:2:3d::cell18 has dofs: 82 83 84 85 578 579 580 581 88 89 90 91 582 583 584 585 586 587 588 589 590 591 592 593 101 594 595 
+DEAL:2:3d::cell19 has dofs: 83 103 85 104 579 596 581 597 89 105 106 107 583 598 599 600 587 601 589 602 591 603 604 605 113 606 607 
+DEAL:2:3d::cell20 has dofs: 103 258 104 259 596 608 597 609 105 260 261 262 598 610 611 612 601 613 602 614 603 615 616 617 268 618 619 
+DEAL:2:3d::cell21 has dofs: 84 85 115 116 580 581 620 621 117 118 91 119 622 623 585 624 588 589 625 626 627 628 593 629 125 630 631 
+DEAL:2:3d::cell22 has dofs: 85 104 116 127 581 597 621 632 118 128 107 129 623 633 600 634 589 602 626 635 628 636 605 637 133 638 639 
+DEAL:2:3d::cell23 has dofs: 104 259 127 270 597 609 632 640 128 272 262 273 633 641 612 642 602 614 635 643 636 644 617 645 278 646 647 
+DEAL:2:3d::cell24 has dofs: 115 116 547 548 620 621 648 649 551 552 119 553 650 651 624 652 625 626 653 654 655 656 629 657 560 658 659 
+DEAL:2:3d::cell25 has dofs: 116 127 548 562 621 632 649 660 552 563 129 564 651 661 634 662 626 635 654 663 656 664 637 665 568 666 667 
+DEAL:2:3d::cell26 has dofs: 127 270 562 570 632 640 660 668 563 571 273 572 661 669 642 670 635 643 663 671 664 672 645 673 576 674 675 
+DEAL:2:3d::cell10 has dofs: 282 283 69 324 286 287 325 326 327 328 291 329 330 331 295 332 298 299 333 334 335 336 303 337 338 339 340 
+DEAL:2:3d::cell11 has dofs: 283 307 324 255 287 309 326 341 328 342 312 343 331 344 315 345 299 317 334 346 336 347 320 348 349 350 351 
+DEAL:2:3d::cell14 has dofs: 286 287 325 326 353 354 70 380 330 331 295 332 381 382 358 383 361 362 384 385 386 387 366 388 339 389 390 
+DEAL:2:3d::cell15 has dofs: 287 309 326 341 354 369 380 256 331 344 315 345 382 391 372 392 362 374 385 393 387 394 377 395 350 396 397 
+DEAL:2:3d::cell17 has dofs: 398 47 400 424 402 425 404 426 406 427 428 429 410 430 431 432 414 433 416 434 418 435 436 437 438 439 440 
+DEAL:2:3d::cell19 has dofs: 400 424 442 253 404 426 444 459 446 460 429 461 449 462 432 463 416 434 452 464 454 465 437 466 467 468 469 
+DEAL:2:3d::cell20 has dofs: 401 402 403 404 49 470 471 472 409 410 411 412 473 474 475 476 477 478 479 480 481 482 483 484 422 485 486 
+DEAL:2:3d::cell21 has dofs: 402 425 404 426 470 50 472 487 410 430 431 432 474 488 489 490 478 491 480 492 482 493 494 495 439 496 497 
+DEAL:2:3d::cell22 has dofs: 403 404 443 444 471 472 280 498 448 449 412 450 499 500 476 501 479 480 502 503 504 505 484 506 457 507 508 
+DEAL:2:3d::cell23 has dofs: 404 426 444 459 472 487 498 254 449 462 432 463 500 509 490 510 480 492 503 511 505 512 495 513 468 514 515 
+DEAL:2::OK
+
index 81969ccd2c03fb85963738f3c7caf92fd53f6127..7434e96b8feba0b23721ff08c01fb14276e2c759 100644 (file)
@@ -1,58 +1,58 @@
 
 DEAL:0:1d::n_dofs: 3
-DEAL:0:1d::n_locally_owned_dofs: 1
-DEAL:0:1d::n_locally_owned_dofs_per_processor: 1 2 0  sum: 3
+DEAL:0:1d::n_locally_owned_dofs: 2
+DEAL:0:1d::n_locally_owned_dofs_per_processor: 2 1 0  sum: 3
 3 1
-0 1
+0 2
 DEAL:0:1d:: locally_owned_dofs: 
 DEAL:0:2d::n_dofs: 9
-DEAL:0:2d::n_locally_owned_dofs: 4
-DEAL:0:2d::n_locally_owned_dofs_per_processor: 4 3 2  sum: 9
+DEAL:0:2d::n_locally_owned_dofs: 7
+DEAL:0:2d::n_locally_owned_dofs_per_processor: 7 1 1  sum: 9
 9 1
-0 4
+0 7
 DEAL:0:2d:: locally_owned_dofs: 
 DEAL:0:3d::n_dofs: 27
-DEAL:0:3d::n_locally_owned_dofs: 10
-DEAL:0:3d::n_locally_owned_dofs_per_processor: 10 11 6  sum: 27
+DEAL:0:3d::n_locally_owned_dofs: 19
+DEAL:0:3d::n_locally_owned_dofs_per_processor: 19 6 2  sum: 27
 27 1
-0 10
+0 19
 DEAL:0:3d:: locally_owned_dofs: 
 
 DEAL:1:1d::n_dofs: 3
-DEAL:1:1d::n_locally_owned_dofs: 2
-DEAL:1:1d::n_locally_owned_dofs_per_processor: 1 2 0  sum: 3
+DEAL:1:1d::n_locally_owned_dofs: 1
+DEAL:1:1d::n_locally_owned_dofs_per_processor: 2 1 0  sum: 3
 3 1
-1 3
+2 3
 DEAL:1:1d:: locally_owned_dofs: 
 DEAL:1:2d::n_dofs: 9
-DEAL:1:2d::n_locally_owned_dofs: 3
-DEAL:1:2d::n_locally_owned_dofs_per_processor: 4 3 2  sum: 9
+DEAL:1:2d::n_locally_owned_dofs: 1
+DEAL:1:2d::n_locally_owned_dofs_per_processor: 7 1 1  sum: 9
 9 1
-4 7
+7 8
 DEAL:1:2d:: locally_owned_dofs: 
 DEAL:1:3d::n_dofs: 27
-DEAL:1:3d::n_locally_owned_dofs: 11
-DEAL:1:3d::n_locally_owned_dofs_per_processor: 10 11 6  sum: 27
+DEAL:1:3d::n_locally_owned_dofs: 6
+DEAL:1:3d::n_locally_owned_dofs_per_processor: 19 6 2  sum: 27
 27 1
-10 21
+19 25
 DEAL:1:3d:: locally_owned_dofs: 
 
 
 DEAL:2:1d::n_dofs: 3
 DEAL:2:1d::n_locally_owned_dofs: 0
-DEAL:2:1d::n_locally_owned_dofs_per_processor: 1 2 0  sum: 3
+DEAL:2:1d::n_locally_owned_dofs_per_processor: 2 1 0  sum: 3
 3 0
 DEAL:2:1d:: locally_owned_dofs: 
 DEAL:2:2d::n_dofs: 9
-DEAL:2:2d::n_locally_owned_dofs: 2
-DEAL:2:2d::n_locally_owned_dofs_per_processor: 4 3 2  sum: 9
+DEAL:2:2d::n_locally_owned_dofs: 1
+DEAL:2:2d::n_locally_owned_dofs_per_processor: 7 1 1  sum: 9
 9 1
-7 9
+8 9
 DEAL:2:2d:: locally_owned_dofs: 
 DEAL:2:3d::n_dofs: 27
-DEAL:2:3d::n_locally_owned_dofs: 6
-DEAL:2:3d::n_locally_owned_dofs_per_processor: 10 11 6  sum: 27
+DEAL:2:3d::n_locally_owned_dofs: 2
+DEAL:2:3d::n_locally_owned_dofs_per_processor: 19 6 2  sum: 27
 27 1
-21 27
+25 27
 DEAL:2:3d:: locally_owned_dofs: 
 
index 648350f6cd29a4ca579b4e948bc696e352ee3cf6..36a2dacc54d50b4c7e7f3d6fb08758401d1762db 100644 (file)
@@ -1,95 +1,95 @@
 
 DEAL:0:1d::n_dofs: 3
-DEAL:0:1d::n_locally_owned_dofs: 1
-DEAL:0:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0  sum: 3
+DEAL:0:1d::n_locally_owned_dofs: 2
+DEAL:0:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0  sum: 3
 3 1
-0 1
+0 2
 DEAL:0:1d:: locally_owned_dofs: 
 DEAL:0:2d::n_dofs: 9
-DEAL:0:2d::n_locally_owned_dofs: 1
-DEAL:0:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0  sum: 9
+DEAL:0:2d::n_locally_owned_dofs: 4
+DEAL:0:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0  sum: 9
 9 1
-0 1
+0 4
 DEAL:0:2d:: locally_owned_dofs: 
 DEAL:0:3d::n_dofs: 27
-DEAL:0:3d::n_locally_owned_dofs: 5
-DEAL:0:3d::n_locally_owned_dofs_per_processor: 5 8 7 5 2  sum: 27
+DEAL:0:3d::n_locally_owned_dofs: 14
+DEAL:0:3d::n_locally_owned_dofs_per_processor: 14 7 4 1 1  sum: 27
 27 1
-0 5
+0 14
 DEAL:0:3d:: locally_owned_dofs: 
 
 DEAL:1:1d::n_dofs: 3
-DEAL:1:1d::n_locally_owned_dofs: 2
-DEAL:1:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0  sum: 3
+DEAL:1:1d::n_locally_owned_dofs: 1
+DEAL:1:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0  sum: 3
 3 1
-1 3
+2 3
 DEAL:1:1d:: locally_owned_dofs: 
 DEAL:1:2d::n_dofs: 9
-DEAL:1:2d::n_locally_owned_dofs: 3
-DEAL:1:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0  sum: 9
+DEAL:1:2d::n_locally_owned_dofs: 2
+DEAL:1:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0  sum: 9
 9 1
-1 4
+4 6
 DEAL:1:2d:: locally_owned_dofs: 
 DEAL:1:3d::n_dofs: 27
-DEAL:1:3d::n_locally_owned_dofs: 8
-DEAL:1:3d::n_locally_owned_dofs_per_processor: 5 8 7 5 2  sum: 27
+DEAL:1:3d::n_locally_owned_dofs: 7
+DEAL:1:3d::n_locally_owned_dofs_per_processor: 14 7 4 1 1  sum: 27
 27 1
-5 13
+14 21
 DEAL:1:3d:: locally_owned_dofs: 
 
 
 DEAL:2:1d::n_dofs: 3
 DEAL:2:1d::n_locally_owned_dofs: 0
-DEAL:2:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0  sum: 3
+DEAL:2:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0  sum: 3
 3 0
 DEAL:2:1d:: locally_owned_dofs: 
 DEAL:2:2d::n_dofs: 9
 DEAL:2:2d::n_locally_owned_dofs: 2
-DEAL:2:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0  sum: 9
+DEAL:2:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0  sum: 9
 9 1
-4 6
+6 8
 DEAL:2:2d:: locally_owned_dofs: 
 DEAL:2:3d::n_dofs: 27
-DEAL:2:3d::n_locally_owned_dofs: 7
-DEAL:2:3d::n_locally_owned_dofs_per_processor: 5 8 7 5 2  sum: 27
+DEAL:2:3d::n_locally_owned_dofs: 4
+DEAL:2:3d::n_locally_owned_dofs_per_processor: 14 7 4 1 1  sum: 27
 27 1
-13 20
+21 25
 DEAL:2:3d:: locally_owned_dofs: 
 
 
 DEAL:3:1d::n_dofs: 3
 DEAL:3:1d::n_locally_owned_dofs: 0
-DEAL:3:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0  sum: 3
+DEAL:3:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0  sum: 3
 3 0
 DEAL:3:1d:: locally_owned_dofs: 
 DEAL:3:2d::n_dofs: 9
-DEAL:3:2d::n_locally_owned_dofs: 3
-DEAL:3:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0  sum: 9
+DEAL:3:2d::n_locally_owned_dofs: 1
+DEAL:3:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0  sum: 9
 9 1
-6 9
+8 9
 DEAL:3:2d:: locally_owned_dofs: 
 DEAL:3:3d::n_dofs: 27
-DEAL:3:3d::n_locally_owned_dofs: 5
-DEAL:3:3d::n_locally_owned_dofs_per_processor: 5 8 7 5 2  sum: 27
+DEAL:3:3d::n_locally_owned_dofs: 1
+DEAL:3:3d::n_locally_owned_dofs_per_processor: 14 7 4 1 1  sum: 27
 27 1
-20 25
+25 26
 DEAL:3:3d:: locally_owned_dofs: 
 
 
 DEAL:4:1d::n_dofs: 3
 DEAL:4:1d::n_locally_owned_dofs: 0
-DEAL:4:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0  sum: 3
+DEAL:4:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0  sum: 3
 3 0
 DEAL:4:1d:: locally_owned_dofs: 
 DEAL:4:2d::n_dofs: 9
 DEAL:4:2d::n_locally_owned_dofs: 0
-DEAL:4:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0  sum: 9
+DEAL:4:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0  sum: 9
 9 0
 DEAL:4:2d:: locally_owned_dofs: 
 DEAL:4:3d::n_dofs: 27
-DEAL:4:3d::n_locally_owned_dofs: 2
-DEAL:4:3d::n_locally_owned_dofs_per_processor: 5 8 7 5 2  sum: 27
+DEAL:4:3d::n_locally_owned_dofs: 1
+DEAL:4:3d::n_locally_owned_dofs_per_processor: 14 7 4 1 1  sum: 27
 27 1
-25 27
+26 27
 DEAL:4:3d:: locally_owned_dofs: 
 
index 06567b8304288d5e334d9c431db4833aed2795f2..8ff8a42b6816feae8c17b318bb2a3729dea738de 100644 (file)
 
 DEAL:0:1d::n_dofs: 3
-DEAL:0:1d::n_locally_owned_dofs: 1
-DEAL:0:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:0:1d::n_locally_owned_dofs: 2
+DEAL:0:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 1
-0 1
+0 2
 DEAL:0:1d:: locally_owned_dofs: 
 DEAL:0:2d::n_dofs: 9
-DEAL:0:2d::n_locally_owned_dofs: 1
-DEAL:0:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:0:2d::n_locally_owned_dofs: 4
+DEAL:0:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 1
-0 1
+0 4
 DEAL:0:2d:: locally_owned_dofs: 
 DEAL:0:3d::n_dofs: 27
-DEAL:0:3d::n_locally_owned_dofs: 1
-DEAL:0:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:0:3d::n_locally_owned_dofs: 8
+DEAL:0:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-0 1
+0 8
 DEAL:0:3d:: locally_owned_dofs: 
 
 DEAL:1:1d::n_dofs: 3
-DEAL:1:1d::n_locally_owned_dofs: 2
-DEAL:1:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:1:1d::n_locally_owned_dofs: 1
+DEAL:1:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 1
-1 3
+2 3
 DEAL:1:1d:: locally_owned_dofs: 
 DEAL:1:2d::n_dofs: 9
-DEAL:1:2d::n_locally_owned_dofs: 3
-DEAL:1:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:1:2d::n_locally_owned_dofs: 2
+DEAL:1:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 1
-1 4
+4 6
 DEAL:1:2d:: locally_owned_dofs: 
 DEAL:1:3d::n_dofs: 27
 DEAL:1:3d::n_locally_owned_dofs: 4
-DEAL:1:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:1:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-1 5
+8 12
 DEAL:1:3d:: locally_owned_dofs: 
 
 
 DEAL:2:1d::n_dofs: 3
 DEAL:2:1d::n_locally_owned_dofs: 0
-DEAL:2:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:2:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:2:1d:: locally_owned_dofs: 
 DEAL:2:2d::n_dofs: 9
 DEAL:2:2d::n_locally_owned_dofs: 2
-DEAL:2:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:2:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 1
-4 6
+6 8
 DEAL:2:2d:: locally_owned_dofs: 
 DEAL:2:3d::n_dofs: 27
-DEAL:2:3d::n_locally_owned_dofs: 2
-DEAL:2:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:2:3d::n_locally_owned_dofs: 4
+DEAL:2:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-5 7
+12 16
 DEAL:2:3d:: locally_owned_dofs: 
 
 
 DEAL:3:1d::n_dofs: 3
 DEAL:3:1d::n_locally_owned_dofs: 0
-DEAL:3:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:3:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:3:1d:: locally_owned_dofs: 
 DEAL:3:2d::n_dofs: 9
-DEAL:3:2d::n_locally_owned_dofs: 3
-DEAL:3:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:3:2d::n_locally_owned_dofs: 1
+DEAL:3:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 1
-6 9
+8 9
 DEAL:3:2d:: locally_owned_dofs: 
 DEAL:3:3d::n_dofs: 27
-DEAL:3:3d::n_locally_owned_dofs: 5
-DEAL:3:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:3:3d::n_locally_owned_dofs: 2
+DEAL:3:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-7 12
+16 18
 DEAL:3:3d:: locally_owned_dofs: 
 
 
 DEAL:4:1d::n_dofs: 3
 DEAL:4:1d::n_locally_owned_dofs: 0
-DEAL:4:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:4:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:4:1d:: locally_owned_dofs: 
 DEAL:4:2d::n_dofs: 9
 DEAL:4:2d::n_locally_owned_dofs: 0
-DEAL:4:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:4:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 0
 DEAL:4:2d:: locally_owned_dofs: 
 DEAL:4:3d::n_dofs: 27
-DEAL:4:3d::n_locally_owned_dofs: 2
-DEAL:4:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:4:3d::n_locally_owned_dofs: 4
+DEAL:4:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-12 14
+18 22
 DEAL:4:3d:: locally_owned_dofs: 
 
 
 DEAL:5:1d::n_dofs: 3
 DEAL:5:1d::n_locally_owned_dofs: 0
-DEAL:5:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:5:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:5:1d:: locally_owned_dofs: 
 DEAL:5:2d::n_dofs: 9
 DEAL:5:2d::n_locally_owned_dofs: 0
-DEAL:5:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:5:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 0
 DEAL:5:2d:: locally_owned_dofs: 
 DEAL:5:3d::n_dofs: 27
-DEAL:5:3d::n_locally_owned_dofs: 4
-DEAL:5:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:5:3d::n_locally_owned_dofs: 2
+DEAL:5:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-14 18
+22 24
 DEAL:5:3d:: locally_owned_dofs: 
 
 
 DEAL:6:1d::n_dofs: 3
 DEAL:6:1d::n_locally_owned_dofs: 0
-DEAL:6:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:6:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:6:1d:: locally_owned_dofs: 
 DEAL:6:2d::n_dofs: 9
 DEAL:6:2d::n_locally_owned_dofs: 0
-DEAL:6:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:6:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 0
 DEAL:6:2d:: locally_owned_dofs: 
 DEAL:6:3d::n_dofs: 27
-DEAL:6:3d::n_locally_owned_dofs: 4
-DEAL:6:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:6:3d::n_locally_owned_dofs: 2
+DEAL:6:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-18 22
+24 26
 DEAL:6:3d:: locally_owned_dofs: 
 
 
 DEAL:7:1d::n_dofs: 3
 DEAL:7:1d::n_locally_owned_dofs: 0
-DEAL:7:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:7:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:7:1d:: locally_owned_dofs: 
 DEAL:7:2d::n_dofs: 9
 DEAL:7:2d::n_locally_owned_dofs: 0
-DEAL:7:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:7:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 0
 DEAL:7:2d:: locally_owned_dofs: 
 DEAL:7:3d::n_dofs: 27
-DEAL:7:3d::n_locally_owned_dofs: 5
-DEAL:7:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:7:3d::n_locally_owned_dofs: 1
+DEAL:7:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-22 27
+26 27
 DEAL:7:3d:: locally_owned_dofs: 
 
 
 DEAL:8:1d::n_dofs: 3
 DEAL:8:1d::n_locally_owned_dofs: 0
-DEAL:8:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:8:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:8:1d:: locally_owned_dofs: 
 DEAL:8:2d::n_dofs: 9
 DEAL:8:2d::n_locally_owned_dofs: 0
-DEAL:8:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:8:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 0
 DEAL:8:2d:: locally_owned_dofs: 
 DEAL:8:3d::n_dofs: 27
 DEAL:8:3d::n_locally_owned_dofs: 0
-DEAL:8:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:8:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 0
 DEAL:8:3d:: locally_owned_dofs: 
 
index 81969ccd2c03fb85963738f3c7caf92fd53f6127..7434e96b8feba0b23721ff08c01fb14276e2c759 100644 (file)
@@ -1,58 +1,58 @@
 
 DEAL:0:1d::n_dofs: 3
-DEAL:0:1d::n_locally_owned_dofs: 1
-DEAL:0:1d::n_locally_owned_dofs_per_processor: 1 2 0  sum: 3
+DEAL:0:1d::n_locally_owned_dofs: 2
+DEAL:0:1d::n_locally_owned_dofs_per_processor: 2 1 0  sum: 3
 3 1
-0 1
+0 2
 DEAL:0:1d:: locally_owned_dofs: 
 DEAL:0:2d::n_dofs: 9
-DEAL:0:2d::n_locally_owned_dofs: 4
-DEAL:0:2d::n_locally_owned_dofs_per_processor: 4 3 2  sum: 9
+DEAL:0:2d::n_locally_owned_dofs: 7
+DEAL:0:2d::n_locally_owned_dofs_per_processor: 7 1 1  sum: 9
 9 1
-0 4
+0 7
 DEAL:0:2d:: locally_owned_dofs: 
 DEAL:0:3d::n_dofs: 27
-DEAL:0:3d::n_locally_owned_dofs: 10
-DEAL:0:3d::n_locally_owned_dofs_per_processor: 10 11 6  sum: 27
+DEAL:0:3d::n_locally_owned_dofs: 19
+DEAL:0:3d::n_locally_owned_dofs_per_processor: 19 6 2  sum: 27
 27 1
-0 10
+0 19
 DEAL:0:3d:: locally_owned_dofs: 
 
 DEAL:1:1d::n_dofs: 3
-DEAL:1:1d::n_locally_owned_dofs: 2
-DEAL:1:1d::n_locally_owned_dofs_per_processor: 1 2 0  sum: 3
+DEAL:1:1d::n_locally_owned_dofs: 1
+DEAL:1:1d::n_locally_owned_dofs_per_processor: 2 1 0  sum: 3
 3 1
-1 3
+2 3
 DEAL:1:1d:: locally_owned_dofs: 
 DEAL:1:2d::n_dofs: 9
-DEAL:1:2d::n_locally_owned_dofs: 3
-DEAL:1:2d::n_locally_owned_dofs_per_processor: 4 3 2  sum: 9
+DEAL:1:2d::n_locally_owned_dofs: 1
+DEAL:1:2d::n_locally_owned_dofs_per_processor: 7 1 1  sum: 9
 9 1
-4 7
+7 8
 DEAL:1:2d:: locally_owned_dofs: 
 DEAL:1:3d::n_dofs: 27
-DEAL:1:3d::n_locally_owned_dofs: 11
-DEAL:1:3d::n_locally_owned_dofs_per_processor: 10 11 6  sum: 27
+DEAL:1:3d::n_locally_owned_dofs: 6
+DEAL:1:3d::n_locally_owned_dofs_per_processor: 19 6 2  sum: 27
 27 1
-10 21
+19 25
 DEAL:1:3d:: locally_owned_dofs: 
 
 
 DEAL:2:1d::n_dofs: 3
 DEAL:2:1d::n_locally_owned_dofs: 0
-DEAL:2:1d::n_locally_owned_dofs_per_processor: 1 2 0  sum: 3
+DEAL:2:1d::n_locally_owned_dofs_per_processor: 2 1 0  sum: 3
 3 0
 DEAL:2:1d:: locally_owned_dofs: 
 DEAL:2:2d::n_dofs: 9
-DEAL:2:2d::n_locally_owned_dofs: 2
-DEAL:2:2d::n_locally_owned_dofs_per_processor: 4 3 2  sum: 9
+DEAL:2:2d::n_locally_owned_dofs: 1
+DEAL:2:2d::n_locally_owned_dofs_per_processor: 7 1 1  sum: 9
 9 1
-7 9
+8 9
 DEAL:2:2d:: locally_owned_dofs: 
 DEAL:2:3d::n_dofs: 27
-DEAL:2:3d::n_locally_owned_dofs: 6
-DEAL:2:3d::n_locally_owned_dofs_per_processor: 10 11 6  sum: 27
+DEAL:2:3d::n_locally_owned_dofs: 2
+DEAL:2:3d::n_locally_owned_dofs_per_processor: 19 6 2  sum: 27
 27 1
-21 27
+25 27
 DEAL:2:3d:: locally_owned_dofs: 
 
index 648350f6cd29a4ca579b4e948bc696e352ee3cf6..36a2dacc54d50b4c7e7f3d6fb08758401d1762db 100644 (file)
@@ -1,95 +1,95 @@
 
 DEAL:0:1d::n_dofs: 3
-DEAL:0:1d::n_locally_owned_dofs: 1
-DEAL:0:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0  sum: 3
+DEAL:0:1d::n_locally_owned_dofs: 2
+DEAL:0:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0  sum: 3
 3 1
-0 1
+0 2
 DEAL:0:1d:: locally_owned_dofs: 
 DEAL:0:2d::n_dofs: 9
-DEAL:0:2d::n_locally_owned_dofs: 1
-DEAL:0:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0  sum: 9
+DEAL:0:2d::n_locally_owned_dofs: 4
+DEAL:0:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0  sum: 9
 9 1
-0 1
+0 4
 DEAL:0:2d:: locally_owned_dofs: 
 DEAL:0:3d::n_dofs: 27
-DEAL:0:3d::n_locally_owned_dofs: 5
-DEAL:0:3d::n_locally_owned_dofs_per_processor: 5 8 7 5 2  sum: 27
+DEAL:0:3d::n_locally_owned_dofs: 14
+DEAL:0:3d::n_locally_owned_dofs_per_processor: 14 7 4 1 1  sum: 27
 27 1
-0 5
+0 14
 DEAL:0:3d:: locally_owned_dofs: 
 
 DEAL:1:1d::n_dofs: 3
-DEAL:1:1d::n_locally_owned_dofs: 2
-DEAL:1:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0  sum: 3
+DEAL:1:1d::n_locally_owned_dofs: 1
+DEAL:1:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0  sum: 3
 3 1
-1 3
+2 3
 DEAL:1:1d:: locally_owned_dofs: 
 DEAL:1:2d::n_dofs: 9
-DEAL:1:2d::n_locally_owned_dofs: 3
-DEAL:1:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0  sum: 9
+DEAL:1:2d::n_locally_owned_dofs: 2
+DEAL:1:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0  sum: 9
 9 1
-1 4
+4 6
 DEAL:1:2d:: locally_owned_dofs: 
 DEAL:1:3d::n_dofs: 27
-DEAL:1:3d::n_locally_owned_dofs: 8
-DEAL:1:3d::n_locally_owned_dofs_per_processor: 5 8 7 5 2  sum: 27
+DEAL:1:3d::n_locally_owned_dofs: 7
+DEAL:1:3d::n_locally_owned_dofs_per_processor: 14 7 4 1 1  sum: 27
 27 1
-5 13
+14 21
 DEAL:1:3d:: locally_owned_dofs: 
 
 
 DEAL:2:1d::n_dofs: 3
 DEAL:2:1d::n_locally_owned_dofs: 0
-DEAL:2:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0  sum: 3
+DEAL:2:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0  sum: 3
 3 0
 DEAL:2:1d:: locally_owned_dofs: 
 DEAL:2:2d::n_dofs: 9
 DEAL:2:2d::n_locally_owned_dofs: 2
-DEAL:2:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0  sum: 9
+DEAL:2:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0  sum: 9
 9 1
-4 6
+6 8
 DEAL:2:2d:: locally_owned_dofs: 
 DEAL:2:3d::n_dofs: 27
-DEAL:2:3d::n_locally_owned_dofs: 7
-DEAL:2:3d::n_locally_owned_dofs_per_processor: 5 8 7 5 2  sum: 27
+DEAL:2:3d::n_locally_owned_dofs: 4
+DEAL:2:3d::n_locally_owned_dofs_per_processor: 14 7 4 1 1  sum: 27
 27 1
-13 20
+21 25
 DEAL:2:3d:: locally_owned_dofs: 
 
 
 DEAL:3:1d::n_dofs: 3
 DEAL:3:1d::n_locally_owned_dofs: 0
-DEAL:3:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0  sum: 3
+DEAL:3:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0  sum: 3
 3 0
 DEAL:3:1d:: locally_owned_dofs: 
 DEAL:3:2d::n_dofs: 9
-DEAL:3:2d::n_locally_owned_dofs: 3
-DEAL:3:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0  sum: 9
+DEAL:3:2d::n_locally_owned_dofs: 1
+DEAL:3:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0  sum: 9
 9 1
-6 9
+8 9
 DEAL:3:2d:: locally_owned_dofs: 
 DEAL:3:3d::n_dofs: 27
-DEAL:3:3d::n_locally_owned_dofs: 5
-DEAL:3:3d::n_locally_owned_dofs_per_processor: 5 8 7 5 2  sum: 27
+DEAL:3:3d::n_locally_owned_dofs: 1
+DEAL:3:3d::n_locally_owned_dofs_per_processor: 14 7 4 1 1  sum: 27
 27 1
-20 25
+25 26
 DEAL:3:3d:: locally_owned_dofs: 
 
 
 DEAL:4:1d::n_dofs: 3
 DEAL:4:1d::n_locally_owned_dofs: 0
-DEAL:4:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0  sum: 3
+DEAL:4:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0  sum: 3
 3 0
 DEAL:4:1d:: locally_owned_dofs: 
 DEAL:4:2d::n_dofs: 9
 DEAL:4:2d::n_locally_owned_dofs: 0
-DEAL:4:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0  sum: 9
+DEAL:4:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0  sum: 9
 9 0
 DEAL:4:2d:: locally_owned_dofs: 
 DEAL:4:3d::n_dofs: 27
-DEAL:4:3d::n_locally_owned_dofs: 2
-DEAL:4:3d::n_locally_owned_dofs_per_processor: 5 8 7 5 2  sum: 27
+DEAL:4:3d::n_locally_owned_dofs: 1
+DEAL:4:3d::n_locally_owned_dofs_per_processor: 14 7 4 1 1  sum: 27
 27 1
-25 27
+26 27
 DEAL:4:3d:: locally_owned_dofs: 
 
index 06567b8304288d5e334d9c431db4833aed2795f2..8ff8a42b6816feae8c17b318bb2a3729dea738de 100644 (file)
 
 DEAL:0:1d::n_dofs: 3
-DEAL:0:1d::n_locally_owned_dofs: 1
-DEAL:0:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:0:1d::n_locally_owned_dofs: 2
+DEAL:0:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 1
-0 1
+0 2
 DEAL:0:1d:: locally_owned_dofs: 
 DEAL:0:2d::n_dofs: 9
-DEAL:0:2d::n_locally_owned_dofs: 1
-DEAL:0:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:0:2d::n_locally_owned_dofs: 4
+DEAL:0:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 1
-0 1
+0 4
 DEAL:0:2d:: locally_owned_dofs: 
 DEAL:0:3d::n_dofs: 27
-DEAL:0:3d::n_locally_owned_dofs: 1
-DEAL:0:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:0:3d::n_locally_owned_dofs: 8
+DEAL:0:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-0 1
+0 8
 DEAL:0:3d:: locally_owned_dofs: 
 
 DEAL:1:1d::n_dofs: 3
-DEAL:1:1d::n_locally_owned_dofs: 2
-DEAL:1:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:1:1d::n_locally_owned_dofs: 1
+DEAL:1:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 1
-1 3
+2 3
 DEAL:1:1d:: locally_owned_dofs: 
 DEAL:1:2d::n_dofs: 9
-DEAL:1:2d::n_locally_owned_dofs: 3
-DEAL:1:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:1:2d::n_locally_owned_dofs: 2
+DEAL:1:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 1
-1 4
+4 6
 DEAL:1:2d:: locally_owned_dofs: 
 DEAL:1:3d::n_dofs: 27
 DEAL:1:3d::n_locally_owned_dofs: 4
-DEAL:1:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:1:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-1 5
+8 12
 DEAL:1:3d:: locally_owned_dofs: 
 
 
 DEAL:2:1d::n_dofs: 3
 DEAL:2:1d::n_locally_owned_dofs: 0
-DEAL:2:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:2:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:2:1d:: locally_owned_dofs: 
 DEAL:2:2d::n_dofs: 9
 DEAL:2:2d::n_locally_owned_dofs: 2
-DEAL:2:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:2:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 1
-4 6
+6 8
 DEAL:2:2d:: locally_owned_dofs: 
 DEAL:2:3d::n_dofs: 27
-DEAL:2:3d::n_locally_owned_dofs: 2
-DEAL:2:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:2:3d::n_locally_owned_dofs: 4
+DEAL:2:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-5 7
+12 16
 DEAL:2:3d:: locally_owned_dofs: 
 
 
 DEAL:3:1d::n_dofs: 3
 DEAL:3:1d::n_locally_owned_dofs: 0
-DEAL:3:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:3:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:3:1d:: locally_owned_dofs: 
 DEAL:3:2d::n_dofs: 9
-DEAL:3:2d::n_locally_owned_dofs: 3
-DEAL:3:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:3:2d::n_locally_owned_dofs: 1
+DEAL:3:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 1
-6 9
+8 9
 DEAL:3:2d:: locally_owned_dofs: 
 DEAL:3:3d::n_dofs: 27
-DEAL:3:3d::n_locally_owned_dofs: 5
-DEAL:3:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:3:3d::n_locally_owned_dofs: 2
+DEAL:3:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-7 12
+16 18
 DEAL:3:3d:: locally_owned_dofs: 
 
 
 DEAL:4:1d::n_dofs: 3
 DEAL:4:1d::n_locally_owned_dofs: 0
-DEAL:4:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:4:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:4:1d:: locally_owned_dofs: 
 DEAL:4:2d::n_dofs: 9
 DEAL:4:2d::n_locally_owned_dofs: 0
-DEAL:4:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:4:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 0
 DEAL:4:2d:: locally_owned_dofs: 
 DEAL:4:3d::n_dofs: 27
-DEAL:4:3d::n_locally_owned_dofs: 2
-DEAL:4:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:4:3d::n_locally_owned_dofs: 4
+DEAL:4:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-12 14
+18 22
 DEAL:4:3d:: locally_owned_dofs: 
 
 
 DEAL:5:1d::n_dofs: 3
 DEAL:5:1d::n_locally_owned_dofs: 0
-DEAL:5:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:5:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:5:1d:: locally_owned_dofs: 
 DEAL:5:2d::n_dofs: 9
 DEAL:5:2d::n_locally_owned_dofs: 0
-DEAL:5:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:5:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 0
 DEAL:5:2d:: locally_owned_dofs: 
 DEAL:5:3d::n_dofs: 27
-DEAL:5:3d::n_locally_owned_dofs: 4
-DEAL:5:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:5:3d::n_locally_owned_dofs: 2
+DEAL:5:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-14 18
+22 24
 DEAL:5:3d:: locally_owned_dofs: 
 
 
 DEAL:6:1d::n_dofs: 3
 DEAL:6:1d::n_locally_owned_dofs: 0
-DEAL:6:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:6:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:6:1d:: locally_owned_dofs: 
 DEAL:6:2d::n_dofs: 9
 DEAL:6:2d::n_locally_owned_dofs: 0
-DEAL:6:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:6:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 0
 DEAL:6:2d:: locally_owned_dofs: 
 DEAL:6:3d::n_dofs: 27
-DEAL:6:3d::n_locally_owned_dofs: 4
-DEAL:6:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:6:3d::n_locally_owned_dofs: 2
+DEAL:6:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-18 22
+24 26
 DEAL:6:3d:: locally_owned_dofs: 
 
 
 DEAL:7:1d::n_dofs: 3
 DEAL:7:1d::n_locally_owned_dofs: 0
-DEAL:7:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:7:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:7:1d:: locally_owned_dofs: 
 DEAL:7:2d::n_dofs: 9
 DEAL:7:2d::n_locally_owned_dofs: 0
-DEAL:7:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:7:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 0
 DEAL:7:2d:: locally_owned_dofs: 
 DEAL:7:3d::n_dofs: 27
-DEAL:7:3d::n_locally_owned_dofs: 5
-DEAL:7:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:7:3d::n_locally_owned_dofs: 1
+DEAL:7:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 1
-22 27
+26 27
 DEAL:7:3d:: locally_owned_dofs: 
 
 
 DEAL:8:1d::n_dofs: 3
 DEAL:8:1d::n_locally_owned_dofs: 0
-DEAL:8:1d::n_locally_owned_dofs_per_processor: 1 2 0 0 0 0 0 0 0  sum: 3
+DEAL:8:1d::n_locally_owned_dofs_per_processor: 2 1 0 0 0 0 0 0 0  sum: 3
 3 0
 DEAL:8:1d:: locally_owned_dofs: 
 DEAL:8:2d::n_dofs: 9
 DEAL:8:2d::n_locally_owned_dofs: 0
-DEAL:8:2d::n_locally_owned_dofs_per_processor: 1 3 2 3 0 0 0 0 0  sum: 9
+DEAL:8:2d::n_locally_owned_dofs_per_processor: 4 2 2 1 0 0 0 0 0  sum: 9
 9 0
 DEAL:8:2d:: locally_owned_dofs: 
 DEAL:8:3d::n_dofs: 27
 DEAL:8:3d::n_locally_owned_dofs: 0
-DEAL:8:3d::n_locally_owned_dofs_per_processor: 1 4 2 5 2 4 4 5 0  sum: 27
+DEAL:8:3d::n_locally_owned_dofs_per_processor: 8 4 4 2 4 2 2 1 0  sum: 27
 27 0
 DEAL:8:3d:: locally_owned_dofs: 
 

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.