From: Martin Kronbichler Date: Mon, 3 Jun 2019 11:34:43 +0000 (+0200) Subject: Adapt tests to the new compute_..._per_processor() functions X-Git-Tag: v9.2.0-rc1~1440^2~3 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=00062387ce4a7e590d7c3f1fd21287e908045688;p=dealii.git Adapt tests to the new compute_..._per_processor() functions --- diff --git a/tests/distributed_grids/dof_handler_number_cache.cc b/tests/distributed_grids/dof_handler_number_cache.cc index 2712a9aa9d..85626e9bbf 100644 --- a/tests/distributed_grids/dof_handler_number_cache.cc +++ b/tests/distributed_grids/dof_handler_number_cache.cc @@ -99,10 +99,10 @@ test() AssertThrow(dof_handler.n_locally_owned_dofs() == N, ExcInternalError()); AssertThrow(dof_handler.locally_owned_dofs() == all, ExcInternalError()); - AssertThrow(dof_handler.n_locally_owned_dofs_per_processor() == + AssertThrow(dof_handler.compute_n_locally_owned_dofs_per_processor() == std::vector(1, N), ExcInternalError()); - AssertThrow(dof_handler.locally_owned_dofs_per_processor() == + AssertThrow(dof_handler.compute_locally_owned_dofs_per_processor() == std::vector(1, all), ExcInternalError()); } diff --git a/tests/distributed_grids/hp_dof_handler_number_cache.cc b/tests/distributed_grids/hp_dof_handler_number_cache.cc index 35b27667f4..c24a60f0c5 100644 --- a/tests/distributed_grids/hp_dof_handler_number_cache.cc +++ b/tests/distributed_grids/hp_dof_handler_number_cache.cc @@ -106,10 +106,10 @@ test() AssertThrow(dof_handler.n_locally_owned_dofs() == N, ExcInternalError()); AssertThrow(dof_handler.locally_owned_dofs() == all, ExcInternalError()); - AssertThrow(dof_handler.n_locally_owned_dofs_per_processor() == + AssertThrow(dof_handler.compute_n_locally_owned_dofs_per_processor() == std::vector(1, N), ExcInternalError()); - AssertThrow(dof_handler.locally_owned_dofs_per_processor() == + AssertThrow(dof_handler.compute_locally_owned_dofs_per_processor() == std::vector(1, all), ExcInternalError()); } diff --git a/tests/dofs/dof_handler_number_cache.cc b/tests/dofs/dof_handler_number_cache.cc index 9690056f6c..39c14497bf 100644 --- a/tests/dofs/dof_handler_number_cache.cc +++ b/tests/dofs/dof_handler_number_cache.cc @@ -96,10 +96,10 @@ test() AssertThrow(dof_handler.n_locally_owned_dofs() == N, ExcInternalError()); AssertThrow(dof_handler.locally_owned_dofs() == all, ExcInternalError()); - AssertThrow(dof_handler.n_locally_owned_dofs_per_processor() == + AssertThrow(dof_handler.compute_n_locally_owned_dofs_per_processor() == std::vector(1, N), ExcInternalError()); - AssertThrow(dof_handler.locally_owned_dofs_per_processor() == + AssertThrow(dof_handler.compute_locally_owned_dofs_per_processor() == std::vector(1, all), ExcInternalError()); } diff --git a/tests/dofs/dof_handler_number_cache_02.cc b/tests/dofs/dof_handler_number_cache_02.cc index 03cde3f5f4..a6c9124f87 100644 --- a/tests/dofs/dof_handler_number_cache_02.cc +++ b/tests/dofs/dof_handler_number_cache_02.cc @@ -95,16 +95,17 @@ test() Assert(dof_handler.n_locally_owned_dofs() == N, ExcInternalError()); Assert(dof_handler.locally_owned_dofs() == all, ExcInternalError()); - Assert(dof_handler.n_locally_owned_dofs_per_processor() == + Assert(dof_handler.compute_n_locally_owned_dofs_per_processor() == std::vector(1, N), ExcInternalError()); - Assert(dof_handler.locally_owned_dofs_per_processor() == + Assert(dof_handler.compute_locally_owned_dofs_per_processor() == std::vector(1, all), ExcInternalError()); dof_handler.clear(); deallog << "those should be zero: " << dof_handler.n_locally_owned_dofs() - << " " << dof_handler.n_locally_owned_dofs_per_processor().size() + << " " + << dof_handler.compute_n_locally_owned_dofs_per_processor().size() << " " << dof_handler.n_dofs() << std::endl; } } diff --git a/tests/dofs/dof_tools_22a.cc b/tests/dofs/dof_tools_22a.cc index d1a5e06968..0ca80adbd0 100644 --- a/tests/dofs/dof_tools_22a.cc +++ b/tests/dofs/dof_tools_22a.cc @@ -114,7 +114,7 @@ test() MPI_COMM_WORLD)); SparsityTools::distribute_sparsity_pattern( sp, - dh.n_locally_owned_dofs_per_processor(), + dh.compute_n_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, relevant_partitioning); diff --git a/tests/dofs/sparsity_pattern_06.cc b/tests/dofs/sparsity_pattern_06.cc index 3a98472f1c..be9c5c158f 100644 --- a/tests/dofs/sparsity_pattern_06.cc +++ b/tests/dofs/sparsity_pattern_06.cc @@ -138,7 +138,7 @@ main(int argc, char **argv) dynamic_sparsity_pattern.print(deallog.get_file_stream()); SparsityTools::distribute_sparsity_pattern( dynamic_sparsity_pattern, - dof_handler_0.n_locally_owned_dofs_per_processor(), + dof_handler_0.compute_n_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, dof_handler_0.locally_owned_dofs()); dynamic_sparsity_pattern.print(deallog.get_file_stream()); diff --git a/tests/dofs/sparsity_pattern_07.cc b/tests/dofs/sparsity_pattern_07.cc index 53d154bf20..2b7634beec 100644 --- a/tests/dofs/sparsity_pattern_07.cc +++ b/tests/dofs/sparsity_pattern_07.cc @@ -155,7 +155,7 @@ main(int argc, char **argv) dynamic_sparsity_pattern.print(deallog.get_file_stream()); SparsityTools::distribute_sparsity_pattern( dynamic_sparsity_pattern, - dof_handler_0.n_locally_owned_dofs_per_processor(), + dof_handler_0.compute_n_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, dof_handler_0.locally_owned_dofs()); dynamic_sparsity_pattern.print(deallog.get_file_stream()); diff --git a/tests/gla/block_mat_02.cc b/tests/gla/block_mat_02.cc index 52a091e86d..db286a5c79 100644 --- a/tests/gla/block_mat_02.cc +++ b/tests/gla/block_mat_02.cc @@ -125,7 +125,7 @@ test() SparsityTools::distribute_sparsity_pattern( sp, - stokes_dof_handler.locally_owned_dofs_per_processor(), + stokes_dof_handler.compute_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, stokes_relevant_set); diff --git a/tests/gla/block_mat_03.cc b/tests/gla/block_mat_03.cc index 51df9f44b4..e516a5118f 100644 --- a/tests/gla/block_mat_03.cc +++ b/tests/gla/block_mat_03.cc @@ -110,7 +110,7 @@ test() DoFTools::make_sparsity_pattern(dof_handler, bcsp, constraints, false); SparsityTools::distribute_sparsity_pattern( bcsp, - dof_handler.locally_owned_dofs_per_processor(), + dof_handler.compute_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, locally_relevant_dofs); diff --git a/tests/gla/mat_03.cc b/tests/gla/mat_03.cc index 0b7bcd9122..eaafffd171 100644 --- a/tests/gla/mat_03.cc +++ b/tests/gla/mat_03.cc @@ -85,7 +85,7 @@ test() MPI_COMM_WORLD)); SparsityTools::distribute_sparsity_pattern( sp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, relevant); sp.compress(); diff --git a/tests/gla/mat_04.cc b/tests/gla/mat_04.cc index 35143067cc..8b42b91ce8 100644 --- a/tests/gla/mat_04.cc +++ b/tests/gla/mat_04.cc @@ -84,7 +84,7 @@ test() MPI_COMM_WORLD)); SparsityTools::distribute_sparsity_pattern( sp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, relevant); sp.compress(); diff --git a/tests/hp/dof_handler_number_cache.cc b/tests/hp/dof_handler_number_cache.cc index 69d3a11dfc..07a5813c33 100644 --- a/tests/hp/dof_handler_number_cache.cc +++ b/tests/hp/dof_handler_number_cache.cc @@ -107,10 +107,10 @@ test() AssertThrow(dof_handler.n_locally_owned_dofs() == N, ExcInternalError()); AssertThrow(dof_handler.locally_owned_dofs() == all, ExcInternalError()); - AssertThrow(dof_handler.n_locally_owned_dofs_per_processor() == + AssertThrow(dof_handler.compute_n_locally_owned_dofs_per_processor() == std::vector(1, N), ExcInternalError()); - AssertThrow(dof_handler.locally_owned_dofs_per_processor() == + AssertThrow(dof_handler.compute_locally_owned_dofs_per_processor() == std::vector(1, all), ExcInternalError()); } diff --git a/tests/lac/linear_operator_12.cc b/tests/lac/linear_operator_12.cc index ba5875d5a0..05dd62b4ce 100644 --- a/tests/lac/linear_operator_12.cc +++ b/tests/lac/linear_operator_12.cc @@ -204,7 +204,7 @@ Step4::setup_system() DoFTools::make_sparsity_pattern(dof_handler, dsp, constraints, false); SparsityTools::distribute_sparsity_pattern( dsp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, locally_relevant_dofs); diff --git a/tests/lac/linear_operator_12a.cc b/tests/lac/linear_operator_12a.cc index 58b012a860..8b6aa15d5c 100644 --- a/tests/lac/linear_operator_12a.cc +++ b/tests/lac/linear_operator_12a.cc @@ -205,7 +205,7 @@ Step4::setup_system() DoFTools::make_sparsity_pattern(dof_handler, dsp, constraints, false); SparsityTools::distribute_sparsity_pattern( dsp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, locally_relevant_dofs); diff --git a/tests/matrix_free/dg_pbc_01.cc b/tests/matrix_free/dg_pbc_01.cc index e8d5a5c865..fb06c63df1 100644 --- a/tests/matrix_free/dg_pbc_01.cc +++ b/tests/matrix_free/dg_pbc_01.cc @@ -97,7 +97,7 @@ test() solver.solve(mf, sol, rhs, PreconditionIdentity()); const std::vector locally_owned_dofs_per_processor = - dof.locally_owned_dofs_per_processor(); + dof.compute_locally_owned_dofs_per_processor(); // gather all data at root if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0) { diff --git a/tests/mpi/constraints_consistent_01.cc b/tests/mpi/constraints_consistent_01.cc index 29a0d2c067..2dae4d4008 100644 --- a/tests/mpi/constraints_consistent_01.cc +++ b/tests/mpi/constraints_consistent_01.cc @@ -84,7 +84,7 @@ check(parallel::distributed::Triangulation &tria) constraints.print(deallog.get_file_stream()); deallog << "consistent? " << constraints.is_consistent_in_parallel( - dof_handler.locally_owned_dofs_per_processor(), + dof_handler.compute_locally_owned_dofs_per_processor(), locally_active_dofs, MPI_COMM_WORLD, true) diff --git a/tests/mpi/distribute_flux_sparsity_pattern.cc b/tests/mpi/distribute_flux_sparsity_pattern.cc index 0b9dcff9c9..bee6f5d62f 100644 --- a/tests/mpi/distribute_flux_sparsity_pattern.cc +++ b/tests/mpi/distribute_flux_sparsity_pattern.cc @@ -134,7 +134,7 @@ namespace LinearAdvectionTest flux_integral_mask); SparsityTools::distribute_sparsity_pattern( dynamic_sparsity_pattern, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, locally_relevant_dofs); diff --git a/tests/mpi/dof_handler_number_cache.cc b/tests/mpi/dof_handler_number_cache.cc index 59a8feb496..507db4136b 100644 --- a/tests/mpi/dof_handler_number_cache.cc +++ b/tests/mpi/dof_handler_number_cache.cc @@ -107,20 +107,21 @@ test() Assert(dof_handler.n_locally_owned_dofs() <= N, ExcInternalError()); for (unsigned int i = 0; - i < dof_handler.n_locally_owned_dofs_per_processor().size(); + i < dof_handler.compute_n_locally_owned_dofs_per_processor().size(); ++i) - AssertThrow(dof_handler.n_locally_owned_dofs_per_processor()[i] <= N, - ExcInternalError()); + AssertThrow( + dof_handler.compute_n_locally_owned_dofs_per_processor()[i] <= N, + ExcInternalError()); const std::vector n_locally_owned_dofs_per_processor = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); AssertThrow(std::accumulate(n_locally_owned_dofs_per_processor.begin(), n_locally_owned_dofs_per_processor.end(), 0U) == N, ExcInternalError()); const std::vector locally_owned_dofs_per_processor = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet all(N), really_all(N); // poor man's union operation for (unsigned int i = 0; i < n_locally_owned_dofs_per_processor.size(); diff --git a/tests/mpi/hp_step-40.cc b/tests/mpi/hp_step-40.cc index 4ccb89600a..ba44608f2c 100644 --- a/tests/mpi/hp_step-40.cc +++ b/tests/mpi/hp_step-40.cc @@ -163,14 +163,15 @@ namespace Step40 DoFTools::make_sparsity_pattern(dof_handler, csp, constraints, false); SparsityTools::distribute_sparsity_pattern( csp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), mpi_communicator, locally_relevant_dofs); - system_matrix.reinit(mpi_communicator, - csp, - dof_handler.n_locally_owned_dofs_per_processor(), - dof_handler.n_locally_owned_dofs_per_processor(), - Utilities::MPI::this_mpi_process(mpi_communicator)); + system_matrix.reinit( + mpi_communicator, + csp, + dof_handler.compute_n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), + Utilities::MPI::this_mpi_process(mpi_communicator)); } @@ -341,7 +342,8 @@ namespace Step40 for (unsigned int i = 0; i < Utilities::MPI::n_mpi_processes(mpi_communicator); ++i) - pcout << dof_handler.n_locally_owned_dofs_per_processor()[i] << '+'; + pcout << dof_handler.compute_n_locally_owned_dofs_per_processor()[i] + << '+'; pcout << std::endl; assemble_system(); diff --git a/tests/mpi/hp_step-40_variable_01.cc b/tests/mpi/hp_step-40_variable_01.cc index ed3d11456e..73e117f835 100644 --- a/tests/mpi/hp_step-40_variable_01.cc +++ b/tests/mpi/hp_step-40_variable_01.cc @@ -169,14 +169,15 @@ namespace Step40 DoFTools::make_sparsity_pattern(dof_handler, csp, constraints, false); SparsityTools::distribute_sparsity_pattern( csp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), mpi_communicator, locally_relevant_dofs); - system_matrix.reinit(mpi_communicator, - csp, - dof_handler.n_locally_owned_dofs_per_processor(), - dof_handler.n_locally_owned_dofs_per_processor(), - Utilities::MPI::this_mpi_process(mpi_communicator)); + system_matrix.reinit( + mpi_communicator, + csp, + dof_handler.compute_n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), + Utilities::MPI::this_mpi_process(mpi_communicator)); } @@ -344,7 +345,8 @@ namespace Step40 for (unsigned int i = 0; i < Utilities::MPI::n_mpi_processes(mpi_communicator); ++i) - pcout << dof_handler.n_locally_owned_dofs_per_processor()[i] << '+'; + pcout << dof_handler.compute_n_locally_owned_dofs_per_processor()[i] + << '+'; pcout << std::endl; assemble_system(); diff --git a/tests/mpi/interpolate_to_different_mesh_02.cc b/tests/mpi/interpolate_to_different_mesh_02.cc index ae7a1fe470..c0b912a980 100644 --- a/tests/mpi/interpolate_to_different_mesh_02.cc +++ b/tests/mpi/interpolate_to_different_mesh_02.cc @@ -153,7 +153,7 @@ SeventhProblem::setup_system() DoFTools::make_sparsity_pattern(dof_handler, csp, constraints, false); SparsityTools::distribute_sparsity_pattern( csp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), mpi_communicator, locally_relevant_dofs); system_matrix.reinit(locally_owned_dofs, diff --git a/tests/mpi/mg_02.cc b/tests/mpi/mg_02.cc index 690aa78eff..50f6ff0ab2 100644 --- a/tests/mpi/mg_02.cc +++ b/tests/mpi/mg_02.cc @@ -96,7 +96,7 @@ test() const std::vector n_locally_owned_dofs_per_processor = - dofh.n_locally_owned_dofs_per_processor(); + dofh.compute_n_locally_owned_dofs_per_processor(); deallog << "n_locally_owned_dofs_per_processor:" << std::endl; for (unsigned int i = 0; i < n_locally_owned_dofs_per_processor.size(); ++i) deallog << n_locally_owned_dofs_per_processor[i] << std::endl; @@ -107,7 +107,7 @@ test() deallog << "level " << lvl << ":" << std::endl; const std::vector vec = - dofh.locally_owned_mg_dofs_per_processor(lvl); + dofh.compute_locally_owned_mg_dofs_per_processor(lvl); for (unsigned int i = 0; i < vec.size(); ++i) deallog << vec[i].n_elements() << std::endl; diff --git a/tests/mpi/p4est_2d_dofhandler_01.cc b/tests/mpi/p4est_2d_dofhandler_01.cc index d7eeb1cf43..28ebb0fcb5 100644 --- a/tests/mpi/p4est_2d_dofhandler_01.cc +++ b/tests/mpi/p4est_2d_dofhandler_01.cc @@ -57,7 +57,7 @@ test() const std::vector n_locally_owned_dofs_per_processor = - dofh.n_locally_owned_dofs_per_processor(); + dofh.compute_n_locally_owned_dofs_per_processor(); if (myid == 0) { deallog << "dofh.n_dofs() " << n_locally_owned_dofs_per_processor diff --git a/tests/mpi/p4est_2d_dofhandler_02.cc b/tests/mpi/p4est_2d_dofhandler_02.cc index 04d80677e7..71df8c5d5b 100644 --- a/tests/mpi/p4est_2d_dofhandler_02.cc +++ b/tests/mpi/p4est_2d_dofhandler_02.cc @@ -90,7 +90,7 @@ test() dofh.distribute_dofs(fe); std::vector n_locally_owned_dofs_per_processor = - dofh.n_locally_owned_dofs_per_processor(); + dofh.compute_n_locally_owned_dofs_per_processor(); if (myid == 0) { deallog << "dofh.n_dofs() " << n_locally_owned_dofs_per_processor diff --git a/tests/mpi/p4est_2d_dofhandler_03.cc b/tests/mpi/p4est_2d_dofhandler_03.cc index f4c89a6a0f..a0f9e53417 100644 --- a/tests/mpi/p4est_2d_dofhandler_03.cc +++ b/tests/mpi/p4est_2d_dofhandler_03.cc @@ -91,7 +91,7 @@ test() dofh.distribute_dofs(fe); std::vector n_locally_owned_dofs_per_processor = - dofh.n_locally_owned_dofs_per_processor(); + dofh.compute_n_locally_owned_dofs_per_processor(); if (myid == 0) { deallog << "dofh.n_dofs() " << n_locally_owned_dofs_per_processor diff --git a/tests/mpi/p4est_2d_dofhandler_04.cc b/tests/mpi/p4est_2d_dofhandler_04.cc index bdb913dc63..6d202c2c02 100644 --- a/tests/mpi/p4est_2d_dofhandler_04.cc +++ b/tests/mpi/p4est_2d_dofhandler_04.cc @@ -91,7 +91,7 @@ test() dofh.distribute_dofs(fe); std::vector n_locally_owned_dofs_per_processor = - dofh.n_locally_owned_dofs_per_processor(); + dofh.compute_n_locally_owned_dofs_per_processor(); if (myid == 0) { deallog << "dofh.n_dofs() " << n_locally_owned_dofs_per_processor diff --git a/tests/mpi/p4est_2d_renumber_02.cc b/tests/mpi/p4est_2d_renumber_02.cc index 7202db7f8a..87dacefe41 100644 --- a/tests/mpi/p4est_2d_renumber_02.cc +++ b/tests/mpi/p4est_2d_renumber_02.cc @@ -81,7 +81,7 @@ test() DoFTools::extract_locally_active_dofs(dofh, dof_set); const std::vector owned_dofs = - dofh.locally_owned_dofs_per_processor(); + dofh.compute_locally_owned_dofs_per_processor(); if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0) { dof_set.print(deallog); diff --git a/tests/mpi/p4est_data_out_01.cc b/tests/mpi/p4est_data_out_01.cc index 2261db64d0..aaa5aa3a02 100644 --- a/tests/mpi/p4est_data_out_01.cc +++ b/tests/mpi/p4est_data_out_01.cc @@ -75,7 +75,7 @@ test() data_out.build_patches(); std::vector n_locally_owned_dofs_per_processor = - dofh.n_locally_owned_dofs_per_processor(); + dofh.compute_n_locally_owned_dofs_per_processor(); if (myid == 0) { for (unsigned int i = 0; i < n_locally_owned_dofs_per_processor.size(); diff --git a/tests/mpi/p4est_get_subdomain_association.cc b/tests/mpi/p4est_get_subdomain_association.cc index 59c4592f00..73d4485a44 100644 --- a/tests/mpi/p4est_get_subdomain_association.cc +++ b/tests/mpi/p4est_get_subdomain_association.cc @@ -61,7 +61,7 @@ test() const std::vector n_locally_owned_dofs_per_processor = - dofh.n_locally_owned_dofs_per_processor(); + dofh.compute_n_locally_owned_dofs_per_processor(); if (myid == 1) { deallog << "dofh.n_dofs() " << n_locally_owned_dofs_per_processor diff --git a/tests/mpi/periodicity_01.cc b/tests/mpi/periodicity_01.cc index ca8807bd7c..7679f5a655 100644 --- a/tests/mpi/periodicity_01.cc +++ b/tests/mpi/periodicity_01.cc @@ -168,7 +168,7 @@ namespace Step40 constraints.close(); const std::vector &locally_owned_dofs = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet locally_active_dofs; DoFTools::extract_locally_active_dofs(dof_handler, locally_active_dofs); AssertThrow(constraints.is_consistent_in_parallel(locally_owned_dofs, @@ -183,14 +183,15 @@ namespace Step40 DoFTools::make_sparsity_pattern(dof_handler, csp, constraints, false); SparsityTools::distribute_sparsity_pattern( csp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), mpi_communicator, locally_relevant_dofs); - system_matrix.reinit(mpi_communicator, - csp, - dof_handler.n_locally_owned_dofs_per_processor(), - dof_handler.n_locally_owned_dofs_per_processor(), - Utilities::MPI::this_mpi_process(mpi_communicator)); + system_matrix.reinit( + mpi_communicator, + csp, + dof_handler.compute_n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), + Utilities::MPI::this_mpi_process(mpi_communicator)); } template diff --git a/tests/mpi/periodicity_02.cc b/tests/mpi/periodicity_02.cc index e05879c552..a817b1e935 100644 --- a/tests/mpi/periodicity_02.cc +++ b/tests/mpi/periodicity_02.cc @@ -398,7 +398,7 @@ namespace Step22 constraints.close(); const std::vector &locally_owned_dofs = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet locally_active_dofs; DoFTools::extract_locally_active_dofs(dof_handler, locally_active_dofs); AssertThrow(constraints.is_consistent_in_parallel(locally_owned_dofs, diff --git a/tests/mpi/periodicity_03.cc b/tests/mpi/periodicity_03.cc index 7ac8b025d3..508f817c4e 100644 --- a/tests/mpi/periodicity_03.cc +++ b/tests/mpi/periodicity_03.cc @@ -328,7 +328,7 @@ namespace Step22 constraints.close(); const std::vector &locally_owned_dofs = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet locally_active_dofs; DoFTools::extract_locally_active_dofs(dof_handler, locally_active_dofs); AssertThrow(constraints.is_consistent_in_parallel(locally_owned_dofs, diff --git a/tests/mpi/periodicity_04.cc b/tests/mpi/periodicity_04.cc index bf5530f694..501fdab10d 100644 --- a/tests/mpi/periodicity_04.cc +++ b/tests/mpi/periodicity_04.cc @@ -206,7 +206,7 @@ check(const unsigned int orientation, bool reverse) constraints.print(deallog.get_file_stream()); const std::vector locally_owned_dofs_vector = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet locally_active_dofs; DoFTools::extract_locally_active_dofs(dof_handler, locally_active_dofs); AssertThrow(constraints.is_consistent_in_parallel(locally_owned_dofs_vector, diff --git a/tests/mpi/periodicity_06.cc b/tests/mpi/periodicity_06.cc index c8dd563a06..9c4b960eca 100644 --- a/tests/mpi/periodicity_06.cc +++ b/tests/mpi/periodicity_06.cc @@ -188,7 +188,7 @@ test(const unsigned numRefinementLevels = 2) constraints.close(); const std::vector &locally_owned_dofs = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet locally_active_dofs; DoFTools::extract_locally_active_dofs(dof_handler, locally_active_dofs); AssertThrow(constraints.is_consistent_in_parallel(locally_owned_dofs, diff --git a/tests/mpi/periodicity_07.cc b/tests/mpi/periodicity_07.cc index 59ec485f07..d7d0cc47fe 100644 --- a/tests/mpi/periodicity_07.cc +++ b/tests/mpi/periodicity_07.cc @@ -139,7 +139,7 @@ test(const unsigned numRefinementLevels = 2) DoFTools::extract_locally_active_dofs(dof_handler, locally_active_dofs); const std::vector locally_owned_dofs = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); std::map> supportPoints; DoFTools::map_dofs_to_support_points(MappingQ1(), diff --git a/tests/mpi/renumber_cuthill_mckee.cc b/tests/mpi/renumber_cuthill_mckee.cc index 2abff36a13..4bc6810960 100644 --- a/tests/mpi/renumber_cuthill_mckee.cc +++ b/tests/mpi/renumber_cuthill_mckee.cc @@ -76,7 +76,7 @@ test() complete_renumbering.begin()); unsigned int offset = renumbering.size(); const std::vector dofs_per_proc = - dofh.locally_owned_dofs_per_processor(); + dofh.compute_locally_owned_dofs_per_processor(); for (unsigned int i = 1; i < nprocs; ++i) { if (myid == i) diff --git a/tests/mpi/renumber_cuthill_mckee_02.cc b/tests/mpi/renumber_cuthill_mckee_02.cc index 3763ffb7c1..29ab2a870c 100644 --- a/tests/mpi/renumber_cuthill_mckee_02.cc +++ b/tests/mpi/renumber_cuthill_mckee_02.cc @@ -79,7 +79,7 @@ test() complete_renumbering.begin()); unsigned int offset = renumbering.size(); const std::vector locally_owned_dofs_per_processor = - dofh.locally_owned_dofs_per_processor(); + dofh.compute_locally_owned_dofs_per_processor(); for (unsigned int i = 1; i < nprocs; ++i) { if (myid == i) diff --git a/tests/mpi/step-40.cc b/tests/mpi/step-40.cc index c79c9c7f57..6253d4b7a5 100644 --- a/tests/mpi/step-40.cc +++ b/tests/mpi/step-40.cc @@ -157,14 +157,15 @@ namespace Step40 DoFTools::make_sparsity_pattern(dof_handler, csp, constraints, false); SparsityTools::distribute_sparsity_pattern( csp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), mpi_communicator, locally_relevant_dofs); - system_matrix.reinit(mpi_communicator, - csp, - dof_handler.n_locally_owned_dofs_per_processor(), - dof_handler.n_locally_owned_dofs_per_processor(), - Utilities::MPI::this_mpi_process(mpi_communicator)); + system_matrix.reinit( + mpi_communicator, + csp, + dof_handler.compute_n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), + Utilities::MPI::this_mpi_process(mpi_communicator)); } @@ -326,7 +327,8 @@ namespace Step40 for (unsigned int i = 0; i < Utilities::MPI::n_mpi_processes(mpi_communicator); ++i) - pcout << dof_handler.n_locally_owned_dofs_per_processor()[i] << '+'; + pcout << dof_handler.compute_n_locally_owned_dofs_per_processor()[i] + << '+'; pcout << std::endl; assemble_system(); diff --git a/tests/mpi/step-40_cuthill_mckee.cc b/tests/mpi/step-40_cuthill_mckee.cc index d591f17ac0..5225ccaaa3 100644 --- a/tests/mpi/step-40_cuthill_mckee.cc +++ b/tests/mpi/step-40_cuthill_mckee.cc @@ -221,14 +221,15 @@ namespace Step40 DoFTools::make_sparsity_pattern(dof_handler, csp, constraints, false); SparsityTools::distribute_sparsity_pattern( csp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), mpi_communicator, locally_relevant_dofs); - system_matrix.reinit(mpi_communicator, - csp, - dof_handler.n_locally_owned_dofs_per_processor(), - dof_handler.n_locally_owned_dofs_per_processor(), - Utilities::MPI::this_mpi_process(mpi_communicator)); + system_matrix.reinit( + mpi_communicator, + csp, + dof_handler.compute_n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), + Utilities::MPI::this_mpi_process(mpi_communicator)); } @@ -390,7 +391,8 @@ namespace Step40 for (unsigned int i = 0; i < Utilities::MPI::n_mpi_processes(mpi_communicator); ++i) - pcout << dof_handler.n_locally_owned_dofs_per_processor()[i] << '+'; + pcout << dof_handler.compute_n_locally_owned_dofs_per_processor()[i] + << '+'; pcout << std::endl; assemble_system(); diff --git a/tests/mpi/step-40_cuthill_mckee_MPI-subset.cc b/tests/mpi/step-40_cuthill_mckee_MPI-subset.cc index a45c9dd935..b658255126 100644 --- a/tests/mpi/step-40_cuthill_mckee_MPI-subset.cc +++ b/tests/mpi/step-40_cuthill_mckee_MPI-subset.cc @@ -222,14 +222,15 @@ namespace Step40 DoFTools::make_sparsity_pattern(dof_handler, csp, constraints, false); SparsityTools::distribute_sparsity_pattern( csp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), mpi_communicator, locally_relevant_dofs); - system_matrix.reinit(mpi_communicator, - csp, - dof_handler.n_locally_owned_dofs_per_processor(), - dof_handler.n_locally_owned_dofs_per_processor(), - Utilities::MPI::this_mpi_process(mpi_communicator)); + system_matrix.reinit( + mpi_communicator, + csp, + dof_handler.compute_n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), + Utilities::MPI::this_mpi_process(mpi_communicator)); } @@ -390,7 +391,7 @@ namespace Step40 << " "; const std::vector n_locally_owned_dofs_per_processor = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); for (unsigned int i = 0; i < Utilities::MPI::n_mpi_processes(mpi_communicator); ++i) diff --git a/tests/mpi/step-40_direct_solver.cc b/tests/mpi/step-40_direct_solver.cc index 6c659d9a99..6b80fca5c7 100644 --- a/tests/mpi/step-40_direct_solver.cc +++ b/tests/mpi/step-40_direct_solver.cc @@ -157,14 +157,15 @@ namespace Step40 DoFTools::make_sparsity_pattern(dof_handler, csp, constraints, false); SparsityTools::distribute_sparsity_pattern( csp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), mpi_communicator, locally_relevant_dofs); - system_matrix.reinit(mpi_communicator, - csp, - dof_handler.n_locally_owned_dofs_per_processor(), - dof_handler.n_locally_owned_dofs_per_processor(), - Utilities::MPI::this_mpi_process(mpi_communicator)); + system_matrix.reinit( + mpi_communicator, + csp, + dof_handler.compute_n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), + Utilities::MPI::this_mpi_process(mpi_communicator)); } @@ -304,7 +305,8 @@ namespace Step40 for (unsigned int i = 0; i < Utilities::MPI::n_mpi_processes(mpi_communicator); ++i) - pcout << dof_handler.n_locally_owned_dofs_per_processor()[i] << '+'; + pcout << dof_handler.compute_n_locally_owned_dofs_per_processor()[i] + << '+'; pcout << std::endl; assemble_system(); diff --git a/tests/petsc_complex/parallel_sparse_matrix_01.cc b/tests/petsc_complex/parallel_sparse_matrix_01.cc index 9791abc2e4..c2992c9657 100644 --- a/tests/petsc_complex/parallel_sparse_matrix_01.cc +++ b/tests/petsc_complex/parallel_sparse_matrix_01.cc @@ -94,7 +94,7 @@ test(const unsigned int poly_degree = 1) DoFTools::make_sparsity_pattern(dof_handler, dsp, constraints, false); SparsityTools::distribute_sparsity_pattern( dsp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), mpi_communicator, locally_relevant_dofs); diff --git a/tests/physics/step-18-rotation_matrix.cc b/tests/physics/step-18-rotation_matrix.cc index 064af3b5fc..94258ef85e 100644 --- a/tests/physics/step-18-rotation_matrix.cc +++ b/tests/physics/step-18-rotation_matrix.cc @@ -358,7 +358,8 @@ namespace Step18 DoFTools::extract_locally_relevant_dofs(dof_handler, locally_relevant_dofs); n_local_cells = GridTools::count_cells_with_subdomain_association( triangulation, triangulation.locally_owned_subdomain()); - local_dofs_per_process = dof_handler.n_locally_owned_dofs_per_processor(); + local_dofs_per_process = + dof_handler.compute_n_locally_owned_dofs_per_processor(); hanging_node_constraints.clear(); DoFTools::make_hanging_node_constraints(dof_handler, hanging_node_constraints); diff --git a/tests/physics/step-18.cc b/tests/physics/step-18.cc index 9dc49fec08..7c491414f3 100644 --- a/tests/physics/step-18.cc +++ b/tests/physics/step-18.cc @@ -374,7 +374,8 @@ namespace Step18 DoFTools::extract_locally_relevant_dofs(dof_handler, locally_relevant_dofs); n_local_cells = GridTools::count_cells_with_subdomain_association( triangulation, triangulation.locally_owned_subdomain()); - local_dofs_per_process = dof_handler.n_locally_owned_dofs_per_processor(); + local_dofs_per_process = + dof_handler.compute_n_locally_owned_dofs_per_processor(); hanging_node_constraints.clear(); DoFTools::make_hanging_node_constraints(dof_handler, hanging_node_constraints); diff --git a/tests/sharedtria/dof_01.cc b/tests/sharedtria/dof_01.cc index 23ffe7e3b6..a1a7fd2d37 100644 --- a/tests/sharedtria/dof_01.cc +++ b/tests/sharedtria/dof_01.cc @@ -106,8 +106,9 @@ test() // deallog << "n_locally_owned_dofs_per_processor: "; // std::vector v = - // dof_handler.n_locally_owned_dofs_per_processor(); unsigned int sum - // = 0; for (unsigned int i=0; i n_locally_owned_dofs_per_processor = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); Assert(dof_handler.n_locally_owned_dofs() == n_locally_owned_dofs_per_processor[triangulation .locally_owned_subdomain()], @@ -134,7 +135,7 @@ test() ExcInternalError()); const std::vector locally_owned_dofs_per_processor = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet all(N); for (unsigned int i = 0; i < locally_owned_dofs_per_processor.size(); ++i) { diff --git a/tests/sharedtria/dof_02.cc b/tests/sharedtria/dof_02.cc index 44841b3736..de3b9d271a 100644 --- a/tests/sharedtria/dof_02.cc +++ b/tests/sharedtria/dof_02.cc @@ -106,8 +106,9 @@ test() // // deallog << "n_locally_owned_dofs_per_processor: "; // std::vector v = - // dof_handler.n_locally_owned_dofs_per_processor(); unsigned int sum - // = 0; for (unsigned int i=0; i n_locally_owned_dofs_per_processor = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); Assert(dof_handler.n_locally_owned_dofs() == n_locally_owned_dofs_per_processor[triangulation .locally_owned_subdomain()], @@ -134,7 +135,7 @@ test() ExcInternalError()); const std::vector locally_owned_dofs_per_processor = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet all(N); for (unsigned int i = 0; i < locally_owned_dofs_per_processor.size(); ++i) { diff --git a/tests/sharedtria/dof_03.cc b/tests/sharedtria/dof_03.cc index 775366e5d4..58618ed41d 100644 --- a/tests/sharedtria/dof_03.cc +++ b/tests/sharedtria/dof_03.cc @@ -104,8 +104,9 @@ test() // // deallog << "n_locally_owned_dofs_per_processor: "; // std::vector v = - // dof_handler.n_locally_owned_dofs_per_processor(); unsigned int sum - // = 0; for (unsigned int i=0; i n_locally_owned_dofs_per_processor = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); Assert(dof_handler.n_locally_owned_dofs() == n_locally_owned_dofs_per_processor[triangulation .locally_owned_subdomain()], @@ -132,7 +133,7 @@ test() ExcInternalError()); const std::vector locally_owned_dofs_per_processor = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet all(N); for (unsigned int i = 0; i < locally_owned_dofs_per_processor.size(); ++i) { diff --git a/tests/sharedtria/dof_04.cc b/tests/sharedtria/dof_04.cc index fb5386ea77..d74b1c795b 100644 --- a/tests/sharedtria/dof_04.cc +++ b/tests/sharedtria/dof_04.cc @@ -106,8 +106,9 @@ test() // // deallog << "n_locally_owned_dofs_per_processor: "; // std::vector v = - // dof_handler.n_locally_owned_dofs_per_processor(); unsigned int sum - // = 0; for (unsigned int i=0; i n_locally_owned_dofs_per_processor = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); Assert(dof_handler.n_locally_owned_dofs() == n_locally_owned_dofs_per_processor[triangulation .locally_owned_subdomain()], @@ -134,7 +135,7 @@ test() ExcInternalError()); const std::vector locally_owned_dofs_per_processor = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet all(N); for (unsigned int i = 0; i < locally_owned_dofs_per_processor.size(); ++i) { diff --git a/tests/sharedtria/dof_05.cc b/tests/sharedtria/dof_05.cc index 25a784fc25..ddd7d7a568 100644 --- a/tests/sharedtria/dof_05.cc +++ b/tests/sharedtria/dof_05.cc @@ -57,9 +57,9 @@ compare_meshes(DoFHandler &shared_dof_handler, shared_dofs.print(deallog.get_file_stream()); std::vector shared_dofs_per_proc = - shared_dof_handler.locally_owned_dofs_per_processor(); + shared_dof_handler.compute_locally_owned_dofs_per_processor(); std::vector distributed_dofs_per_proc = - distributed_dof_handler.locally_owned_dofs_per_processor(); + distributed_dof_handler.compute_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], diff --git a/tests/sharedtria/dof_06.cc b/tests/sharedtria/dof_06.cc index ad7f2c0cd1..715b4b6d07 100644 --- a/tests/sharedtria/dof_06.cc +++ b/tests/sharedtria/dof_06.cc @@ -73,7 +73,7 @@ test() << dof_handler.n_locally_owned_dofs() << std::endl; std::vector shared_dofs_per_proc = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_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()); diff --git a/tests/sharedtria/hp_dof_01.cc b/tests/sharedtria/hp_dof_01.cc index 1c255bad18..45539023d1 100644 --- a/tests/sharedtria/hp_dof_01.cc +++ b/tests/sharedtria/hp_dof_01.cc @@ -111,8 +111,9 @@ test() // deallog << "n_locally_owned_dofs_per_processor: "; // std::vector v = - // dof_handler.n_locally_owned_dofs_per_processor(); unsigned int sum - // = 0; for (unsigned int i=0; i n_locally_owned_dofs_per_processor = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); Assert(dof_handler.n_locally_owned_dofs() == n_locally_owned_dofs_per_processor[triangulation .locally_owned_subdomain()], @@ -139,7 +140,7 @@ test() ExcInternalError()); const std::vector locally_owned_dofs_per_processor = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet all(N); for (unsigned int i = 0; i < locally_owned_dofs_per_processor.size(); ++i) { diff --git a/tests/sharedtria/hp_dof_02.cc b/tests/sharedtria/hp_dof_02.cc index 4a61490820..6aaee1de86 100644 --- a/tests/sharedtria/hp_dof_02.cc +++ b/tests/sharedtria/hp_dof_02.cc @@ -112,8 +112,9 @@ test() // // deallog << "n_locally_owned_dofs_per_processor: "; // std::vector v = - // dof_handler.n_locally_owned_dofs_per_processor(); unsigned int sum - // = 0; for (unsigned int i=0; i n_locally_owned_dofs_per_processor = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); Assert(dof_handler.n_locally_owned_dofs() == n_locally_owned_dofs_per_processor[triangulation .locally_owned_subdomain()], @@ -140,7 +141,7 @@ test() ExcInternalError()); const std::vector locally_owned_dofs_per_processor = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet all(N); for (unsigned int i = 0; i < locally_owned_dofs_per_processor.size(); ++i) { diff --git a/tests/sharedtria/hp_dof_03.cc b/tests/sharedtria/hp_dof_03.cc index 87bf7379b8..a410b009e5 100644 --- a/tests/sharedtria/hp_dof_03.cc +++ b/tests/sharedtria/hp_dof_03.cc @@ -109,8 +109,9 @@ test() // // deallog << "n_locally_owned_dofs_per_processor: "; // std::vector v = - // dof_handler.n_locally_owned_dofs_per_processor(); unsigned int sum - // = 0; for (unsigned int i=0; i n_locally_owned_dofs_per_processor = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); Assert(dof_handler.n_locally_owned_dofs() == n_locally_owned_dofs_per_processor[triangulation .locally_owned_subdomain()], @@ -137,7 +138,7 @@ test() ExcInternalError()); const std::vector locally_owned_dofs_per_processor = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet all(N); for (unsigned int i = 0; i < locally_owned_dofs_per_processor.size(); ++i) { diff --git a/tests/sharedtria/hp_dof_04.cc b/tests/sharedtria/hp_dof_04.cc index e37e13d7ef..7c56973b12 100644 --- a/tests/sharedtria/hp_dof_04.cc +++ b/tests/sharedtria/hp_dof_04.cc @@ -112,8 +112,9 @@ test() // // deallog << "n_locally_owned_dofs_per_processor: "; // std::vector v = - // dof_handler.n_locally_owned_dofs_per_processor(); unsigned int sum - // = 0; for (unsigned int i=0; i n_locally_owned_dofs_per_processor = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); Assert(dof_handler.n_locally_owned_dofs() == n_locally_owned_dofs_per_processor[triangulation .locally_owned_subdomain()], @@ -140,7 +141,7 @@ test() ExcInternalError()); const std::vector locally_owned_dofs_per_processor = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet all(N); for (unsigned int i = 0; i < locally_owned_dofs_per_processor.size(); ++i) { diff --git a/tests/sharedtria/hp_no_cells_01.cc b/tests/sharedtria/hp_no_cells_01.cc index 5eee549c6d..a2ec552783 100644 --- a/tests/sharedtria/hp_no_cells_01.cc +++ b/tests/sharedtria/hp_no_cells_01.cc @@ -80,7 +80,7 @@ test() deallog << "n_locally_owned_dofs_per_processor: "; std::vector v = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); unsigned int sum = 0; for (unsigned int i = 0; i < v.size(); ++i) { @@ -105,7 +105,7 @@ test() Assert(std::accumulate(v.begin(), v.end(), 0U) == N, ExcInternalError()); std::vector locally_owned_dofs_per_processor = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet all(N); for (unsigned int i = 0; i < locally_owned_dofs_per_processor.size(); ++i) { diff --git a/tests/sharedtria/mg_dof_02.cc b/tests/sharedtria/mg_dof_02.cc index 9d753f29a7..83b6712eef 100644 --- a/tests/sharedtria/mg_dof_02.cc +++ b/tests/sharedtria/mg_dof_02.cc @@ -52,7 +52,7 @@ write_dof_data(DoFHandler &dof_handler) for (unsigned int lvl = 0; lvl < n_levels; ++lvl) { std::vector dof_index_per_proc = - dof_handler.locally_owned_mg_dofs_per_processor(lvl); + dof_handler.compute_locally_owned_mg_dofs_per_processor(lvl); for (unsigned int i = 0; i < dof_index_per_proc.size(); ++i) dof_index_per_proc[i].print(deallog); diff --git a/tests/sharedtria/no_cells_01.cc b/tests/sharedtria/no_cells_01.cc index 6087a92294..661c37e96e 100644 --- a/tests/sharedtria/no_cells_01.cc +++ b/tests/sharedtria/no_cells_01.cc @@ -74,7 +74,7 @@ test() deallog << "n_locally_owned_dofs_per_processor: "; const std::vector v = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); unsigned int sum = 0; for (unsigned int i = 0; i < v.size(); ++i) { @@ -87,7 +87,7 @@ test() deallog << std::endl; Assert(dof_handler.n_locally_owned_dofs() == - dof_handler.n_locally_owned_dofs_per_processor() + dof_handler.compute_n_locally_owned_dofs_per_processor() [triangulation.locally_owned_subdomain()], ExcInternalError()); Assert(dof_handler.n_locally_owned_dofs() == @@ -98,12 +98,12 @@ test() Assert(dof_handler.n_locally_owned_dofs() <= N, ExcInternalError()); const std::vector n_owned_dofs = - dof_handler.n_locally_owned_dofs_per_processor(); + dof_handler.compute_n_locally_owned_dofs_per_processor(); Assert(std::accumulate(n_owned_dofs.begin(), n_owned_dofs.end(), 0U) == N, ExcInternalError()); const std::vector owned_dofs = - dof_handler.locally_owned_dofs_per_processor(); + dof_handler.compute_locally_owned_dofs_per_processor(); IndexSet all(N); for (unsigned int i = 0; i < owned_dofs.size(); ++i) { diff --git a/tests/trilinos/direct_solver_2.cc b/tests/trilinos/direct_solver_2.cc index 0ec5c71105..74cd532974 100644 --- a/tests/trilinos/direct_solver_2.cc +++ b/tests/trilinos/direct_solver_2.cc @@ -203,7 +203,7 @@ Step4::setup_system() DoFTools::make_sparsity_pattern(dof_handler, dsp, constraints, false); SparsityTools::distribute_sparsity_pattern( dsp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, locally_relevant_dofs); diff --git a/tests/trilinos/direct_solver_3.cc b/tests/trilinos/direct_solver_3.cc index e4c44953c7..e4f4b336b6 100644 --- a/tests/trilinos/direct_solver_3.cc +++ b/tests/trilinos/direct_solver_3.cc @@ -165,7 +165,7 @@ Step4::setup_system() DoFTools::make_sparsity_pattern(dof_handler, dsp, constraints, false); SparsityTools::distribute_sparsity_pattern( dsp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, locally_relevant_dofs); diff --git a/tests/trilinos/elide_zeros.cc b/tests/trilinos/elide_zeros.cc index a93bacc239..b1f84bee96 100644 --- a/tests/trilinos/elide_zeros.cc +++ b/tests/trilinos/elide_zeros.cc @@ -173,7 +173,7 @@ namespace LinearAdvectionTest SparsityTools::distribute_sparsity_pattern( dynamic_sparsity_pattern, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, locally_relevant_dofs); diff --git a/tests/trilinos/renumbering_01.cc b/tests/trilinos/renumbering_01.cc index 7e2bed8179..d76bb28485 100644 --- a/tests/trilinos/renumbering_01.cc +++ b/tests/trilinos/renumbering_01.cc @@ -127,7 +127,7 @@ private: /*keep constrained dofs*/ false); SparsityTools::distribute_sparsity_pattern( sparsity_pattern, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), MPI_COMM_WORLD, locally_relevant_dofs); diff --git a/tests/trilinos/solver_control_06.cc b/tests/trilinos/solver_control_06.cc index 8af5b8e855..d1eecce171 100644 --- a/tests/trilinos/solver_control_06.cc +++ b/tests/trilinos/solver_control_06.cc @@ -220,7 +220,7 @@ Test_Solver_Output::setup_system() SparsityTools::distribute_sparsity_pattern( dsp, - dof_handler.n_locally_owned_dofs_per_processor(), + dof_handler.compute_n_locally_owned_dofs_per_processor(), mpi_comm, locally_relevant_dofs);