]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Avoid deprecated argument in distribute_mg_dofs 8727/head
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Tue, 10 Sep 2019 08:05:38 +0000 (10:05 +0200)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Tue, 10 Sep 2019 08:07:26 +0000 (10:07 +0200)
142 files changed:
tests/bits/step-16.cc
tests/dofs/block_info.cc
tests/dofs/block_info_02.cc
tests/dofs/block_list_01.cc
tests/dofs/block_list_02.cc
tests/dofs/block_list_03.cc
tests/dofs/block_list_04.cc
tests/dofs/block_list_05.cc
tests/dofs/block_list_parallel_01.cc
tests/dofs/dof_renumbering.cc
tests/dofs/dof_renumbering_07.cc
tests/dofs/dof_renumbering_08.cc
tests/dofs/dof_renumbering_09.cc
tests/dofs/extract_dofs_by_component_01_mg.cc
tests/dofs/extract_dofs_by_component_02_mg.cc
tests/examples/step-56.cc
tests/fe/transfer.cc
tests/integrators/assembler_simple_mgmatrix_03.cc
tests/integrators/assembler_simple_mgmatrix_04.cc
tests/integrators/cells_and_faces_01.cc
tests/integrators/functional_01.cc
tests/integrators/mesh_worker_01.cc
tests/integrators/mesh_worker_02.cc
tests/integrators/mesh_worker_03.cc
tests/matrix_free/compare_faces_by_cells.cc
tests/matrix_free/dg_pbc_02.cc
tests/matrix_free/matrix_vector_mg.cc
tests/matrix_free/multigrid_dg_periodic.cc
tests/matrix_free/multigrid_dg_sip_01.cc
tests/matrix_free/multigrid_dg_sip_02.cc
tests/matrix_free/parallel_multigrid.cc
tests/matrix_free/parallel_multigrid_02.cc
tests/matrix_free/parallel_multigrid_adaptive_01.cc
tests/matrix_free/parallel_multigrid_adaptive_02.cc
tests/matrix_free/parallel_multigrid_adaptive_04.cc
tests/matrix_free/parallel_multigrid_adaptive_05.cc
tests/matrix_free/parallel_multigrid_adaptive_06.cc
tests/matrix_free/parallel_multigrid_adaptive_06ref.cc
tests/matrix_free/parallel_multigrid_adaptive_08.cc
tests/matrix_free/parallel_multigrid_mf.cc
tests/matrix_free/step-37.cc
tests/meshworker/mesh_loop_gmg_01.cc
tests/mpi/flux_edge_01.cc
tests/mpi/mg_02.cc
tests/mpi/mg_03.cc
tests/mpi/mg_04.cc
tests/mpi/mg_05.cc
tests/mpi/mg_06.cc
tests/mpi/mg_ghost_dofs_periodic_01.cc
tests/mpi/mg_ghost_dofs_periodic_02.cc
tests/mpi/mg_ghost_dofs_periodic_03.cc
tests/mpi/mg_ghost_dofs_periodic_04.cc
tests/mpi/mg_ghost_dofs_periodic_05.cc
tests/mpi/mg_ghost_dofs_periodic_07.cc
tests/mpi/multigrid_adaptive.cc
tests/mpi/multigrid_uniform.cc
tests/mpi/step-39-block.cc
tests/mpi/step-39.cc
tests/multigrid/boundary_01.cc
tests/multigrid/constrained_dofs_01.cc
tests/multigrid/constrained_dofs_02.cc
tests/multigrid/constrained_dofs_03.cc
tests/multigrid/count_01.cc
tests/multigrid/distribute_bug_01.cc
tests/multigrid/dof_01.cc
tests/multigrid/dof_02.cc
tests/multigrid/dof_03.cc
tests/multigrid/dof_04.cc
tests/multigrid/dof_05.cc
tests/multigrid/events_01.cc
tests/multigrid/mg_coarse_01.cc
tests/multigrid/mg_output_dirichlet.cc
tests/multigrid/mg_output_neumann.cc
tests/multigrid/mg_renumbered_01.cc
tests/multigrid/mg_renumbered_02.cc
tests/multigrid/mg_renumbered_03.cc
tests/multigrid/renumbering_01.cc
tests/multigrid/renumbering_02.cc
tests/multigrid/renumbering_03.cc
tests/multigrid/renumbering_04.cc
tests/multigrid/step-16-02.cc
tests/multigrid/step-16-03.cc
tests/multigrid/step-16-04.cc
tests/multigrid/step-16-05.cc
tests/multigrid/step-16-06.cc
tests/multigrid/step-16-07.cc
tests/multigrid/step-16-50-mpi-linear-operator.cc
tests/multigrid/step-16-50-mpi-smoother.cc
tests/multigrid/step-16-50-mpi.cc
tests/multigrid/step-16-50-serial.cc
tests/multigrid/step-16-bdry1.cc
tests/multigrid/step-16.cc
tests/multigrid/step-39-02.cc
tests/multigrid/step-39-02a.cc
tests/multigrid/step-39-03.cc
tests/multigrid/step-39.cc
tests/multigrid/step-50_01.cc
tests/multigrid/transfer_01.cc
tests/multigrid/transfer_02.cc
tests/multigrid/transfer_03.cc
tests/multigrid/transfer_04.cc
tests/multigrid/transfer_04a.cc
tests/multigrid/transfer_04b.cc
tests/multigrid/transfer_05.cc
tests/multigrid/transfer_06.cc
tests/multigrid/transfer_block.cc
tests/multigrid/transfer_block_select.cc
tests/multigrid/transfer_compare_01.cc
tests/multigrid/transfer_matrix_free_01.cc
tests/multigrid/transfer_matrix_free_02.cc
tests/multigrid/transfer_matrix_free_02_block.cc
tests/multigrid/transfer_matrix_free_02_block_02.cc
tests/multigrid/transfer_matrix_free_03.cc
tests/multigrid/transfer_matrix_free_04.cc
tests/multigrid/transfer_matrix_free_05.cc
tests/multigrid/transfer_matrix_free_06.cc
tests/multigrid/transfer_matrix_free_07.cc
tests/multigrid/transfer_matrix_free_08.cc
tests/multigrid/transfer_matrix_free_09.cc
tests/multigrid/transfer_matrix_free_10.cc
tests/multigrid/transfer_matrix_free_11.cc
tests/multigrid/transfer_matrix_free_12.cc
tests/multigrid/transfer_prebuilt_01.cc
tests/multigrid/transfer_prebuilt_02.cc
tests/multigrid/transfer_prebuilt_03.cc
tests/multigrid/transfer_prebuilt_04.cc
tests/multigrid/transfer_select.cc
tests/multigrid/transfer_system_01.cc
tests/multigrid/transfer_system_02.cc
tests/multigrid/transfer_system_03.cc
tests/multigrid/transfer_system_04.cc
tests/multigrid/transfer_system_05.cc
tests/multigrid/transfer_system_adaptive_01.cc
tests/multigrid/transfer_system_adaptive_02.cc
tests/multigrid/transfer_system_adaptive_03.cc
tests/multigrid/transfer_system_adaptive_04.cc
tests/multigrid/transfer_system_adaptive_05.cc
tests/multigrid/transfer_system_adaptive_06.cc
tests/multigrid/transfer_system_adaptive_07.cc
tests/multigrid/transfer_system_adaptive_08.cc
tests/multigrid/transfer_system_adaptive_09.cc
tests/trilinos/mg_transfer_prebuilt_01.cc

index 1205ca68ed7c6a04776718c5947a5a170b594c13..be1e62be883614164001ec0687f432845d91dc51 100644 (file)
@@ -107,7 +107,7 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   deallog << "   Number of degrees of freedom: " << mg_dof_handler.n_dofs()
           << std::endl;
