From 51e5f938f9916ec80ddade4f48d87f7093154e04 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Thu, 10 Dec 2015 09:52:18 -0600 Subject: [PATCH] Adjust testsuite. --- doc/news/changes.h | 11 +++++++++-- tests/bits/data_out_07.cc | 2 +- tests/bits/data_out_common.h | 2 +- tests/bits/dof_tools_06.cc | 2 +- tests/bits/dof_tools_13.cc | 2 +- tests/bits/dof_tools_13a.cc | 2 +- tests/bits/dof_tools_19.cc | 2 +- tests/bits/step-14.cc | 4 ++-- tests/codim_one/surface.cc | 2 +- tests/dofs/accessor_01.cc | 2 +- tests/dofs/accessor_02.cc | 2 +- tests/dofs/dof_renumbering.cc | 2 +- tests/dofs/dof_renumbering_02.cc | 4 ++-- tests/dofs/dof_renumbering_07.cc | 2 +- tests/fail/hp-step-14.cc | 4 ++-- tests/fail/rt_crash_01.cc | 2 +- tests/grid/grid_tools_halo_layer_04.cc | 2 +- tests/grid/grid_tools_halo_layer_05.cc | 2 +- tests/integrators/assembler_simple_mgmatrix_04.cc | 2 +- tests/integrators/cells_and_faces_01.cc | 4 ++-- tests/integrators/mesh_worker_02.cc | 2 +- tests/integrators/mesh_worker_03.cc | 2 +- tests/matrix_free/copy.cc | 2 +- tests/matrix_free/get_functions_common.h | 2 +- tests/matrix_free/get_functions_gl.cc | 2 +- tests/matrix_free/get_functions_mappingq.cc | 2 +- tests/matrix_free/get_functions_q_hierarchical.cc | 2 +- tests/matrix_free/get_functions_rect.cc | 2 +- tests/matrix_free/get_values_plain.cc | 2 +- tests/matrix_free/matrix_vector_15.cc | 2 +- tests/matrix_free/matrix_vector_16.cc | 2 +- tests/matrix_free/matrix_vector_common.h | 2 +- tests/matrix_free/matrix_vector_hp.cc | 2 +- tests/matrix_free/matrix_vector_mg.cc | 2 +- tests/matrix_free/no_index_initialize.cc | 2 +- tests/matrix_free/parallel_multigrid.cc | 10 +++++----- tests/matrix_free/thread_correctness.cc | 2 +- tests/matrix_free/thread_correctness_hp.cc | 2 +- tests/matrix_free/update_mapping_only.cc | 4 ++-- tests/multigrid/mg_output_dirichlet.cc | 4 ++-- tests/multigrid/mg_output_neumann.cc | 4 ++-- tests/multigrid/mg_renumbered_01.cc | 2 +- tests/multigrid/mg_renumbered_03.cc | 2 +- tests/multigrid/transfer_03.cc | 2 +- tests/multigrid/transfer_block.cc | 4 ++-- tests/multigrid/transfer_block_select.cc | 4 ++-- tests/multigrid/transfer_compare_01.cc | 6 +++--- tests/multigrid/transfer_select.cc | 2 +- tests/trilinos/mg_transfer_prebuilt_01.cc | 2 +- 49 files changed, 72 insertions(+), 65 deletions(-) diff --git a/doc/news/changes.h b/doc/news/changes.h index 44103108d1..a6215cb618 100644 --- a/doc/news/changes.h +++ b/doc/news/changes.h @@ -491,12 +491,19 @@ inconvenience this causes.
    -
  1. New: There is now a function Triangulation::get_tria() that +
  2. New: There is now a function Triangulation::get_triangulation() that allows writing code to get at the underlying triangulation for everything that looks like a container, i.e., both Triangulation or DoFHandler objects.
    - (Wolfgang Bangerth, 2015/12/07) + (Wolfgang Bangerth, 2015/12/10) +
  3. + +
  4. Deprecated: The functions DoFHandler::get_tria() and + hp::DoFHandler::get_tria() were deprecated. UseDoFHandler::get_triangulation() and + hp::DoFHandler::get_triangulation() instead. +
    + (Wolfgang Bangerth, 2015/12/10)
  5. Improved: Many more functions in namespace GridTools and class diff --git a/tests/bits/data_out_07.cc b/tests/bits/data_out_07.cc index b6f4c85e45..b70ca501bd 100644 --- a/tests/bits/data_out_07.cc +++ b/tests/bits/data_out_07.cc @@ -32,7 +32,7 @@ check_this (const DoFHandler &dof_handler, const Vector &v_cell) { DataOut data_out; - data_out.attach_triangulation (dof_handler.get_tria()); + data_out.attach_triangulation (dof_handler.get_triangulation()); data_out.add_data_vector (v_cell, "cell_data"); data_out.build_patches (); diff --git a/tests/bits/data_out_common.h b/tests/bits/data_out_common.h index a3ad763f09..d0b4d67130 100644 --- a/tests/bits/data_out_common.h +++ b/tests/bits/data_out_common.h @@ -90,7 +90,7 @@ check (const FiniteElement &fe, Vector v_node (dof_handler.n_dofs()); for (unsigned int i=0; i v_cell (dof_handler.get_tria().n_active_cells()); + Vector v_cell (dof_handler.get_triangulation().n_active_cells()); for (unsigned int i=0; i &dof_handler) { std::vector dofs(dof_handler.n_dofs()); - for (unsigned int level=0; level &dof_handler) if (dof_handler.get_fe().is_primitive() == false) return; - Vector cell_data (dof_handler.get_tria().n_active_cells()); + Vector cell_data (dof_handler.get_triangulation().n_active_cells()); for (unsigned int i=0; i &dof_handler) if (dof_handler.get_fe().is_primitive() == false) return; - Vector cell_data (dof_handler.get_tria().n_active_cells()); + Vector cell_data (dof_handler.get_triangulation().n_active_cells()); for (unsigned int i=0; i &dof_handler) cm.distribute (solution); // Evaluate error - Vector cellwise_errors (dof_handler.get_tria ().n_active_cells()); + Vector cellwise_errors (dof_handler.get_triangulation ().n_active_cells()); VectorTools::integrate_difference (dof_handler, solution, test_func, cellwise_errors, quadrature, VectorTools::L2_norm); diff --git a/tests/bits/step-14.cc b/tests/bits/step-14.cc index 6cfc93d259..d8fd7c46a2 100644 --- a/tests/bits/step-14.cc +++ b/tests/bits/step-14.cc @@ -265,7 +265,7 @@ namespace Evaluation << ".eps" << std::ends; - GridOut().write_eps (dof_handler.get_tria(), + GridOut().write_eps (dof_handler.get_triangulation(), deallog.get_file_stream()); } } @@ -1682,7 +1682,7 @@ namespace LaplaceSolver face_integrals[cell->face(face_no)] = -1e20; error_indicators.reinit (dual_solver.dof_handler - .get_tria().n_active_cells()); + .get_triangulation().n_active_cells()); const unsigned int n_threads = MultithreadInfo::n_threads(); for (unsigned int i=0; i void test_in_dim(const DoFHandlerType &d1, const DoFHandlerType &d2) { typename DoFHandlerType::active_cell_iterator a = d1.begin_active(); - typename DoFHandlerType::cell_iterator l = d1.begin(d1.get_tria().n_levels()-1); + typename DoFHandlerType::cell_iterator l = d1.begin(d1.get_triangulation().n_levels()-1); deallog << "a " << a << std::endl << "l " << l << std::endl; diff --git a/tests/dofs/accessor_02.cc b/tests/dofs/accessor_02.cc index a98e07760c..38c7d7ffed 100644 --- a/tests/dofs/accessor_02.cc +++ b/tests/dofs/accessor_02.cc @@ -44,7 +44,7 @@ template void test_in_dim(const DoFHandlerType &d1, const DoFHandlerType &d2) { typename DoFHandlerType::active_cell_iterator a = d1.begin_active(); - typename DoFHandlerType::cell_iterator l = d1.begin(d1.get_tria().n_levels()-1); + typename DoFHandlerType::cell_iterator l = d1.begin(d1.get_triangulation().n_levels()-1); deallog << "a " << a << std::endl << "l " << l << std::endl; diff --git a/tests/dofs/dof_renumbering.cc b/tests/dofs/dof_renumbering.cc index 6d232b223a..0eb632f4a7 100644 --- a/tests/dofs/dof_renumbering.cc +++ b/tests/dofs/dof_renumbering.cc @@ -116,7 +116,7 @@ check_renumbering(DoFHandler &mgdof, bool discontinuous) print_dofs (dof); // Check level ordering - for (unsigned int level=0; level &mgdof) DoFRenumbering::downstream(dof, direction); print_dofs (dof); // Check level ordering - for (unsigned int level=0; level &mgdof) DoFRenumbering::downstream(dof, direction, true); print_dofs (dof); // Check level ordering - for (unsigned int level=0; level &dof) deallog << element.get_name() << std::endl; DoFRenumbering::boost::Cuthill_McKee(dof); - for (unsigned int level=0; levelface(face_no)] = -1e20; error_indicators.reinit (dual_solver.dof_handler - .get_tria().n_active_cells()); + .get_triangulation().n_active_cells()); const unsigned int n_threads = MultithreadInfo::n_threads(); Threads::ThreadGroup<> threads; diff --git a/tests/fail/rt_crash_01.cc b/tests/fail/rt_crash_01.cc index 62298e8fc3..fd03f077a0 100644 --- a/tests/fail/rt_crash_01.cc +++ b/tests/fail/rt_crash_01.cc @@ -75,7 +75,7 @@ check_this (const DoFHandler &dof_handler) ExcInternalError()); // Evaluate error - Vector cellwise_errors (dof_handler.get_tria ().n_active_cells()); + Vector cellwise_errors (dof_handler.get_triangulation ().n_active_cells()); VectorTools::integrate_difference (dof_handler, solution, test_func, cellwise_errors, quadrature, VectorTools::L2_norm); diff --git a/tests/grid/grid_tools_halo_layer_04.cc b/tests/grid/grid_tools_halo_layer_04.cc index 7c80262942..7fdd45ab9f 100644 --- a/tests/grid/grid_tools_halo_layer_04.cc +++ b/tests/grid/grid_tools_halo_layer_04.cc @@ -46,7 +46,7 @@ template void write_vtk (const hp::DoFHandler &dof_handler, const std::string filename) { - Vector active_fe_index (dof_handler.get_tria().n_active_cells()); + Vector active_fe_index (dof_handler.get_triangulation().n_active_cells()); int count = 0; typename hp::DoFHandler::active_cell_iterator cell = dof_handler.begin_active(), diff --git a/tests/grid/grid_tools_halo_layer_05.cc b/tests/grid/grid_tools_halo_layer_05.cc index 6d5371d2bf..2f24712ee7 100644 --- a/tests/grid/grid_tools_halo_layer_05.cc +++ b/tests/grid/grid_tools_halo_layer_05.cc @@ -46,7 +46,7 @@ template void write_vtk (const hp::DoFHandler &dof_handler, const std::string filename) { - Vector active_fe_index (dof_handler.get_tria().n_active_cells()); + Vector active_fe_index (dof_handler.get_triangulation().n_active_cells()); int count = 0; typename hp::DoFHandler::active_cell_iterator cell = dof_handler.begin_active(), diff --git a/tests/integrators/assembler_simple_mgmatrix_04.cc b/tests/integrators/assembler_simple_mgmatrix_04.cc index 5b9bf0beed..b176553b93 100644 --- a/tests/integrators/assembler_simple_mgmatrix_04.cc +++ b/tests/integrators/assembler_simple_mgmatrix_04.cc @@ -132,7 +132,7 @@ void assemble_mg_matrix(DoFHandler &dof_handler, dof_handler.begin_mg(), dof_handler.end_mg(), dof_info, info_box, matrix_integrator, assembler); - const unsigned int nlevels = dof_handler.get_tria().n_levels(); + const unsigned int nlevels = dof_handler.get_triangulation().n_levels(); for (unsigned int level=0; level &mgdofs) BlockVector faces(n_functionals); for (unsigned int i=0; i &mgdofs) MGLevelObject > mg_matrix_dg_up; MGLevelObject > mg_matrix_dg_down; - const unsigned int n_levels = mgdofs.get_tria().n_levels(); + const unsigned int n_levels = mgdofs.get_triangulation().n_levels(); mg_sparsity.resize(0, n_levels-1); mg_sparsity_dg_interface.resize(0, n_levels-1); diff --git a/tests/integrators/mesh_worker_03.cc b/tests/integrators/mesh_worker_03.cc index 087c6ed028..77d5bfe5da 100644 --- a/tests/integrators/mesh_worker_03.cc +++ b/tests/integrators/mesh_worker_03.cc @@ -237,7 +237,7 @@ test_simple(DoFHandler &mgdofs) MGLevelObject > mg_matrix_dg_up; MGLevelObject > mg_matrix_dg_down; - const unsigned int n_levels = mgdofs.get_tria().n_levels(); + const unsigned int n_levels = mgdofs.get_triangulation().n_levels(); mg_sparsity.resize(0, n_levels-1); mg_sparsity_dg_interface.resize(0, n_levels-1); diff --git a/tests/matrix_free/copy.cc b/tests/matrix_free/copy.cc index 7a2ba0ade8..08ea2d414d 100644 --- a/tests/matrix_free/copy.cc +++ b/tests/matrix_free/copy.cc @@ -72,7 +72,7 @@ void sub_test() constraints); constraints.close(); - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl; + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl; diff --git a/tests/matrix_free/get_functions_common.h b/tests/matrix_free/get_functions_common.h index bf0aa20f75..a2b079eb81 100644 --- a/tests/matrix_free/get_functions_common.h +++ b/tests/matrix_free/get_functions_common.h @@ -218,7 +218,7 @@ void do_test (const DoFHandler &dof, { deallog << "Testing " << dof.get_fe().get_name() << std::endl; // use this for info on problem - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() // << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl; diff --git a/tests/matrix_free/get_functions_gl.cc b/tests/matrix_free/get_functions_gl.cc index e92c41660b..33e2245796 100644 --- a/tests/matrix_free/get_functions_gl.cc +++ b/tests/matrix_free/get_functions_gl.cc @@ -53,7 +53,7 @@ void test () constraints.close(); deallog << "Testing " << dof.get_fe().get_name() << std::endl; - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() // << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl; diff --git a/tests/matrix_free/get_functions_mappingq.cc b/tests/matrix_free/get_functions_mappingq.cc index b58f01ea66..488ea3cbf2 100644 --- a/tests/matrix_free/get_functions_mappingq.cc +++ b/tests/matrix_free/get_functions_mappingq.cc @@ -54,7 +54,7 @@ void test () // get_functions_common, but here we have to // manually choose another mapping deallog << "Testing " << dof.get_fe().get_name() << std::endl; - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() // << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl; diff --git a/tests/matrix_free/get_functions_q_hierarchical.cc b/tests/matrix_free/get_functions_q_hierarchical.cc index 9844e65459..3a8b3c2921 100644 --- a/tests/matrix_free/get_functions_q_hierarchical.cc +++ b/tests/matrix_free/get_functions_q_hierarchical.cc @@ -55,7 +55,7 @@ void test () constraints.close(); deallog << "Testing " << dof.get_fe().get_name() << std::endl; - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() // << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl; diff --git a/tests/matrix_free/get_functions_rect.cc b/tests/matrix_free/get_functions_rect.cc index 09b0223a86..d927ae4847 100644 --- a/tests/matrix_free/get_functions_rect.cc +++ b/tests/matrix_free/get_functions_rect.cc @@ -76,7 +76,7 @@ void test () // get_functions_common, but here we have to // manually choose non-rectangular tests. deallog << "Testing " << dof.get_fe().get_name() << std::endl; - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() // << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl; diff --git a/tests/matrix_free/get_values_plain.cc b/tests/matrix_free/get_values_plain.cc index b02597741f..11efbf3863 100644 --- a/tests/matrix_free/get_values_plain.cc +++ b/tests/matrix_free/get_values_plain.cc @@ -107,7 +107,7 @@ void do_test (const DoFHandler &dof, const ConstraintMatrix &constraints) { deallog << "Testing " << dof.get_fe().get_name() << std::endl; - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() // << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl; diff --git a/tests/matrix_free/matrix_vector_15.cc b/tests/matrix_free/matrix_vector_15.cc index 86fe0d6d4a..811d030f73 100644 --- a/tests/matrix_free/matrix_vector_15.cc +++ b/tests/matrix_free/matrix_vector_15.cc @@ -95,7 +95,7 @@ void do_test (const DoFHandler &dof, deallog << "Testing " << dof.get_fe().get_name() << std::endl; if (parallel_option > 0) deallog << "Parallel option: " << parallel_option << std::endl; - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl; + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl; diff --git a/tests/matrix_free/matrix_vector_16.cc b/tests/matrix_free/matrix_vector_16.cc index a375b50478..daae99c8c6 100644 --- a/tests/matrix_free/matrix_vector_16.cc +++ b/tests/matrix_free/matrix_vector_16.cc @@ -96,7 +96,7 @@ void do_test (const DoFHandler &dof, deallog << "Testing " << dof.get_fe().get_name() << std::endl; if (parallel_option > 0) deallog << "Parallel option: " << parallel_option << std::endl; - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl; + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl; diff --git a/tests/matrix_free/matrix_vector_common.h b/tests/matrix_free/matrix_vector_common.h index 31d3678ce6..f74e6e0c16 100644 --- a/tests/matrix_free/matrix_vector_common.h +++ b/tests/matrix_free/matrix_vector_common.h @@ -47,7 +47,7 @@ void do_test (const DoFHandler &dof, deallog << "Testing " << dof.get_fe().get_name() << std::endl; if (parallel_option > 0) deallog << "Parallel option: " << parallel_option << std::endl; - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl; + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl; diff --git a/tests/matrix_free/matrix_vector_hp.cc b/tests/matrix_free/matrix_vector_hp.cc index 7e3261f2db..f67b85d0f6 100644 --- a/tests/matrix_free/matrix_vector_hp.cc +++ b/tests/matrix_free/matrix_vector_hp.cc @@ -158,7 +158,7 @@ void test () sparsity.copy_from (csp); SparseMatrix system_matrix (sparsity); - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl; + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl; diff --git a/tests/matrix_free/matrix_vector_mg.cc b/tests/matrix_free/matrix_vector_mg.cc index 224b0de812..683a030cc4 100644 --- a/tests/matrix_free/matrix_vector_mg.cc +++ b/tests/matrix_free/matrix_vector_mg.cc @@ -53,7 +53,7 @@ void test () constraints); constraints.close (); - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl; + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; // set up MatrixFree diff --git a/tests/matrix_free/no_index_initialize.cc b/tests/matrix_free/no_index_initialize.cc index a753b01ba7..8a5434a73c 100644 --- a/tests/matrix_free/no_index_initialize.cc +++ b/tests/matrix_free/no_index_initialize.cc @@ -113,7 +113,7 @@ void do_test (const DoFHandler &dof, const ConstraintMatrix &constraints) { // use this for info on problem - //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() + //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() // << std::endl; //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl; //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl; diff --git a/tests/matrix_free/parallel_multigrid.cc b/tests/matrix_free/parallel_multigrid.cc index b45ffcbab9..41c13b2e4e 100644 --- a/tests/matrix_free/parallel_multigrid.cc +++ b/tests/matrix_free/parallel_multigrid.cc @@ -81,7 +81,7 @@ public: endc = dof_handler.end(level); for (; cell!=endc; ++cell) { - if (dof_handler.get_tria().locally_owned_subdomain()!=numbers::invalid_subdomain_id + if (dof_handler.get_triangulation().locally_owned_subdomain()!=numbers::invalid_subdomain_id && cell->level_subdomain_id()==numbers::artificial_subdomain_id) continue; const FiniteElement &fe = cell->get_fe(); @@ -339,8 +339,8 @@ void do_test (const DoFHandler &dof, typedef LaplaceOperator LevelMatrixType; MGLevelObject mg_matrices; - mg_matrices.resize(0, dof.get_tria().n_levels()-1); - for (unsigned int level = 0; level &dof, mg_smoother; MGLevelObject smoother_data; - smoother_data.resize(0, dof.get_tria().n_levels()-1); - for (unsigned int level = 0; level fe_sys(dof.get_fe(), dim); - DoFHandler dofh_eulerian(dof.get_tria()); + DoFHandler dofh_eulerian(dof.get_triangulation()); dofh_eulerian.distribute_dofs(fe_sys); MatrixFree mf_data; diff --git a/tests/multigrid/mg_output_dirichlet.cc b/tests/multigrid/mg_output_dirichlet.cc index 0c30454be5..b16fa4a71f 100644 --- a/tests/multigrid/mg_output_dirichlet.cc +++ b/tests/multigrid/mg_output_dirichlet.cc @@ -121,7 +121,7 @@ void initialize (const DoFHandler &dof, std::vector dof_indices(dofs_per_cell); std::vector face_indices(dofs_per_face); - for (unsigned int l=0; l::cell_iterator cell = dof.begin_mg(l); @@ -153,7 +153,7 @@ void print (const DoFHandler &dof, { const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - for (unsigned int l=0; l &dof, std::vector dof_indices(dofs_per_cell); std::vector face_indices(dofs_per_face); - for (unsigned int l=0; l::cell_iterator cell = dof.begin_mg(l); @@ -153,7 +153,7 @@ void print (const DoFHandler &dof, { const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - for (unsigned int l=0; l &dof, std::vector > &interfac { const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - for (unsigned int l=0; l &dof, std::vector > &interfac { const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - for (unsigned int l=0; l &dof, { const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - for (unsigned int l=0; l > - new_dofs(mg_dof.get_tria().n_levels(), + new_dofs(mg_dof.get_triangulation().n_levels(), std::vector(selected.size())); std::swap(ndofs, new_dofs); MGTools::count_dofs_per_block (mg_dof, ndofs); @@ -105,7 +105,7 @@ void check_block(const FiniteElement &fe, for (unsigned int l=0; l > mg_ndofs(mgdof.get_tria().n_levels(), + std::vector > mg_ndofs(mgdof.get_triangulation().n_levels(), std::vector(fe.n_blocks())); MGTools::count_dofs_per_block(mgdof, mg_ndofs); diff --git a/tests/multigrid/transfer_block_select.cc b/tests/multigrid/transfer_block_select.cc index 84567a374b..9c1a02f24e 100644 --- a/tests/multigrid/transfer_block_select.cc +++ b/tests/multigrid/transfer_block_select.cc @@ -57,7 +57,7 @@ reinit_vector_by_blocks ( if (ndofs.size() == 0) { std::vector > - new_dofs(mg_dof.get_tria().n_levels(), + new_dofs(mg_dof.get_triangulation().n_levels(), std::vector(selected.size())); std::swap(ndofs, new_dofs); MGTools::count_dofs_per_block (mg_dof, ndofs); @@ -91,7 +91,7 @@ void check_select(const FiniteElement &fe, unsigned int selected) for (unsigned int l=0; l > mg_ndofs(mgdof.get_tria().n_levels(), + std::vector > mg_ndofs(mgdof.get_triangulation().n_levels(), std::vector(fe.n_blocks())); MGTools::count_dofs_per_block(mgdof, mg_ndofs); diff --git a/tests/multigrid/transfer_compare_01.cc b/tests/multigrid/transfer_compare_01.cc index 98dad7ab9c..60d6b8b6f1 100644 --- a/tests/multigrid/transfer_compare_01.cc +++ b/tests/multigrid/transfer_compare_01.cc @@ -60,7 +60,7 @@ reinit_vector_by_blocks ( if (ndofs.size() == 0) { std::vector > - new_dofs(mg_dof.get_tria().n_levels(), + new_dofs(mg_dof.get_triangulation().n_levels(), std::vector(selected.size())); std::swap(ndofs, new_dofs); MGTools::count_dofs_per_block (mg_dof, ndofs); @@ -92,7 +92,7 @@ reinit_vector_by_blocks ( if (ndofs.size() == 0) { std::vector > - new_dofs(mg_dof.get_tria().n_levels(), + new_dofs(mg_dof.get_triangulation().n_levels(), std::vector(selected.size())); std::swap(ndofs, new_dofs); MGTools::count_dofs_per_block (mg_dof, ndofs); @@ -148,7 +148,7 @@ void check_block(const FiniteElement &fe) // Store sizes vector ndofs(fe.n_blocks()); DoFTools::count_dofs_per_block(mgdof, ndofs); - std::vector > mg_ndofs(mgdof.get_tria().n_levels(), + std::vector > mg_ndofs(mgdof.get_triangulation().n_levels(), std::vector(fe.n_blocks())); MGTools::count_dofs_per_block(mgdof, mg_ndofs); diff --git a/tests/multigrid/transfer_select.cc b/tests/multigrid/transfer_select.cc index 9e373785d4..fc3586ef31 100644 --- a/tests/multigrid/transfer_select.cc +++ b/tests/multigrid/transfer_select.cc @@ -67,7 +67,7 @@ void check_select(const FiniteElement &fe, for (unsigned int l=0; l > mg_ndofs(mgdof.get_tria().n_levels()); + std::vector > mg_ndofs(mgdof.get_triangulation().n_levels()); MGTools::count_dofs_per_component(mgdof, mg_ndofs, true, mg_target_component); deallog << "Global dofs:"; diff --git a/tests/trilinos/mg_transfer_prebuilt_01.cc b/tests/trilinos/mg_transfer_prebuilt_01.cc index 118f0030b3..45a152fc1b 100644 --- a/tests/trilinos/mg_transfer_prebuilt_01.cc +++ b/tests/trilinos/mg_transfer_prebuilt_01.cc @@ -45,7 +45,7 @@ reinit_vector (const dealii::DoFHandler &mg_dof, { const dealii::parallel::distributed::Triangulation *tria = (dynamic_cast*> - (&mg_dof.get_tria())); + (&mg_dof.get_triangulation())); AssertThrow(tria!=NULL, ExcMessage("multigrid with Trilinos vectors only works with distributed Triangulation!")); for (unsigned int level=v.min_level(); -- 2.39.5