index b251b53854e9d382f03a1d8d392de06716630ef4..3530a2b24c8ea2b1e54a5ab5419385af02aaf25b 100644 (file)
@@ -32,7 +32,7 @@ test_grid(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
 {
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
   BlockInfo bi;
   bi.initialize(mgdof);
   bi.initialize_local(mgdof);
index d3d63ef1056a8e2207e68fcc2a4baf680aed59d5..13b0be4320b2a24f885fd01980630396d1d26136 100644 (file)
@@ -35,7 +35,7 @@ test_grid(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
 {
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
   BlockInfo bi;
   bi.initialize(mgdof, false, false);
   bi.initialize_local(mgdof);
index a30ae3a408556f4b381901331aae276a521a3779..5e77c22918c0d5a5a88a322a985c633b8f2eaba2 100644 (file)
@@ -24,7 +24,7 @@ test_block_list(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
 
   DoFHandler<dim> dof;
   dof.initialize(tr, fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
 
   const unsigned int level = tr.n_levels() - 1;
 
index 58020eaa1774e8e7a6d3ad5f366e26b572fda9b8..62b6e483d2eccfdf73815f7330631ac6cd516be5 100644 (file)
@@ -24,7 +24,7 @@ test_block_list(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
 
   DoFHandler<dim> dof;
   dof.initialize(tr, fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
 
   const unsigned int level = tr.n_levels() - 1;
 
index ab6c2441a2ad9e33fb317f311b15943636040404..7e6d4c5007c1ecd834b23c910c45577b63dafb6c 100644 (file)
@@ -24,7 +24,7 @@ test_block_list(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
 
   DoFHandler<dim> dof;
   dof.initialize(tr, fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
 
   const unsigned int level = tr.n_levels() - 1;
 
index 795c8baa3dfca489c53c500e586ad821385cacce..790f0c38d89c4593b7a0dac675b8e68416e2a40d 100644 (file)
@@ -24,7 +24,7 @@ test_block_list(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
 
   DoFHandler<dim> dof;
   dof.initialize(tr, fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
 
   const unsigned int level = tr.n_levels() - 1;
 
index dd7b2a0f2cb308ebfe81467dcc06068f1f9d85be..9437e721fd5912856d8c82b4022551d4c66c8b39 100644 (file)
@@ -59,7 +59,7 @@ test_block_list(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
 
   DoFHandler<dim> dof;
   dof.initialize(tr, fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
 
   const unsigned int level = tr.n_levels() - 1;
 
index f4331c56f6fda5dd9178e18ef4948541c6fa3c10..a68cb87c1d697df98dbc8a1e51aa79e563b9e676 100644 (file)
@@ -27,7 +27,7 @@ test_block_list(const parallel::distributed::Triangulation<dim> &tr,
 
   DoFHandler<dim> dof;
   dof.initialize(tr, fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
 
   for (unsigned int level = 0; level < tr.n_global_levels(); ++level)
     {
index 62c44a8f1947c18ef6244186efb1c3e6885c5f48..8769316c97fc6983cf2e4ce98f660af8c4a18b7f 100644 (file)
@@ -172,13 +172,13 @@ check()
 
   FESystem<dim> e1(FE_Q<dim>(2), 2, FE_DGQ<dim>(1), 1);
   mgdof.distribute_dofs(e1);
-  mgdof.distribute_mg_dofs(e1);
+  mgdof.distribute_mg_dofs();
   check_renumbering(mgdof, false);
   mgdof.clear();
 
   FESystem<dim> e2(FE_DGP<dim>(2), 2, FE_DGQ<dim>(1), 1);
   mgdof.distribute_dofs(e2);
-  mgdof.distribute_mg_dofs(e2);
+  mgdof.distribute_mg_dofs();
   check_renumbering(mgdof, true);
   mgdof.clear();
 }
index 8c1588af0cbc1eac41b7a825ca54a0aeebeb2b32..51666d6f7587bf761b730808bb3bbba424f7fa88 100644 (file)
@@ -105,7 +105,7 @@ check()
     DoFHandler<dim> dof(tr);
 
     dof.distribute_dofs(fe);
-    dof.distribute_mg_dofs(fe);
+    dof.distribute_mg_dofs();
     check_renumbering(dof);
   }
 
@@ -114,7 +114,7 @@ check()
     DoFHandler<dim> dof(tr);
 
     dof.distribute_dofs(fe);
-    dof.distribute_mg_dofs(fe);
+    dof.distribute_mg_dofs();
     check_renumbering(dof);
   }
 }
index 871e1a584951321ed1a587db4797a48fea334ac5..85e3b7531f41ac21d0b70106887d27c06eaaace6 100644 (file)
@@ -102,7 +102,7 @@ check()
     DoFHandler<dim> dof(tr);
 
     dof.distribute_dofs(fe);
-    dof.distribute_mg_dofs(fe);
+    dof.distribute_mg_dofs();
     check_renumbering(dof);
   }
 
@@ -111,7 +111,7 @@ check()
     DoFHandler<dim> dof(tr);
 
     dof.distribute_dofs(fe);
-    dof.distribute_mg_dofs(fe);
+    dof.distribute_mg_dofs();
     check_renumbering(dof);
   }
 }
index 5c2f1d667eab10dbf1479dea3a8fb521ab0a7d95..accf970953299a48f33b189dcaf6b71ce06a83f5 100644 (file)
@@ -70,7 +70,7 @@ test()
 
   FE_Q<dim> fe(1);
   dof_handler.distribute_dofs(fe);
-  dof_handler.distribute_mg_dofs(fe);
+  dof_handler.distribute_mg_dofs();
 
 
   // Print dofs before reordering
index a0bd320e63eeb4b05ab04b03bec34992f11ca366..577a5e85e055c6f702fe05c4c30c4153c59a86f3 100644 (file)
@@ -53,7 +53,7 @@ check()
   FESystem<dim>   element(FE_Q<dim>(2), 1, FE_Nedelec<dim>(0), 1);
   DoFHandler<dim> dof(tr);
   dof.distribute_dofs(element);
-  dof.distribute_mg_dofs(element);
+  dof.distribute_mg_dofs();
 
   // try all possible component
   // masks, which we encode as bit
index 4e4f6318dc5686befd2ade26ef7b1a1741527132..226c75cf67961c6eb54bece3509091c2594be72f 100644 (file)
@@ -54,7 +54,7 @@ check()
   FESystem<dim>   element(FE_Q<dim>(2), 1, FE_Nedelec<dim>(0), 1);
   DoFHandler<dim> dof(tr);
   dof.distribute_dofs(element);
-  dof.distribute_mg_dofs(element);
+  dof.distribute_mg_dofs();
 
   // try all possible block
   // masks, which we encode as bit
index 959bbc2f301c29692aad30f15fa1483b53570c82..a5eee5fc99aecc74cb859d455e9c710a95359f1c 100644 (file)
@@ -493,7 +493,7 @@ namespace Step56
     pressure_mass_matrix.clear();
 
     // The main DoFHandler only needs active DoFs, so we are not calling
-    // distribute_mg_dofs() here
+    // distribute_mg_dofs();
     dof_handler.distribute_dofs(fe);
 
     // This block structure separates the dim velocity components from
index b34fff0a5a3c6e0b2ec8f4b75400721f57c6bec9..71f77eb5c6b6b1eb4569c67024ff3205b983b2a9 100644 (file)
@@ -54,7 +54,7 @@ print_matrix(Triangulation<dim> &      tr,
 {
   DoFHandler<dim> dof(tr);
   dof.distribute_dofs(finel);
-  dof.distribute_mg_dofs(finel);
+  dof.distribute_mg_dofs();
 
   MGTransferPrebuilt<Vector<double>> transfer;
   transfer.build_matrices(dof);
index 97635c01f6b7c0dad88f7f925387388b69c670ad..e4916baeaa550a5b19d95aae4be3aba0d66a8206 100644 (file)
@@ -75,7 +75,7 @@ test(FiniteElement<dim> &fe)
 
   DoFHandler<dim> dof(tr);
   dof.distribute_dofs(fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
   dof.initialize_local_block_info();
   for (unsigned int level = 0; level < tr.n_levels(); ++level)
     DoFRenumbering::component_wise(dof, level);
index d0b6cf3540d6ce2632c34591596fb34c41e4f94b..2d7124af2f1c7e29da13ea8296f36a54e3e7ca60 100644 (file)
@@ -194,7 +194,7 @@ test(FiniteElement<dim> &fe)
 
   DoFHandler<dim> dof(tr);
   dof.distribute_dofs(fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
   dof.initialize_local_block_info();
   mg::SparseMatrixCollection<double> mg;
   mg.resize(0, tr.n_levels() - 1);
index 002d2eeb418866b8e93c62ee1bb1e05ffc276b66..fc0693154c7fbed7ad19d6be2aa6e7ab41cd50da 100644 (file)
@@ -194,21 +194,21 @@ test(const FiniteElement<dim> &fe)
   tr.refine_global(1);
   deallog.push("1");
   dofs.distribute_dofs(fe);
-  dofs.distribute_mg_dofs(fe);
+  dofs.distribute_mg_dofs();
   test_mesh(dofs);
   deallog.pop();
   tr.begin(1)->set_refine_flag();
   tr.execute_coarsening_and_refinement();
   deallog.push("2");
   dofs.distribute_dofs(fe);
-  dofs.distribute_mg_dofs(fe);
+  dofs.distribute_mg_dofs();
   test_mesh(dofs);
   deallog.pop();
   tr.begin(2)->set_refine_flag();
   tr.execute_coarsening_and_refinement();
   deallog.push("3");
   dofs.distribute_dofs(fe);
-  dofs.distribute_mg_dofs(fe);
+  dofs.distribute_mg_dofs();
   test_mesh(dofs);
   deallog.pop();
 }
index 3b8cdb30478cdb80508ad09b29740114e40db91c..8773647b43d87ae2428c526a8af92d79ced413e6 100644 (file)
@@ -166,21 +166,21 @@ test(const FiniteElement<dim> &fe)
   tr.refine_global(1);
   deallog.push("1");
   dofs.distribute_dofs(fe);
-  dofs.distribute_mg_dofs(fe);
+  dofs.distribute_mg_dofs();
   test_mesh(dofs);
   deallog.pop();
   tr.begin(1)->set_refine_flag();
   tr.execute_coarsening_and_refinement();
   deallog.push("2");
   dofs.distribute_dofs(fe);
-  dofs.distribute_mg_dofs(fe);
+  dofs.distribute_mg_dofs();
   test_mesh(dofs);
   deallog.pop();
   tr.begin(2)->set_refine_flag();
   tr.execute_coarsening_and_refinement();
   deallog.push("3");
   dofs.distribute_dofs(fe);
-  dofs.distribute_mg_dofs(fe);
+  dofs.distribute_mg_dofs();
   test_mesh(dofs);
   deallog.pop();
 }
index 219db3742adb10c608fdd656480e2bdd39d5a627..969552e71a1c2bd6dc88c4453052e84936a93271 100644 (file)
@@ -215,7 +215,7 @@ test(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> dofs(tr);
   dofs.distribute_dofs(fe);
-  dofs.distribute_mg_dofs(fe);
+  dofs.distribute_mg_dofs();
   deallog << "DoFHandler " << dofs.n_dofs() << " levels";
   for (unsigned int l = 0; l < tr.n_levels(); ++l)
     deallog << ' ' << l << ':' << dofs.n_dofs(l);
index cf8cc744cd31e959c943e04016dddb1b0528a5b5..1c5a7b8f364797bd77545560f182215a0b098d3e 100644 (file)
@@ -314,7 +314,7 @@ test(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> dofs(tr);
   dofs.distribute_dofs(fe);
-  dofs.distribute_mg_dofs(fe);
+  dofs.distribute_mg_dofs();
   deallog << "DoFHandler " << dofs.n_dofs() << " levels";
   for (unsigned int l = 0; l < tr.n_levels(); ++l)
     deallog << ' ' << l << ':' << dofs.n_dofs(l);
index d8abc2940f7cfadcb42a805d70dddf06470e210a..f3050cf73200716fbe6d6c472923ffd3fce2b29f 100644 (file)
@@ -313,7 +313,7 @@ test(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> dofs(tr);
   dofs.distribute_dofs(fe);
-  dofs.distribute_mg_dofs(fe);
+  dofs.distribute_mg_dofs();
   deallog << "DoFHandler " << dofs.n_dofs() << " levels";
   for (unsigned int l = 0; l < tr.n_levels(); ++l)
     deallog << ' ' << l << ':' << dofs.n_dofs(l);
index a24cf3dc948c185158b6dd54db863d93b07df21b..e8626fdcae4205d4792fdeff61c34ecd8eec3f3d 100644 (file)
@@ -337,7 +337,7 @@ test()
   FE_DGQ<dim>     fe(fe_degree);
   DoFHandler<dim> dof(tria);
   dof.distribute_dofs(fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
   deallog << "Number of DoFs: " << dof.n_dofs() << std::endl;
 
   MappingQGeneric<dim>                                   mapping(fe_degree + 1);
index d95b361a430303fc188e44000cff39ec0effc1dc..2a67eae8cdd1a2e7ab4bd2b369be154b676906fa 100644 (file)
@@ -82,7 +82,7 @@ test()
   FE_DGQ<dim>     fe(1);
   DoFHandler<dim> dof(tria);
   dof.distribute_dofs(fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
   AffineConstraints<double> constraints;
   constraints.close();
 
index 596e8cdd703c35e5afadd969d52ed35e74622768..ed1a74a51b03536275d21eaee69bdb3df2f837d2 100644 (file)
@@ -55,7 +55,7 @@ test()
   // setup DoFs
   DoFHandler<dim> dof(tria);
   dof.distribute_dofs(fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
   AffineConstraints<double> constraints;
   VectorTools::interpolate_boundary_values(dof,
                                            0,
index 853d5e0fe4c5522b88c15f0fb48f4430e48003e9..a9a6550e9b6370873659cb21b4fb5668b2820269 100644 (file)
@@ -630,7 +630,7 @@ test()
       FE_DGQ<dim>     fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       do_test<dim, fe_degree, fe_degree + 1, double>(dof);
     }
index 23096ad0bfeb97343a0ad32d42f26520bf0e3acb..7dd71a2fca0a140935c297a52ae67176b7b0a1dc 100644 (file)
@@ -634,7 +634,7 @@ test()
       FE_DGQ<dim>     fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       do_test<dim, fe_degree, fe_degree + 1, double>(dof, true);
     }
index 52181a93348855575eb57bb3c61fcfe5a95c214b..980bc419259e0b063c5fa0411e88d9acc021c0b7 100644 (file)
@@ -546,7 +546,7 @@ test()
       FE_DGQ<dim>     fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       do_test<dim, fe_degree, fe_degree + 1, double>(dof, true);
     }
index cba8b73b6ef1735d47272475040ead044beb78d5..9267b213f03bbe846e33a792f25a2b760244c000 100644 (file)
@@ -446,7 +446,7 @@ test()
       FE_Q<dim>       fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       do_test<dim, fe_degree, fe_degree + 1, double>(dof);
     }
index 66b6ed925b8936d805e91bec4a62b2cb4c43df66..9185a4448d0d81f5f1e602f877dc86fb067e00b5 100644 (file)
@@ -264,7 +264,7 @@ test()
       FE_Q<dim>       fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       do_test<dim, fe_degree, fe_degree + 1, double>(dof);
     }
index f22561aeb9d10639d17869d5ce357afd031db4e6..388fc77ef5a346c1386c8fd74552b16268c42511 100644 (file)
@@ -642,7 +642,7 @@ test()
       FE_Q<dim>       fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       do_test<dim, fe_degree, fe_degree + 1, double>(dof);
     }
index 4331103dd9c8a9153c5ef5c64f4182de092e3e8c..2f2abb724e9fb460653dbfb43b91fe5fb54d7c23 100644 (file)
@@ -337,7 +337,7 @@ test()
       FE_Q<dim>       fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       do_test<dim, fe_degree, fe_degree + 1, double>(dof);
     }
index ee68fbb7a0240c99fc74372ef86fc0dbd4cca3e0..c30c263defe3cf60628592417ce274a2d64af6ab 100644 (file)
@@ -335,7 +335,7 @@ test()
       FE_Q<dim>       fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       do_test<dim, fe_degree, fe_degree + 1, double>(dof);
     }
index c380b50b293587e83664d13b1e30eaf7285816f6..3d2b4aee9a43c9600dae26849497f8b0130c26ae 100644 (file)
@@ -646,7 +646,7 @@ test()
       FE_Q<dim>       fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       deallog.push("threaded");
       do_test<dim, fe_degree, fe_degree + 1, Number>(dof, true);
index 47ba3889e8ad1aceb166156dac646bc0871e27d8..3febd20874b399a7b9e4eead7ab0bf8e02ebd365 100644 (file)
@@ -415,7 +415,7 @@ test(const unsigned int nbands = 1)
       FE_Q<dim>       fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       do_test<dim, fe_degree, fe_degree + 1, double>(dof, nbands);
     }
index ec5293a713724d0e76433f8b7332fff6addf55b8..4333ee97461081fdede2f1b871fcfb0f329027a3 100644 (file)
@@ -324,7 +324,7 @@ test()
       FE_Q<dim>       fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       do_test<dim, fe_degree, fe_degree + 1, double>(dof);
     }
index 8c6b201129c1d4a78627cf64148fd5d3b4f7f2ff..080c1facd2f0ae562586ce598cdd459ce204070e 100644 (file)
@@ -405,7 +405,7 @@ test()
       FE_Q<dim>       fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       do_test<dim, fe_degree, fe_degree + 1, double>(dof);
     }
index 5d4dc67743a84b79ff3ecabd2ea8decb00b53c5c..2ce591eb191cbac2efa213084e088de74c4b7317 100644 (file)
@@ -452,7 +452,7 @@ test()
       FE_Q<dim>       fe(fe_degree);
       DoFHandler<dim> dof(tria);
       dof.distribute_dofs(fe);
-      dof.distribute_mg_dofs(fe);
+      dof.distribute_mg_dofs();
 
       do_test<dim, fe_degree, fe_degree + 1, number>(dof);
     }
index 932c1a89b583c178f60b6091a54a2a783d2c89d7..a63271f3c1dbfe29b3c260a57de3a09c9ac5b1bf 100644 (file)
@@ -416,7 +416,7 @@ namespace Step37
     mg_constraints.clear_elements();
 
     dof_handler.distribute_dofs(fe);
-    dof_handler.distribute_mg_dofs(fe);
+    dof_handler.distribute_mg_dofs();
 
     deallog << "Number of degrees of freedom: " << dof_handler.n_dofs()
             << std::endl;
index e44df1f303d4b622ca4b4c499ad9449bebc66431..121af10ece751c4727ee7c96ec3e05fb58d82ab8 100644 (file)
@@ -68,7 +68,7 @@ test()
   FE_Q<dim>       fe(1);
   DoFHandler<dim> dofh(tria);
   dofh.distribute_dofs(fe);
-  dofh.distribute_mg_dofs(fe);
+  dofh.distribute_mg_dofs();
 
 
   ScratchData scratch;
index e30b0f8ab9ce02446818ca524f26f239b3302f37..d174279c7761da48927f19f8b94a4a3035942a8c 100644 (file)
@@ -115,7 +115,7 @@ namespace Step39
   InteriorPenaltyProblem<dim>::setup_system()
   {
     dof_handler.distribute_dofs(fe);
-    dof_handler.distribute_mg_dofs(fe);
+    dof_handler.distribute_mg_dofs();
 
     DoFTools::extract_locally_relevant_dofs(dof_handler, locally_relevant_set);
 
index 50f6ff0ab2f2bcb2a219f04ee00116afafd33285..5b11bb691e0c53f21ad76f30bb3d3d048e55d027 100644 (file)
@@ -86,7 +86,7 @@ test()
   Assert(dofh.has_active_dofs() == true, ExcInternalError());
   Assert(dofh.has_level_dofs() == false, ExcInternalError());
 
-  dofh.distribute_mg_dofs(fe);
+  dofh.distribute_mg_dofs();
 
   Assert(dofh.has_active_dofs() == true, ExcInternalError());
   Assert(dofh.has_level_dofs() == true, ExcInternalError());
index d0e9a1613c639e17c2964acca0d522bcb0c354f5..270ec0607074dd5d0096cd3307d526604ecd1bea 100644 (file)
@@ -99,7 +99,7 @@ test()
 
   static const FE_DGP<dim> fe(0);
   dofh.distribute_dofs(fe);
-  dofh.distribute_mg_dofs(fe);
+  dofh.distribute_mg_dofs();
 
   {
     for (unsigned int lvl = 0; lvl < tr.n_levels(); ++lvl)
index 5f2f199fa60d4c852de3024b4ca33ed0e5802665..0ae59a75e4d0868c491a551ad77de31755af6e36 100644 (file)
@@ -89,7 +89,7 @@ test()
 
   static const FE_Q<dim> fe(1);
   dofh.distribute_dofs(fe);
-  dofh.distribute_mg_dofs(fe);
+  dofh.distribute_mg_dofs();
 
   {
     for (unsigned int lvl = 0; lvl < tr.n_levels(); ++lvl)
index fc5ca6d418c254554f14d8a95c10b97b400491cc..f9d7dffb1186f5cd240088089d31dffd6d11f6fc 100644 (file)
@@ -113,7 +113,7 @@ test()
 
       static const FE_Q<dim> fe(1);
       dofh.distribute_dofs(fe);
-      dofh.distribute_mg_dofs(fe);
+      dofh.distribute_mg_dofs();
 
       {
         for (unsigned int lvl = 0; lvl < tr.n_levels(); ++lvl)
index 739572ec81fee295346bbc4c522a542a4484fb02..4ba4cd4f23888a880bc2e5a1dc2c442b820105a1 100644 (file)
@@ -119,7 +119,7 @@ test()
 
       static const FE_Q<dim> fe(1);
       dofh.distribute_dofs(fe);
-      dofh.distribute_mg_dofs(fe);
+      dofh.distribute_mg_dofs();
 
       {
         for (unsigned int lvl = 0; lvl < tr.n_levels(); ++lvl)
index 9c75d1a409f943f8c74ab7dcd4dae70e1fbdabb8..9150815fa22749dd23467283b8f2e46d532aa183 100644 (file)
@@ -78,7 +78,7 @@ test()
   FE_Q<dim>       fe(1);
   DoFHandler<dim> dof_handler(tria);
   dof_handler.distribute_dofs(fe);
-  dof_handler.distribute_mg_dofs(fe);
+  dof_handler.distribute_mg_dofs();
 
   std::vector<types::global_dof_index> dof_indices(fe.dofs_per_cell);
   for (unsigned int level = 0; level < tria.n_global_levels(); ++level)
index c11811fa77510df2447c3b14c86df78f4d4074d5..afe97bf12ac00fda48d9a38c023e528e7c0e5c9a 100644 (file)
@@ -58,7 +58,7 @@ test()
   FE_Q<dim>       fe(1);
   DoFHandler<dim> dof_handler(tria);
   dof_handler.distribute_dofs(fe);
-  dof_handler.distribute_mg_dofs(fe);
+  dof_handler.distribute_mg_dofs();
 
   std::vector<types::global_dof_index> dof_indices(fe.dofs_per_cell);
   for (unsigned int level = 0; level < tria.n_global_levels(); ++level)
index 916f3287489bb5931078cbdf21767de5916ba21f..15673c807ac13cb013a370a3b7371af04ea5fdc3 100644 (file)
@@ -71,7 +71,7 @@ test()
       FE_Q<dim>       fe(1);
       DoFHandler<dim> dof_handler(tria);
       dof_handler.distribute_dofs(fe);
-      dof_handler.distribute_mg_dofs(fe);
+      dof_handler.distribute_mg_dofs();
 
       std::vector<types::global_dof_index> dof_indices(fe.dofs_per_cell);
       for (unsigned int level = 0; level < tria.n_global_levels(); ++level)
index f77aa85042f543c442eba617b11ccaa9f98c67bc..c68f8c1975a766fe77095fe31888cb9b7acec2a9 100644 (file)
@@ -86,7 +86,7 @@ test()
   FE_Q<dim>       fe(1);
   DoFHandler<dim> dof_handler(tria);
   dof_handler.distribute_dofs(fe);
-  dof_handler.distribute_mg_dofs(fe);
+  dof_handler.distribute_mg_dofs();
 
   std::vector<types::global_dof_index> dof_indices(fe.dofs_per_cell);
   for (unsigned int level = 0; level < tria.n_global_levels(); ++level)
index 8132a8f3c340d3d68f085399d28de0300c168c5e..61e86544358c8fb330b200ad8229506e31e3acd5 100644 (file)
@@ -72,7 +72,7 @@ test()
   deallog << "Number of cells: " << tria.n_global_active_cells() << std::endl
           << "Number of DoFs: " << dof_handler.n_dofs() << std::endl;
 
-  dof_handler.distribute_mg_dofs(fe);
+  dof_handler.distribute_mg_dofs();
   deallog << "Number of DoFs per level: ";
   for (unsigned int level = 0; level < tria.n_global_levels(); ++level)
     deallog << dof_handler.n_dofs(level) << " ";
index d0dabdf3ff3ab9426870b14973b24e21675f236f..dd5f7afe6bdf9feea4d4b61708e61e8a45e02bc9 100644 (file)
@@ -77,9 +77,9 @@ test()
   FE_Q<dim>       fe2(1);
   DoFHandler<dim> dof_handler(tria);
   dof_handler.distribute_dofs(fe1);
-  dof_handler.distribute_mg_dofs(fe1);
+  dof_handler.distribute_mg_dofs();
   dof_handler.distribute_dofs(fe2);
-  dof_handler.distribute_mg_dofs(fe2);
+  dof_handler.distribute_mg_dofs();
   deallog << "OK" << std::endl;
 }
 
index 9ce3bc7b66b1302438d48811a838a307db73ca8e..f3b4765260ba7c8556bf6528b00bc51b1165281b 100644 (file)
@@ -176,7 +176,7 @@ namespace Step50
   LaplaceProblem<dim>::setup_system()
   {
     mg_dof_handler.distribute_dofs(fe);
-    mg_dof_handler.distribute_mg_dofs(fe);
+    mg_dof_handler.distribute_mg_dofs();
 
     deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs();
 
index 32925e848fa9e06ad0cfaa33733fe1cd86c0788b..c59f656bd82c5f7e822daf51cbbc6aeae36d6dd1 100644 (file)
@@ -176,7 +176,7 @@ namespace Step50
   LaplaceProblem<dim>::setup_system()
   {
     mg_dof_handler.distribute_dofs(fe);
-    mg_dof_handler.distribute_mg_dofs(fe);
+    mg_dof_handler.distribute_mg_dofs();
 
     deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs();
 
index 2b211eafdcfbb03b900739abba9affa38462185b..fdd195ceed86619ee85d6b45e9cdeb5d9f71f15a 100644 (file)
@@ -462,7 +462,7 @@ namespace Step39
   InteriorPenaltyProblem<dim>::setup_system()
   {
     dof_handler.distribute_dofs(fe);
-    dof_handler.distribute_mg_dofs(fe);
+    dof_handler.distribute_mg_dofs();
 
     DoFTools::extract_locally_relevant_dofs(dof_handler, locally_relevant_set);
     solution.reinit(dof_handler.locally_owned_dofs(), MPI_COMM_WORLD);
index c75ff46ef4f7a95341ec38cc1f081065873d4ccc..cb94a8471eb7de587b2a92a6cd0b36aa5ff373e8 100644 (file)
@@ -463,7 +463,7 @@ namespace Step39
   InteriorPenaltyProblem<dim>::setup_system()
   {
     dof_handler.distribute_dofs(fe);
-    dof_handler.distribute_mg_dofs(fe);
+    dof_handler.distribute_mg_dofs();
 
     DoFTools::extract_locally_relevant_dofs(dof_handler, locally_relevant_set);
     solution.reinit(dof_handler.locally_owned_dofs(), MPI_COMM_WORLD);
index 179e325097108cf1ae859c87e536a8afcd69857c..b59735df926b70c8562177ad401b9b71a6e9eb44 100644 (file)
@@ -72,7 +72,7 @@ check_fe(FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   std::vector<std::set<types::global_dof_index>> boundary_indices(
     tr.n_levels());
index 02b9dbb3063b724ad07342be9b62300cc60e22bf..c804c8b8153dea83f606bfd5e91c01f877b39ec7 100644 (file)
@@ -80,7 +80,7 @@ check_fe(FiniteElement<dim> &fe)
 
   DoFHandler<dim> dofh(tr);
   dofh.distribute_dofs(fe);
-  dofh.distribute_mg_dofs(fe);
+  dofh.distribute_mg_dofs();
 
   MGConstrainedDoFs mg_constrained_dofs_ref;
   {
@@ -93,7 +93,7 @@ check_fe(FiniteElement<dim> &fe)
 
     DoFHandler<dim> dofhref(tr);
     dofhref.distribute_dofs(fe);
-    dofhref.distribute_mg_dofs(fe);
+    dofhref.distribute_mg_dofs();
 
     // std::map<std::string,std::vector<types::global_dof_index> > dofmap;
     std::map<std::string, std::vector<types::global_dof_index>> mgdofmap;
index 0e58d638cc0a66cd90ec3966003eecc9075fc787..1a79583351d7af67ca1c097fc803b9c672c8af6f 100644 (file)
@@ -141,7 +141,7 @@ check_fe(FiniteElement<dim> &fe)
 
   DoFHandler<dim> dofh(tr);
   dofh.distribute_dofs(fe);
-  dofh.distribute_mg_dofs(fe);
+  dofh.distribute_mg_dofs();
 
   MGConstrainedDoFs mg_constrained_dofs_ref;
   {
@@ -154,7 +154,7 @@ check_fe(FiniteElement<dim> &fe)
 
     DoFHandler<dim> dofhref(tr);
     dofhref.distribute_dofs(fe);
-    dofhref.distribute_mg_dofs(fe);
+    dofhref.distribute_mg_dofs();
 
     // std::map<std::string,std::vector<types::global_dof_index> > dofmap;
     std::map<std::string, std::vector<types::global_dof_index>> mgdofmap;
index 177995219950d38738c3976b7e1bcbd3d6af73a2..03b09adb04448306f9e63bcc168e89d12e0496a7 100644 (file)
@@ -56,7 +56,7 @@ check_fe(FiniteElement<dim> &fe, ComponentMask &component_mask)
 
   DoFHandler<dim> dofh(tr);
   dofh.distribute_dofs(fe);
-  dofh.distribute_mg_dofs(fe);
+  dofh.distribute_mg_dofs();
 
   MGConstrainedDoFs            mg_constrained_dofs;
   std::set<types::boundary_id> boundary_indicators;
index cdc7a6e91513c43031328204eb5b63351502af35..936faff7a6e819fcd2df0bc30fc5c6281098d820 100644 (file)
@@ -64,7 +64,7 @@ check_fe(FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   std::vector<std::vector<types::global_dof_index>> count(tr.n_levels());
   MGTools::count_dofs_per_component(mgdof, count, false);
index 7261ece8e353191b5ddd6872e8e29c48d983be03..fdfb742593b52495f118ef0385ec7e64588ea893 100644 (file)
@@ -98,7 +98,7 @@ do_test()
 
   DoFHandler<dim> dof_handler(triangulation);
   dof_handler.distribute_dofs(fe);
-  dof_handler.distribute_mg_dofs(fe);
+  dof_handler.distribute_mg_dofs();
 }
 
 
index e6dd14f586dde986376db5e21d97cc50374fe061..c2d9393fe0a8cac74402f94f59bcfe4a98ca77fa 100644 (file)
@@ -82,7 +82,7 @@ check_fe(FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
   dofs(mgdof);
 }
 
index f9f75119d6c383a17c5c9f82380bf17bd9f3d79b..94e0d06a81cb55db15e2e615a19ac5467a015661 100644 (file)
@@ -88,7 +88,7 @@ check_fe(FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
   dofs(mgdof);
 }
 
index db553eaebec38acf1ad7cdbe2ec7bc739b4b47fb..4b2c690bc2990b5ac28a439f51039584d478fb27 100644 (file)
@@ -54,7 +54,7 @@ check()
 
 
     dof.distribute_dofs(fe);
-    dof.distribute_mg_dofs(fe);
+    dof.distribute_mg_dofs();
     deallog << "check " << dim << " level  distribute " << dof.has_active_dofs()
             << ' ' << dof.has_level_dofs() << std::endl;
 
index 9edb0061474be8d80789bfe9de0bc1e97c4b75a8..a8b1fde1b4081d43b4bfc05ca404da1fffc5688f 100644 (file)
@@ -43,7 +43,7 @@ check()
 
   DoFHandler<dim> dof(tr);
   dof.distribute_dofs(fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
 
   std::vector<types::global_dof_index> dof_indices(fe.dofs_per_cell);
   std::vector<types::global_dof_index> mg_dof_indices(fe.dofs_per_cell);
index e9cc6ced1d4179f3c392052bf5f097800b52503a..94acd75e324eefde7cc6289f6e0d576711d3d312 100644 (file)
@@ -46,7 +46,7 @@ check()
 
   DoFHandler<dim> dof(tr);
   dof.distribute_dofs(fe);
-  dof.distribute_mg_dofs(fe);
+  dof.distribute_mg_dofs();
   deallog << dim << "D OK" << std::endl;
 }
 
index 4cfa2d97c5443e857a31d4e060d9e9bc0af1a01a..54b977e940b69bcfdf6caa26f22af7142e14fcf5 100644 (file)
@@ -144,7 +144,7 @@ namespace Step50
   LaplaceProblem<dim>::setup_system()
   {
     mg_dof_handler.distribute_dofs(fe);
-    mg_dof_handler.distribute_mg_dofs(fe);
+    mg_dof_handler.distribute_mg_dofs();
 
     DoFTools::extract_locally_relevant_dofs(mg_dof_handler,
                                             locally_relevant_set);
index fb0ec4225794fa47baf5421d0b51bab81a361414..4d7ec9fca4afb94219efa24e241aaeeeeddf15c3 100644 (file)
@@ -201,7 +201,7 @@ namespace Step50
   LaplaceProblem<dim>::setup_system()
   {
     mg_dof_handler.distribute_dofs(fe);
-    mg_dof_handler.distribute_mg_dofs(fe);
+    mg_dof_handler.distribute_mg_dofs();
 
     DoFTools::extract_locally_relevant_dofs(mg_dof_handler,
                                             locally_relevant_set);
index 349c234e15f98d8639aa8f4e8053bbae53fe9189..188a534a52d322afa1a713ae7c52ec2ed6f498e2 100644 (file)
@@ -221,11 +221,11 @@ check_simple(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   DoFHandler<dim> mgdof_renumbered(tr);
   mgdof_renumbered.distribute_dofs(fe);
-  mgdof_renumbered.distribute_mg_dofs(fe);
+  mgdof_renumbered.distribute_mg_dofs();
 
   std::vector<unsigned int> block_component(4, 0);
   block_component[2] = 1;
index b44bb80e1a6b71d31f276ad5743048603a33c55d..703a7f07688f9805c6a0971d5a3b351d05122707 100644 (file)
@@ -219,11 +219,11 @@ check_simple(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   DoFHandler<dim> mgdof_renumbered(tr);
   mgdof_renumbered.distribute_dofs(fe);
-  mgdof_renumbered.distribute_mg_dofs(fe);
+  mgdof_renumbered.distribute_mg_dofs();
 
   std::vector<unsigned int> block_component(4, 0);
   block_component[2] = 1;
index 587c308b89d79e170d2b9b33f36cab7933f6e7c7..e79ea0d620fc02c91936e0bfca097c4b4c1ff90e 100644 (file)
@@ -209,9 +209,9 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
   mg_dof_handler_renumbered.distribute_dofs(fe);
-  mg_dof_handler_renumbered.distribute_mg_dofs(fe);
+  mg_dof_handler_renumbered.distribute_mg_dofs();
 
   std::vector<unsigned int> block_component(2 * dim, 0);
   for (unsigned int c = dim; c < 2 * dim; ++c)
index 765b612b6055bc393be62262bf0dc80e4180ffd8..a65dca123377a109d2e4227eee8acc32a1368a45 100644 (file)
@@ -221,7 +221,7 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler_renumbered.distribute_dofs(fe);
-  mg_dof_handler_renumbered.distribute_mg_dofs(fe);
+  mg_dof_handler_renumbered.distribute_mg_dofs();
 
   const unsigned int nlevels = triangulation.n_levels();
 
index 8ab549443c8bdfa841d1cb266ec91193f30c4e60..703f21efd7c9d44ef5ad8797808d7f52c4efe046 100644 (file)
@@ -271,9 +271,9 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
   mg_dof_handler_renumbered.distribute_dofs(fe);
-  mg_dof_handler_renumbered.distribute_mg_dofs(fe);
+  mg_dof_handler_renumbered.distribute_mg_dofs();
 
   const unsigned int nlevels = triangulation.n_levels();
 
index eb97013b47f79df91593c7487508f03d13be5786..1cce3de6a98c0a2d35f1d31bc7d86612aae7fdd8 100644 (file)
@@ -52,7 +52,7 @@ check()
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
   DoFRenumbering::component_wise(mgdof);
   for (unsigned int l = 0; l < tr.n_levels(); ++l)
     DoFRenumbering::component_wise(mgdof, l);
index bc6e8e00f1d2400a6d609620d9e882f794525fed..4cd07a746caf0f47fab579699acea7a8825fa89d 100644 (file)
@@ -57,7 +57,7 @@ check()
 
   DoFHandler<dim> mg_dof_handler(tria);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
   Point<dim> a;
   a(0) = 1;
   for (unsigned int level = 0; level < tria.n_levels(); ++level)
index 4deda3182f9ae262148a2334d897ffb22f40b735..aed52fb3ef828b497c3d32b9b9fd6f7d2892166a 100644 (file)
@@ -59,7 +59,7 @@ check()
 
   DoFHandler<dim> mg_dof_handler(tria);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
   for (unsigned int level = 0; level < tria.n_levels(); ++level)
     {
       const types::global_dof_index   n_dofs = mg_dof_handler.n_dofs(level);
index 1ed8ab1645f232fe12a3396f02ce7459907192e8..b3a4a4da86c7abdedc2422e670c36366a4305195 100644 (file)
@@ -52,7 +52,7 @@ check(FiniteElement<dim> &fe)
 
   DoFHandler<dim> dh(tria);
   dh.distribute_dofs(fe);
-  dh.distribute_mg_dofs(fe);
+  dh.distribute_mg_dofs();
 
   deallog << "** before:" << std::endl;
   {
index 46fe69d95c0cc198708c7b82586b5375bf6726f6..a0ec9e6599afd79f2586ca58b063a31d9e6ccbcb 100644 (file)
@@ -237,7 +237,7 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
   deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs();
 
   for (unsigned int l = 0; l < triangulation.n_levels(); ++l)
index b0fadd8968be32d292fdbee4b16bda9aa50eb012..8b17190ce7186493b4e56ba0caa8adcae66c68d9 100644 (file)
@@ -162,7 +162,7 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   sparsity_pattern.reinit(mg_dof_handler.n_dofs(),
                           mg_dof_handler.n_dofs(),
index e5e97c7477ade7f16ffb319a21420ec6aee52cde..ae8257bf1a6ef8d83e2df3b5b8a5760ac2bd45a9 100644 (file)
@@ -166,7 +166,7 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   sparsity_pattern.reinit(mg_dof_handler.n_dofs(),
                           mg_dof_handler.n_dofs(),
index 5bcf87673884cb126f0ad73cfa979a33a3edb7d6..e0ccc7820002bc91f5b8271782d393feebd17861 100644 (file)
@@ -163,7 +163,7 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   sparsity_pattern.reinit(mg_dof_handler.n_dofs(),
                           mg_dof_handler.n_dofs(),
index a5d46fdb092b8b120ba922836889a4b95578ae0e..b0748e26f7fb20c3ac0d2aac94495fb9c7ed7b9f 100644 (file)
@@ -163,7 +163,7 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   sparsity_pattern.reinit(mg_dof_handler.n_dofs(),
                           mg_dof_handler.n_dofs(),
index f6b1aadb5a2ce70ce2d1d1075f5773a1ff9157d7..7369f58437b9825550657efaab9b3fa8d0d36744 100644 (file)
@@ -162,7 +162,7 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
   deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs();
 
   for (unsigned int l = 0; l < triangulation.n_levels(); ++l)
index e235d990f5f1bda32126db8dc8ced6cd6aa99dfe..ed8769119337fb01108a176ae0fe104dcd2c67b8 100644 (file)
@@ -196,7 +196,7 @@ namespace Step50
   LaplaceProblem<dim>::setup_system()
   {
     mg_dof_handler.distribute_dofs(fe);
-    mg_dof_handler.distribute_mg_dofs(fe);
+    mg_dof_handler.distribute_mg_dofs();
 
     DoFTools::extract_locally_relevant_dofs(mg_dof_handler,
                                             locally_relevant_set);
index 680801bb64b5a6deeb892dd55f93e40f82940678..f8365f1dd67bf72a5c312c519d255791760d433b 100644 (file)
@@ -196,7 +196,7 @@ namespace Step50
   LaplaceProblem<dim>::setup_system()
   {
     mg_dof_handler.distribute_dofs(fe);
-    mg_dof_handler.distribute_mg_dofs(fe);
+    mg_dof_handler.distribute_mg_dofs();
 
     DoFTools::extract_locally_relevant_dofs(mg_dof_handler,
                                             locally_relevant_set);
index 7529a613495a66f0551788c410be03082bffd54d..4a369c65e84475dc96461cd9800be72712b6349a 100644 (file)
@@ -196,7 +196,7 @@ namespace Step50
   LaplaceProblem<dim>::setup_system()
   {
     mg_dof_handler.distribute_dofs(fe);
-    mg_dof_handler.distribute_mg_dofs(fe);
+    mg_dof_handler.distribute_mg_dofs();
 
     DoFTools::extract_locally_relevant_dofs(mg_dof_handler,
                                             locally_relevant_set);
index 893cf79e721f6163958160bfe4393b2874baae0f..733fb1034dcc62f35db1bd59d1c3e3c777d12b06 100644 (file)
@@ -165,7 +165,7 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   sparsity_pattern.reinit(mg_dof_handler.n_dofs(),
                           mg_dof_handler.n_dofs(),
index a7f567beb1a763516fe7a41f8b775741f88e970a..8e39e8031ac4cc8f1a2b4c232580ac99f1468fb9 100644 (file)
@@ -238,7 +238,7 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
   deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs();
 
   for (unsigned int l = 0; l < triangulation.n_levels(); ++l)
index 3b4dfe4cd33eb7f7dcd143ad046719b006f27309..6a27dc0893387ef51ed4123ddc4f78f50872a1b1 100644 (file)
@@ -162,7 +162,7 @@ void
 LaplaceProblem<dim>::setup_system()
 {
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
   deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs();
 
   for (unsigned int l = 0; l < triangulation.n_levels(); ++l)
index a335b5ddbdc35a822a55770784257d48dc69175b..8f7d862ddaff42239526eda83a87a6b32f6ca5d1 100644 (file)
@@ -452,7 +452,7 @@ namespace Step39
   InteriorPenaltyProblem<dim>::setup_system()
   {
     dof_handler.distribute_dofs(fe);
-    dof_handler.distribute_mg_dofs(fe);
+    dof_handler.distribute_mg_dofs();
     types::global_dof_index n_dofs = dof_handler.n_dofs();
     solution.reinit(n_dofs);
     right_hand_side.reinit(n_dofs);
index 220d8d65ef899dfa87e755c31a2d9f1ab3fb08cb..4d6a3ec3d4bf442cd3a26c0904c30c76944a911f 100644 (file)
@@ -455,7 +455,7 @@ namespace Step39
   InteriorPenaltyProblem<dim>::setup_system()
   {
     dof_handler.distribute_dofs(fe);
-    dof_handler.distribute_mg_dofs(fe);
+    dof_handler.distribute_mg_dofs();
     types::global_dof_index n_dofs = dof_handler.n_dofs();
     solution.reinit(n_dofs);
     right_hand_side.reinit(n_dofs);
index 4ab6afb6283f1b85907ec6b8424f2657867dc239..439c841c531f6bd5a0f21bc5cf8f711754519cec 100644 (file)
@@ -458,7 +458,7 @@ namespace Step39
   InteriorPenaltyProblem<dim>::setup_system()
   {
     dof_handler.distribute_dofs(fe);
-    dof_handler.distribute_mg_dofs(fe);
+    dof_handler.distribute_mg_dofs();
     types::global_dof_index n_dofs = dof_handler.n_dofs();
     solution.reinit(n_dofs);
     right_hand_side.reinit(n_dofs);
index a75319c0675617106c9b4145c9c9456baa2ed580..9160fc1c8c79a7dc6fa40c33346dbcaf39c23a9f 100644 (file)
@@ -452,7 +452,7 @@ namespace Step39
   InteriorPenaltyProblem<dim>::setup_system()
   {
     dof_handler.distribute_dofs(fe);
-    dof_handler.distribute_mg_dofs(fe);
+    dof_handler.distribute_mg_dofs();
     types::global_dof_index n_dofs = dof_handler.n_dofs();
     solution.reinit(n_dofs);
     right_hand_side.reinit(n_dofs);
index 6d0144f7809951c56b6f8d4c90abdf3784654b20..0daaf3d4fe160bd8d413a1c5449dcdd9a73e88bc 100644 (file)
@@ -198,7 +198,7 @@ namespace Step50
   LaplaceProblem<dim>::setup_system()
   {
     mg_dof_handler.distribute_dofs(fe);
-    mg_dof_handler.distribute_mg_dofs(fe);
+    mg_dof_handler.distribute_mg_dofs();
 
     DoFTools::extract_locally_relevant_dofs(mg_dof_handler,
                                             locally_relevant_set);
index 7cc63c260a49fa1b7f9ca7bcd6a90e148eec8f57..b25d2221432085dd5a60704a17b07788e4f937e8 100644 (file)
@@ -67,7 +67,7 @@ check_simple(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   MGTransferPrebuilt<Vector<double>> transfer;
   transfer.build_matrices(mgdof);
index e16988b6e5574097963c974c239f9e972fdd9ed6..02e33a3e0f9ad3490d30f4bd5c95ca77caa95218 100644 (file)
@@ -100,7 +100,7 @@ check_simple(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   MGTransferPrebuilt<Vector<double>> transfer;
   transfer.build_matrices(mgdof);
index 0cb623b1562a7e844344829a9c0f7f314efa70a8..0d9c03c685f5055a2929682e75815e825a3b4318 100644 (file)
@@ -193,11 +193,11 @@ check_simple(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   DoFHandler<dim> mgdof_renumbered(tr);
   mgdof_renumbered.distribute_dofs(fe);
-  mgdof_renumbered.distribute_mg_dofs(fe);
+  mgdof_renumbered.distribute_mg_dofs();
 
   std::vector<unsigned int> block_component(4, 0);
   block_component[2] = 1;
index a2ffd2d42ff5c22fe7080b8000ee1b4124eae7a9..326e597f40d18b268739a18b61abc362ec31760b 100644 (file)
@@ -122,7 +122,7 @@ check_fe(FiniteElement<dim> &fe)
 
   DoFHandler<dim> dofh(tr);
   dofh.distribute_dofs(fe);
-  dofh.distribute_mg_dofs(fe);
+  dofh.distribute_mg_dofs();
   typedef TrilinosWrappers::MPI::Vector vector_t;
 
   MGConstrainedDoFs mg_constrained_dofs;
index 9733e27802cda426fa87c83de06b3b7eb626537d..ed71663c24d828193d8411e0b3b6fb728fdf8974 100644 (file)
@@ -126,7 +126,7 @@ check_fe(FiniteElement<dim> &fe)
 
   DoFHandler<dim> dofh(tr);
   dofh.distribute_dofs(fe);
-  dofh.distribute_mg_dofs(fe);
+  dofh.distribute_mg_dofs();
   typedef TrilinosWrappers::MPI::Vector vector_t;
   {}
   MGTransferPrebuilt<vector_t> transfer;
index d4daa56a27e66c00eb3ab8a00483c2374ec50ffc..42994dbdfbbea40f746db529d67e4a297035806d 100644 (file)
@@ -126,7 +126,7 @@ check_fe(FiniteElement<dim> &fe)
 
   DoFHandler<dim> dofh(tr);
   dofh.distribute_dofs(fe);
-  dofh.distribute_mg_dofs(fe);
+  dofh.distribute_mg_dofs();
   typedef PETScWrappers::MPI::Vector vector_t;
   {}
   MGTransferPrebuilt<vector_t> transfer;
index aced985f946d47ddfa855c67633b27aa1b3000f2..ec5447a9b33add4d905611ee48c06db2c93b8157 100644 (file)
@@ -103,7 +103,7 @@ check(const unsigned int fe_degree)
 
       DoFHandler<dim> mgdof(tr);
       mgdof.distribute_dofs(fe);
-      mgdof.distribute_mg_dofs(fe);
+      mgdof.distribute_mg_dofs();
 
       MGConstrainedDoFs                                   mg_constrained_dofs;
       ZeroFunction<dim>                                   zero_function;
index 551bdf0cc0b80ae3cb89544fd9af1a3725f6411d..f4cdaaf52bd9ce41fe5bb070ab84fc667f49d45c 100644 (file)
@@ -109,11 +109,11 @@ check(const unsigned int fe_degree)
 
       DoFHandler<dim> mgdof_1(tr);
       mgdof_1.distribute_dofs(fe_1);
-      mgdof_1.distribute_mg_dofs(fe_1);
+      mgdof_1.distribute_mg_dofs();
 
       DoFHandler<dim> mgdof_2(tr);
       mgdof_2.distribute_dofs(fe_2);
-      mgdof_2.distribute_mg_dofs(fe_2);
+      mgdof_2.distribute_mg_dofs();
 
       const std::vector<const DoFHandler<dim> *> mgdof_ptr{&mgdof_1, &mgdof_2};
 
index 82c2578b32e716dc745af44189e30fa9353cf6d1..abb10618d1d52b49a52f74b4ad3eb4ee7e4b2c6b 100644 (file)
@@ -99,7 +99,7 @@ check_block(const FiniteElement<dim> &fe,
   DoFHandler<dim>  mgdof(tr);
   DoFHandler<dim> &dof = mgdof;
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
   DoFRenumbering::component_wise(mgdof);
   vector<types::global_dof_index> ndofs(fe.n_blocks());
   DoFTools::count_dofs_per_block(mgdof, ndofs);
index c5324946511e836bc144af407694671992c84b92..a1d0f4e0ad50fb7201486cad93424ac4f11ad8dd 100644 (file)
@@ -85,7 +85,7 @@ check_select(const FiniteElement<dim> &fe, unsigned int selected)
   DoFHandler<dim>  mgdof(tr);
   DoFHandler<dim> &dof = mgdof;
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
   DoFRenumbering::component_wise(mgdof);
   vector<types::global_dof_index> ndofs(fe.n_blocks());
   DoFTools::count_dofs_per_block(mgdof, ndofs);
index d8b6d6844ce2995c3d7c39213081bec25bced0a7..4e97c2223e960dc6e7a07a4f24ed0ed9bd9453df 100644 (file)
@@ -129,7 +129,7 @@ check_block(const FiniteElement<dim> &fe)
   DoFHandler<dim>  mgdof(tr);
   DoFHandler<dim> &dof = mgdof;
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   // Make sure all orderings are the
   // same
index c169c1ee00b4292d0af315ed9b222fc643061032..3345e52d99136ed5e38e1f3ec5894885bd874187 100644 (file)
@@ -65,7 +65,7 @@ check(const unsigned int fe_degree)
 
       DoFHandler<dim> mgdof(tr);
       mgdof.distribute_dofs(fe);
-      mgdof.distribute_mg_dofs(fe);
+      mgdof.distribute_mg_dofs();
 
       MGConstrainedDoFs                                   mg_constrained_dofs;
       Functions::ZeroFunction<dim>                        zero_function;
index f590ab04849cb42138d92f1b5392a02fd37998df..94413aa6f379be89613a9c441d22c4552a8461aa 100644 (file)
@@ -94,7 +94,7 @@ check(const unsigned int fe_degree)
 
       DoFHandler<dim> mgdof(tr);
       mgdof.distribute_dofs(fe);
-      mgdof.distribute_mg_dofs(fe);
+      mgdof.distribute_mg_dofs();
 
       MGConstrainedDoFs                                   mg_constrained_dofs;
       Functions::ZeroFunction<dim>                        zero_function;
index a9a31a45dc31223e73b56d7a294a85d8d351877c..4e7f5e2041d824bcafb3c7133f05a3c353043ef2 100644 (file)
@@ -98,7 +98,7 @@ check(const unsigned int fe_degree)
 
       DoFHandler<dim> mgdof(tr);
       mgdof.distribute_dofs(fe);
-      mgdof.distribute_mg_dofs(fe);
+      mgdof.distribute_mg_dofs();
 
       MGConstrainedDoFs                                   mg_constrained_dofs;
       ZeroFunction<dim>                                   zero_function;
index bd359bbdead870bd0fbe5ae962ad548bf53f8f69..4d782c8e3081e652991582138b05b502fa8284d1 100644 (file)
@@ -103,11 +103,11 @@ check(const unsigned int fe_degree)
 
       DoFHandler<dim> mgdof_1(tr);
       mgdof_1.distribute_dofs(fe_1);
-      mgdof_1.distribute_mg_dofs(fe_1);
+      mgdof_1.distribute_mg_dofs();
 
       DoFHandler<dim> mgdof_2(tr);
       mgdof_2.distribute_dofs(fe_2);
-      mgdof_2.distribute_mg_dofs(fe_2);
+      mgdof_2.distribute_mg_dofs();
 
       const std::vector<const DoFHandler<dim> *> mgdof_ptr{&mgdof_1, &mgdof_2};
 
index 16a5a339fe8c08353b80b32c5ed6f9a5e0855a39..9ffb0853512ebed0ae28670be044c08b7e05e61f 100644 (file)
@@ -63,7 +63,7 @@ check(const unsigned int fe_degree)
 
       DoFHandler<dim> mgdof(tr);
       mgdof.distribute_dofs(fe);
-      mgdof.distribute_mg_dofs(fe);
+      mgdof.distribute_mg_dofs();
 
       MGConstrainedDoFs                                   mg_constrained_dofs;
       Functions::ZeroFunction<dim>                        zero_function;
index 17915ee17c7b57562f8b14e134d0eb4c3c2c0368..41431608587f5d9eaf3eb3e4b731c085dffdd61c 100644 (file)
@@ -66,7 +66,7 @@ check(const unsigned int fe_degree)
 
       DoFHandler<dim> mgdof(tr);
       mgdof.distribute_dofs(fe);
-      mgdof.distribute_mg_dofs(fe);
+      mgdof.distribute_mg_dofs();
 
       // build reference
       MGTransferPrebuilt<LinearAlgebra::distributed::Vector<double>>
index 220eb31076bcda72a38cd07ba314fed00c95393a..73b429074e66559ce1f2aa064dc1c8050a6d619d 100644 (file)
@@ -93,7 +93,7 @@ check(const unsigned int fe_degree)
 
       DoFHandler<dim> mgdof(tr);
       mgdof.distribute_dofs(fe);
-      mgdof.distribute_mg_dofs(fe);
+      mgdof.distribute_mg_dofs();
 
       // build reference
       MGTransferPrebuilt<LinearAlgebra::distributed::Vector<double>>
index 8654ceccf2042101aaf38a97706dd3f56e9e1245..e3206fa262ade8ea559c7bde1b840fc2348e91df 100644 (file)
@@ -96,7 +96,7 @@ check(const unsigned int fe_degree)
 
       DoFHandler<dim> mgdof(tr);
       mgdof.distribute_dofs(fe);
-      mgdof.distribute_mg_dofs(fe);
+      mgdof.distribute_mg_dofs();
 
       MGConstrainedDoFs                                   mg_constrained_dofs;
       Functions::ZeroFunction<dim>                        zero_function;
index f82a46ee2200f509e013c0b58178e66d5e1616d1..f6b118bb46d630224ca53aae8fbd5451d362d918 100644 (file)
@@ -93,7 +93,7 @@ check(const unsigned int fe_degree)
 
       DoFHandler<dim> mgdof(tr);
       mgdof.distribute_dofs(fe);
-      mgdof.distribute_mg_dofs(fe);
+      mgdof.distribute_mg_dofs();
 
       // build reference
       MGTransferPrebuilt<LinearAlgebra::distributed::Vector<double>>
index f1d98ae909ab15385d1058b1a2775211b6c87f16..18b33e98a925e4e33115fd8553a285b93da1fbb0 100644 (file)
@@ -67,7 +67,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   // build matrix-free transfer
   MGTransferMatrixFree<dim, Number> transfer;
index ca997301a562ef4e04a02480e0d8b62df9d00706..ba94fa9eda803de329d23c51dd21bb66178e5b31 100644 (file)
@@ -61,7 +61,7 @@ check(const FiniteElement<dim> &fe)
 
       DoFHandler<dim> mgdof(tr);
       mgdof.distribute_dofs(fe);
-      mgdof.distribute_mg_dofs(fe);
+      mgdof.distribute_mg_dofs();
 
       Tensor<1, dim> exponents_monomial;
       for (unsigned int d = 0; d < dim; ++d)
index 2e6ee74b898e993ca2e45de7b20679f88d9b57fa..7b462d80c21ed50385835816bcb25c0b6060a2d7 100644 (file)
@@ -61,7 +61,7 @@ check(const FiniteElement<dim> &fe)
 
       DoFHandler<dim> mgdof(tr);
       mgdof.distribute_dofs(fe);
-      mgdof.distribute_mg_dofs(fe);
+      mgdof.distribute_mg_dofs();
 
       Tensor<1, dim> exponents_monomial;
       for (unsigned int d = 0; d < dim; ++d)
index 3f866d4b3b0bc412eb5f8c50a9d7d012351a58e6..2d618d1bdad979fa28e674ffbb6124689a762f35 100644 (file)
@@ -55,7 +55,7 @@ check(const unsigned int fe_degree)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   MGConstrainedDoFs mg_constrained_dofs;
   mg_constrained_dofs.initialize(mgdof);
index de9dd7216434a5ebb71f6f7a842e907fa6fe595d..17b1fce6643730924a8ff25b5c77471bd5691b9d 100644 (file)
@@ -70,7 +70,7 @@ check(const FiniteElement<dim> &fe_scalar)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   // build matrix-free transfer
   MGTransferMatrixFree<dim, Number> transfer;
index a0fb2246cc29d8475ab06205d7c68044d78b9ec1..b5432676c89eb2d8ba6edb8a51cbaa4e2a3a9b03 100644 (file)
@@ -58,7 +58,7 @@ check_simple(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   MGTransferPrebuilt<Vector<double>> transfer;
   transfer.build_matrices(mgdof);
index 22ad770476255c975ce36794e9fbe5dcc7947578..9c6df5076807b33b82d3088e2e5a75b312e2fdf3 100644 (file)
@@ -60,7 +60,7 @@ check_simple(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   MGConstrainedDoFs mg_constrained_dofs;
   mg_constrained_dofs.initialize(mgdof);
index 1568fa8d1a28ddce6726e7523fb3976c39487c35..0c4806b1305703ca342482a2c81e3a9a89264a4f 100644 (file)
@@ -61,7 +61,7 @@ check_simple(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   std::map<types::boundary_id, const Function<dim> *> dirichlet_boundary;
   Functions::ZeroFunction<dim> homogeneous_dirichlet_bc(1);
index 141e8ad717af3b2ca1da6907b8db28e79d9f5a2f..074ff7f50383e8b1d62e1df6d7c042c4866f6cbb 100644 (file)
@@ -63,7 +63,7 @@ check()
 
       DoFHandler<dim> mgdof(tr);
       mgdof.distribute_dofs(fe);
-      mgdof.distribute_mg_dofs(fe);
+      mgdof.distribute_mg_dofs();
 
       MGConstrainedDoFs                                   mg_constrained_dofs;
       Functions::ZeroFunction<dim>                        zero_function;
index e1f8f390bcf007c2adc078d590053519459e8dd5..8fc70872f228def1a256f3279a92710451d96230 100644 (file)
@@ -58,7 +58,7 @@ check_select(const FiniteElement<dim> &fe,
   DoFHandler<dim>  mgdof(tr);
   DoFHandler<dim> &dof = mgdof;
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
   DoFRenumbering::component_wise(mgdof, target_component);
   vector<types::global_dof_index> ndofs(
     *std::max_element(target_component.begin(), target_component.end()) + 1);
index 1fa3206622d0ca5caebd23e2f794b98400fd929e..6835847470e4373b9ba3c6711232039c34a71c7b 100644 (file)
@@ -97,7 +97,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   DoFRenumbering::component_wise(mg_dof_handler);
   for (unsigned int level = 0; level < tr.n_levels(); ++level)
index 29eca1f469bdf0227ecf2d0b41b32fecfd456641..8a82dec48942487640ff3391510970fcad3855c7 100644 (file)
@@ -98,7 +98,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   DoFRenumbering::component_wise(mg_dof_handler);
   for (unsigned int level = 0; level < tr.n_levels(); ++level)
index f275b5f19f667520ebd6aa02f25265984df56db9..00eee4d5ce9585c59dfaf1f518d8cd3eeec6161a 100644 (file)
@@ -99,7 +99,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   DoFRenumbering::component_wise(mg_dof_handler);
   for (unsigned int level = 0; level < tr.n_levels(); ++level)
index 9b738d37455bd73fd6733c8c9474619fe252678d..9d6c8f7fa9ca10bc01971777fc53430dcc9ff7e8 100644 (file)
@@ -99,7 +99,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   std::vector<unsigned int> block_component(3, 0);
   block_component[2] = 1;
index c3204e449f899931d847ceb0b72509f47f80050b..cc9a6e7264ea782891505e762ef59bcc79a3f65f 100644 (file)
@@ -53,7 +53,7 @@ check(const FiniteElement<dim> &fe, const unsigned int selected_block)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   std::vector<unsigned int> block_component(5, 0);
   block_component[2] = 1;
index c45231881d697c9e6f80a836f345802457ed4e33..c908ae1b62f3e3f719698f87bc8cd61eae0dafd4 100644 (file)
@@ -137,7 +137,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   deallog << "Global  dofs: " << mg_dof_handler.n_dofs() << std::endl;
   for (unsigned int l = 0; l < tr.n_levels(); ++l)
index 3f0f295e31f3861d1d024b0e96f8bc3bd9e1a399..fd6b86cea196f11bb94a46e8c02ada96b96cdf0e 100644 (file)
@@ -137,7 +137,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   deallog << "Global  dofs: " << mg_dof_handler.n_dofs() << std::endl;
   for (unsigned int l = 0; l < tr.n_levels(); ++l)
index fb054e5c511733537f7ed8c11d17a020066b67db..700ee7d78492264336f3d481d216484cb44b1851 100644 (file)
@@ -138,7 +138,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   deallog << "Global  dofs: " << mg_dof_handler.n_dofs() << std::endl;
   for (unsigned int l = 0; l < tr.n_levels(); ++l)
index fcbbff141485f8fe851bcebfd196df2263dc5e15..a504d459340cc082ca48fdd8de0a7da5734dee8d 100644 (file)
@@ -137,7 +137,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   deallog << "Global  dofs: " << mg_dof_handler.n_dofs() << std::endl;
   for (unsigned int l = 0; l < tr.n_levels(); ++l)
index 2dc4a631c13cc695285a17319b1ef8299ce48cda..8318af82bd717ca9c071c5bc9061542d2d638630 100644 (file)
@@ -139,7 +139,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   deallog << "Global  dofs: " << mg_dof_handler.n_dofs() << std::endl;
   for (unsigned int l = 0; l < tr.n_levels(); ++l)
index daa8141fef7d13092e6a9e339bfcb5182ddd66c5..c9804a34e27dd659e9a2afa3b9d82a3f533759fa 100644 (file)
@@ -137,7 +137,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   deallog << "Global  dofs: " << mg_dof_handler.n_dofs() << std::endl;
   for (unsigned int l = 0; l < tr.n_levels(); ++l)
index c024583202124ef7275391bfdd83d453302b7943..da5d56403a0efdfab19b26b8d0bd4724a5e51e0f 100644 (file)
@@ -139,7 +139,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   std::vector<unsigned int> block_selected(3, 0);
   block_selected[2] = 1;
index 7328215b41046ccda700d7f2f787cc4a6e83c177..179b12a858ba812227ac28a6bc35fa70f9f86986 100644 (file)
@@ -138,7 +138,7 @@ check(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   std::vector<unsigned int> block_selected(3, 0);
   block_selected[2] = 1;
index eb622ccc428cf898aca122099f9006d39a6d7786..9954b618b641bca6822060aac06b8f540e0fddad 100644 (file)
@@ -99,7 +99,7 @@ check(const FiniteElement<dim> &fe, const unsigned int selected_block)
 
   DoFHandler<dim> mg_dof_handler(tr);
   mg_dof_handler.distribute_dofs(fe);
-  mg_dof_handler.distribute_mg_dofs(fe);
+  mg_dof_handler.distribute_mg_dofs();
 
   std::vector<unsigned int> block_component(5, 0);
   block_component[2] = 1;
index 04699d55d2874924b0d4c89a39c10eb73150543c..54a8357b2a0cb67c3501fc0cc52235cefa4cf79d 100644 (file)
@@ -78,7 +78,7 @@ check_simple(const FiniteElement<dim> &fe)
 
   DoFHandler<dim> mgdof(tr);
   mgdof.distribute_dofs(fe);
-  mgdof.distribute_mg_dofs(fe);
+  mgdof.distribute_mg_dofs();
 
   MGTransferPrebuilt<TrilinosWrappers::MPI::Vector> transfer;
   transfer.build_matrices(mgdof);

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.