diff --git a/examples/benchmarks_3D.cc b/examples/benchmarks_3D.cc index c420392e..4ae08298 100644 --- a/examples/benchmarks_3D.cc +++ b/examples/benchmarks_3D.cc @@ -52,7 +52,7 @@ class AgglomerationBenchmark public: AgglomerationBenchmark( - const GridType & grid_type = GridType::grid_generator, + const GridType &grid_type = GridType::grid_generator, const PartitionerType &partitioner_type = PartitionerType::rtree, const unsigned int extraction_level = 0, const unsigned int n_subdomains = 0); @@ -70,7 +70,7 @@ class AgglomerationBenchmark template AgglomerationBenchmark::AgglomerationBenchmark( - const GridType & grid_type, + const GridType &grid_type, const PartitionerType &partitioner_type, const unsigned int extraction_level, const unsigned int n_subdomains) diff --git a/examples/classical_dg_assembly.cc b/examples/classical_dg_assembly.cc index 3b392794..bd3a69d4 100644 --- a/examples/classical_dg_assembly.cc +++ b/examples/classical_dg_assembly.cc @@ -55,11 +55,11 @@ class Solution : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; virtual Tensor<1, dim> - gradient(const Point & p, + gradient(const Point &p, const unsigned int component = 0) const override; }; @@ -92,7 +92,7 @@ Solution::gradient(const Point &p, const unsigned int) const template void Solution::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -111,7 +111,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; }; @@ -119,7 +119,7 @@ class RightHandSide : public Function template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -260,7 +260,7 @@ Poisson::assemble_system() fe_values.reinit(cell); - const auto & q_points = fe_values.get_quadrature_points(); + const auto &q_points = fe_values.get_quadrature_points(); const unsigned int n_qpoints = q_points.size(); std::vector rhs(n_qpoints); rhs_function->value_list(q_points, rhs); diff --git a/examples/metrics.cc b/examples/metrics.cc index 2a39f3a9..401edd46 100644 --- a/examples/metrics.cc +++ b/examples/metrics.cc @@ -76,7 +76,7 @@ class Mesh public: - Mesh(const MeshType & grid_type = MeshType::square, + Mesh(const MeshType &grid_type = MeshType::square, const PartitionerType &partitioner_type = PartitionerType::rtree, const unsigned int = 0, const unsigned int = 0); @@ -92,7 +92,7 @@ class Mesh template -Mesh::Mesh(const MeshType & grid_type, +Mesh::Mesh(const MeshType &grid_type, const PartitionerType &partitioner_type, const unsigned int extraction_level, const unsigned int n_subdomains) @@ -115,19 +115,22 @@ Mesh::setup_agglomerated_grid() GridIn grid_in; switch (grid_type) { - case MeshType::square: { + case MeshType::square: + { GridGenerator::hyper_cube(tria, 0., 1.); tria.refine_global(5); // 1024 std::cout << "Number of background cells: " << tria.n_active_cells() << std::endl; break; } - case MeshType::ball: { + case MeshType::ball: + { GridGenerator::hyper_ball(tria); tria.refine_global(6); // 20480 break; } - case MeshType::unstructured: { + case MeshType::unstructured: + { grid_in.attach_triangulation(tria); std::ifstream gmsh_file( "../../meshes/t3.msh"); // unstructured square [0,1]^2 @@ -227,7 +230,8 @@ Mesh::setup_agglomerated_grid() #endif } else if (partitioner_type == PartitionerType::no_partition) - {} + { + } else { Assert(false, ExcMessage("Wrong partitioning.")); diff --git a/examples/minimal_SIP.cc b/examples/minimal_SIP.cc index 468b22ae..1fc14f74 100644 --- a/examples/minimal_SIP.cc +++ b/examples/minimal_SIP.cc @@ -37,7 +37,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; }; @@ -45,7 +45,7 @@ class RightHandSide : public Function template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -391,7 +391,7 @@ Poisson::assemble_system() cell_rhs = 0; const auto &agglo_values = ah->reinit(polytope); - const auto & q_points = agglo_values.get_quadrature_points(); + const auto &q_points = agglo_values.get_quadrature_points(); const unsigned int n_qpoints = q_points.size(); std::vector rhs(n_qpoints); rhs_function->value_list(q_points, rhs); @@ -791,7 +791,7 @@ main(int argc, char *argv[]) << std::endl; Poisson standard_problem(false); standard_problem.run(); - const auto & standard_matrix = standard_problem.get_matrix(); + const auto &standard_matrix = standard_problem.get_matrix(); Poisson agglo_problem(true); agglo_problem.run(); const auto &agglo_matrix = agglo_problem.get_matrix(); diff --git a/include/agglomeration_accessor.h b/include/agglomeration_accessor.h index d7da73d2..58aaec70 100644 --- a/include/agglomeration_accessor.h +++ b/include/agglomeration_accessor.h @@ -186,7 +186,7 @@ class AgglomerationAccessor */ AgglomerationAccessor( const typename Triangulation::active_cell_iterator - & master_cell, + &master_cell, const AgglomerationHandler *ah); /** @@ -194,8 +194,8 @@ class AgglomerationAccessor */ AgglomerationAccessor( const typename Triangulation::active_cell_iterator &cell, - const CellId & cell_id, - const AgglomerationHandler * ah); + const CellId &cell_id, + const AgglomerationHandler *ah); /** * Default destructor. @@ -462,7 +462,7 @@ inline AgglomerationAccessor::AgglomerationAccessor() template inline AgglomerationAccessor::AgglomerationAccessor( const typename Triangulation::active_cell_iterator &cell, - const AgglomerationHandler * ah) + const AgglomerationHandler *ah) { handler = const_cast *>(ah); if (&(*handler->master_cells_container.end()) == std::addressof(cell)) @@ -486,7 +486,7 @@ inline AgglomerationAccessor::AgglomerationAccessor( template inline AgglomerationAccessor::AgglomerationAccessor( const typename Triangulation::active_cell_iterator &neigh_cell, - const CellId & master_cell_id, + const CellId &master_cell_id, const AgglomerationHandler *ah) { Assert(neigh_cell->is_ghost(), ExcInternalError()); @@ -695,7 +695,7 @@ template unsigned int AgglomerationAccessor::n_agglomerated_faces() const { - const auto & agglomeration = get_agglomerate(); + const auto &agglomeration = get_agglomerate(); unsigned int n_neighbors = 0; for (const auto &cell : agglomeration) n_neighbors += n_agglomerated_faces_per_cell(cell); diff --git a/include/agglomeration_iterator.h b/include/agglomeration_iterator.h index fcac0ebd..4fc12ab1 100644 --- a/include/agglomeration_iterator.h +++ b/include/agglomeration_iterator.h @@ -41,15 +41,15 @@ class AgglomerationIterator */ AgglomerationIterator( const typename Triangulation::active_cell_iterator &cell, - const AgglomerationHandler * handler); + const AgglomerationHandler *handler); /** * Same as above, needed for ghosted elements. */ AgglomerationIterator( const typename Triangulation::active_cell_iterator - & master_cell, - const CellId & cell_id, + &master_cell, + const CellId &cell_id, const AgglomerationHandler *handler); /** @@ -168,7 +168,7 @@ inline AgglomerationIterator::AgglomerationIterator() template inline AgglomerationIterator::AgglomerationIterator( const typename Triangulation::active_cell_iterator - & master_cell, + &master_cell, const AgglomerationHandler *handler) : accessor(master_cell, handler) {} @@ -176,8 +176,8 @@ inline AgglomerationIterator::AgglomerationIterator( template inline AgglomerationIterator::AgglomerationIterator( const typename Triangulation::active_cell_iterator - & master_cell, - const CellId & cell_id, + &master_cell, + const CellId &cell_id, const AgglomerationHandler *handler) : accessor(master_cell, cell_id, handler) {} @@ -255,7 +255,7 @@ inline AgglomerationIterator AgglomerationIterator::operator++(int) { AgglomerationIterator tmp(*this); - operator++(); + operator++(); return tmp; } @@ -277,7 +277,7 @@ inline AgglomerationIterator AgglomerationIterator::operator--(int) { AgglomerationIterator tmp(*this); - operator--(); + operator--(); return tmp; } diff --git a/include/poly_utils.h b/include/poly_utils.h index 45f62062..94ad5094 100644 --- a/include/poly_utils.h +++ b/include/poly_utils.h @@ -88,8 +88,8 @@ namespace dealii::PolyUtils::internal void get_face_connectivity_of_cells( const parallel::fullydistributed::Triangulation - & triangulation, - DynamicSparsityPattern & cell_connectivity, + &triangulation, + DynamicSparsityPattern &cell_connectivity, const std::vector locally_owned_cells) { cell_connectivity.reinit(triangulation.n_locally_owned_active_cells(), @@ -151,7 +151,7 @@ namespace dealii::PolyUtils unsigned int target_level, std::vector::value>::active_cell_iterator>> &boxes, - std::vector> & csr); + std::vector> &csr); /** @@ -231,11 +231,11 @@ namespace dealii::PolyUtils typename Box, typename Allocators> Rtree_visitor::Rtree_visitor( - const Translator & translator, + const Translator &translator, const unsigned int target_level, std::vector::value>::active_cell_iterator>> - & bb_in_boxes, + &bb_in_boxes, std::vector> &csr) : translator(translator) , level(0) @@ -393,7 +393,7 @@ namespace dealii::PolyUtils compute_h_orthogonal( const unsigned int face_index, const std::vector::active_face_iterator> - & polygon_boundary, + &polygon_boundary, const Tensor<1, dim> &deal_normal) { #ifdef DEAL_II_WITH_CGAL @@ -516,8 +516,8 @@ namespace dealii::PolyUtils void interpolate_to_fine_grid( const AgglomerationHandler &agglomeration_handler, - VectorType & dst, - const VectorType & src) + VectorType &dst, + const VectorType &src) { Assert((dim == spacedim), ExcNotImplemented()); Assert( @@ -700,7 +700,7 @@ namespace dealii::PolyUtils template void collect_cells_for_agglomeration( - const Triangulation & tria, + const Triangulation &tria, const std::vector &cell_idxs, std::vector::active_cell_iterator> &cells_to_be_agglomerated) @@ -912,7 +912,7 @@ namespace dealii::PolyUtils // box_ratio - const auto & agglo_values = ah.reinit(polytope); + const auto &agglo_values = ah.reinit(polytope); const double measure_element = std::accumulate(agglo_values.get_JxW_values().cbegin(), agglo_values.get_JxW_values().cend(), @@ -952,7 +952,7 @@ namespace dealii::PolyUtils void export_polygon_to_csv_file( const AgglomerationHandler &agglomeration_handler, - const std::string & filename) + const std::string &filename) { static_assert(dim == 2); // With 3D, Paraview is much better std::ofstream myfile; diff --git a/source/agglomeration_handler.cc b/source/agglomeration_handler.cc index d4f9138e..9daebd33 100644 --- a/source/agglomeration_handler.cc +++ b/source/agglomeration_handler.cc @@ -98,10 +98,10 @@ AgglomerationHandler::define_agglomerate( template void AgglomerationHandler::initialize_fe_values( - const Quadrature & cell_quadrature, - const UpdateFlags & flags, + const Quadrature &cell_quadrature, + const UpdateFlags &flags, const Quadrature &face_quadrature, - const UpdateFlags & face_flags) + const UpdateFlags &face_flags) { agglomeration_quad = cell_quadrature; agglomeration_flags = flags; @@ -192,7 +192,7 @@ AgglomerationHandler::initialize_agglomeration_data( template void AgglomerationHandler::create_bounding_box( - const AgglomerationContainer & polytope, + const AgglomerationContainer &polytope, const types::global_cell_index master_idx) { Assert(n_agglomerations > 0, @@ -443,7 +443,7 @@ AgglomerationHandler::agglomerated_quadrature( // Map back each point in real space by using the map associated to the // bounding box. std::vector> unit_points(vec_pts.size()); - const auto & bbox = + const auto &bbox = bboxes[master2polygon.at(master_cell->active_cell_index())]; unit_points.reserve(vec_pts.size()); @@ -592,12 +592,12 @@ AgglomerationHandler::reinit_interface( !neigh_polytope->is_locally_owned()), ExcInternalError()); - const auto & cell = polytope_in->as_dof_handler_iterator(agglo_dh); - const auto & bbox = bboxes[master2polygon.at(cell->active_cell_index())]; + const auto &cell = polytope_in->as_dof_handler_iterator(agglo_dh); + const auto &bbox = bboxes[master2polygon.at(cell->active_cell_index())]; const double bbox_measure = bbox.volume(); const unsigned int neigh_rank = neigh_polytope->subdomain_id(); - const CellId & neigh_id = neigh_polytope->id(); + const CellId &neigh_id = neigh_polytope->id(); // Retrieve qpoints,JxWs, normals sent previously from the neighboring // rank. @@ -661,7 +661,7 @@ template template void AgglomerationHandler::create_agglomeration_sparsity_pattern( - DynamicSparsityPattern & dsp, + DynamicSparsityPattern &dsp, const AffineConstraints constraints, const bool keep_constrained_dofs, const types::subdomain_id subdomain_id) @@ -805,7 +805,7 @@ namespace dealii const typename DoFHandler::active_cell_iterator &cell, const unsigned int face_index, std::unique_ptr> - & agglo_isv_ptr, + &agglo_isv_ptr, const AgglomerationHandler &handler) { Assert(handler.is_master_cell(cell), @@ -915,7 +915,7 @@ namespace dealii static void setup_master_neighbor_connectivity( const typename Triangulation::active_cell_iterator - & master_cell, + &master_cell, const AgglomerationHandler &handler) { Assert(handler.master_slave_relationships @@ -1031,8 +1031,8 @@ namespace dealii .visited_cell_and_faces)) { handler.polytope_cache - .interface[{current_polytope_id, - neighbor_polytope_id}] + .interface[{ + current_polytope_id, neighbor_polytope_id}] .emplace_back(cell, f); handler.polytope_cache.visited_cell_and_faces @@ -1046,8 +1046,8 @@ namespace dealii .visited_cell_and_faces)) { handler.polytope_cache - .interface[{neighbor_polytope_id, - current_polytope_id}] + .interface[{ + neighbor_polytope_id, current_polytope_id}] .emplace_back(neighboring_cell, nof); handler.polytope_cache.visited_cell_and_faces @@ -1098,8 +1098,8 @@ namespace dealii .visited_cell_and_faces)) { handler.polytope_cache - .interface[{current_polytope_id, - neighbor_polytope_id}] + .interface[{ + current_polytope_id, neighbor_polytope_id}] .emplace_back(cell, f); handler.polytope_cache.visited_cell_and_faces @@ -1112,8 +1112,8 @@ namespace dealii .visited_cell_and_faces)) { handler.polytope_cache - .interface[{neighbor_polytope_id, - current_polytope_id}] + .interface[{ + neighbor_polytope_id, current_polytope_id}] .emplace_back(neighboring_cell, nof); handler.polytope_cache.visited_cell_and_faces @@ -1191,8 +1191,8 @@ namespace dealii handler.polytope_cache.visited_cell_and_faces_id)) { handler.polytope_cache - .interface[{current_polytope_id, - check_neigh_polytope_id}] + .interface[{ + current_polytope_id, check_neigh_polytope_id}] .emplace_back(cell, f); // std::cout << "ADDED (" @@ -1213,8 +1213,8 @@ namespace dealii handler.polytope_cache.visited_cell_and_faces_id)) { handler.polytope_cache - .interface[{check_neigh_polytope_id, - current_polytope_id}] + .interface[{ + check_neigh_polytope_id, current_polytope_id}] .emplace_back(neighboring_cell, nof); handler.polytope_cache.visited_cell_and_faces_id @@ -1271,7 +1271,8 @@ namespace dealii std::end(handler.polytope_cache.visited_cell_and_faces)) { handler.polytope_cache - .interface[{current_polytope_id, current_polytope_id}] + .interface[{ + current_polytope_id, current_polytope_id}] .emplace_back(cell, f); handler.polytope_cache.visited_cell_and_faces.insert( @@ -1321,7 +1322,7 @@ namespace dealii template class AgglomerationHandler<1>; template void AgglomerationHandler<1>::create_agglomeration_sparsity_pattern( - DynamicSparsityPattern & sparsity_pattern, + DynamicSparsityPattern &sparsity_pattern, const AffineConstraints constraints, const bool keep_constrained_dofs, const types::subdomain_id subdomain_id); @@ -1329,7 +1330,7 @@ AgglomerationHandler<1>::create_agglomeration_sparsity_pattern( template class AgglomerationHandler<2>; template void AgglomerationHandler<2>::create_agglomeration_sparsity_pattern( - DynamicSparsityPattern & sparsity_pattern, + DynamicSparsityPattern &sparsity_pattern, const AffineConstraints constraints, const bool keep_constrained_dofs, const types::subdomain_id subdomain_id); @@ -1337,7 +1338,7 @@ AgglomerationHandler<2>::create_agglomeration_sparsity_pattern( template class AgglomerationHandler<3>; template void AgglomerationHandler<3>::create_agglomeration_sparsity_pattern( - DynamicSparsityPattern & sparsity_pattern, + DynamicSparsityPattern &sparsity_pattern, const AffineConstraints constraints, const bool keep_constrained_dofs, const types::subdomain_id subdomain_id); diff --git a/source/assembly_check.cc b/source/assembly_check.cc index 0523fc58..d73a2a5c 100644 --- a/source/assembly_check.cc +++ b/source/assembly_check.cc @@ -21,7 +21,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; }; @@ -29,7 +29,7 @@ class RightHandSide : public Function template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -49,8 +49,8 @@ class Poisson setup_agglomeration(); void distribute_jumps_and_averages( - FEFaceValues & fe_face, - FEFaceValues & fe_face1, + FEFaceValues &fe_face, + FEFaceValues &fe_face1, const typename DoFHandler::active_cell_iterator &cell, const unsigned int f); void @@ -173,8 +173,8 @@ Poisson::setup_agglomeration() template void Poisson::distribute_jumps_and_averages( - FEFaceValues & fe_face, - FEFaceValues & fe_face1, + FEFaceValues &fe_face, + FEFaceValues &fe_face1, const typename DoFHandler::active_cell_iterator &cell, const unsigned int f) { @@ -556,7 +556,7 @@ Poisson::assemble_system() // const auto &agglo_values = ah->reinit(cell); fe_values.reinit(cell); - const auto & q_points = fe_values.get_quadrature_points(); + const auto &q_points = fe_values.get_quadrature_points(); const unsigned int n_qpoints = q_points.size(); std::vector rhs(n_qpoints); rhs_function->value_list(q_points, rhs); diff --git a/test/polydeal/3DRtree.cc b/test/polydeal/3DRtree.cc index f9f64fbd..786bba88 100644 --- a/test/polydeal/3DRtree.cc +++ b/test/polydeal/3DRtree.cc @@ -53,7 +53,7 @@ class Poisson std::unique_ptr> rhs_function; public: - Poisson(const GridType & grid_type = GridType::grid_generator, + Poisson(const GridType &grid_type = GridType::grid_generator, const PartitionerType &partitioner_type = PartitionerType::rtree, const unsigned int = 0, const unsigned int = 0, @@ -71,7 +71,7 @@ class Poisson template -Poisson::Poisson(const GridType & grid_type, +Poisson::Poisson(const GridType &grid_type, const PartitionerType &partitioner_type, const unsigned int extraction_level, const unsigned int n_subdomains, @@ -151,7 +151,7 @@ Poisson::make_grid() std::vector::active_cell_iterator> cells_to_agglomerate; std::vector idxs_to_agglomerate; - const auto & csr_and_agglomerates = + const auto &csr_and_agglomerates = PolyUtils::extract_children_of_level(tree, extraction_level); diff --git a/test/polydeal/agglomerate_distributed_mesh.cc b/test/polydeal/agglomerate_distributed_mesh.cc index a1fcfb75..6f92c538 100644 --- a/test/polydeal/agglomerate_distributed_mesh.cc +++ b/test/polydeal/agglomerate_distributed_mesh.cc @@ -63,7 +63,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; static constexpr unsigned int dim = 2; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); AssertThrow(n_ranks == 3, diff --git a/test/polydeal/continuous_face_01.cc b/test/polydeal/continuous_face_01.cc index fa83695b..6a55ca9d 100644 --- a/test/polydeal/continuous_face_01.cc +++ b/test/polydeal/continuous_face_01.cc @@ -128,7 +128,7 @@ test_face_qpoints(AgglomerationHandler<2> &ah) { if (!polytope->at_boundary(f)) { - const auto & neigh_polytope = polytope->neighbor(f); + const auto &neigh_polytope = polytope->neighbor(f); const unsigned int nofn = polytope->neighbor_of_agglomerated_neighbor(f); const auto &fe_faces = diff --git a/test/polydeal/continuous_face_02.cc b/test/polydeal/continuous_face_02.cc index 5bfaf2aa..e668cf17 100644 --- a/test/polydeal/continuous_face_02.cc +++ b/test/polydeal/continuous_face_02.cc @@ -126,7 +126,7 @@ test_face_qpoints(AgglomerationHandler<2> &ah) { if (!polytope->at_boundary(f)) { - const auto & neigh_polytope = polytope->neighbor(f); + const auto &neigh_polytope = polytope->neighbor(f); const unsigned int nofn = polytope->neighbor_of_agglomerated_neighbor(f); const auto &fe_faces = @@ -312,7 +312,7 @@ test2(const Triangulation<2> &tria, AgglomerationHandler<2> &ah) void -test3(const Triangulation<2> & tria, +test3(const Triangulation<2> &tria, AgglomerationHandler<2> &ah, const unsigned int n_subdomains) { diff --git a/test/polydeal/continuous_face_03.cc b/test/polydeal/continuous_face_03.cc index 07dd7e2b..97a6cb7d 100644 --- a/test/polydeal/continuous_face_03.cc +++ b/test/polydeal/continuous_face_03.cc @@ -342,7 +342,7 @@ test_face_qpoints(AgglomerationHandler<2> &ah) { if (!polytope->at_boundary(f)) { - const auto & neigh_polytope = polytope->neighbor(f); + const auto &neigh_polytope = polytope->neighbor(f); const unsigned int nofn = polytope->neighbor_of_agglomerated_neighbor(f); const auto &fe_faces = diff --git a/test/polydeal/continuous_face_distorted_grid.cc b/test/polydeal/continuous_face_distorted_grid.cc index 25575d72..6f5da394 100644 --- a/test/polydeal/continuous_face_distorted_grid.cc +++ b/test/polydeal/continuous_face_distorted_grid.cc @@ -118,7 +118,7 @@ test_face_qpoints(AgglomerationHandler<2> &ah) { if (!polytope->at_boundary(f)) { - const auto & neigh_polytope = polytope->neighbor(f); + const auto &neigh_polytope = polytope->neighbor(f); const unsigned int nofn = polytope->neighbor_of_agglomerated_neighbor(f); const auto &fe_faces = diff --git a/test/polydeal/continuous_face_exact_solution.cc b/test/polydeal/continuous_face_exact_solution.cc index 9bfc6c47..a183b47c 100644 --- a/test/polydeal/continuous_face_exact_solution.cc +++ b/test/polydeal/continuous_face_exact_solution.cc @@ -53,7 +53,7 @@ class LinearFunction : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; std::vector coefficients; @@ -74,7 +74,7 @@ LinearFunction::value(const Point &p, const unsigned int) const template void LinearFunction::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -94,7 +94,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; SolutionType sol_type; @@ -104,7 +104,7 @@ class RightHandSide : public Function template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { (void)points; @@ -133,11 +133,11 @@ class SolutionLinear : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; virtual Tensor<1, dim> - gradient(const Point & p, + gradient(const Point &p, const unsigned int component = 0) const override; }; @@ -164,7 +164,7 @@ SolutionLinear::gradient(const Point &p, const unsigned int) const template void SolutionLinear::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -186,11 +186,11 @@ class SolutionQuadratic : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; virtual Tensor<1, dim> - gradient(const Point & p, + gradient(const Point &p, const unsigned int component = 0) const override; }; @@ -218,7 +218,7 @@ SolutionQuadratic::gradient(const Point &p, const unsigned int) const template void SolutionQuadratic::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -245,7 +245,7 @@ class Poisson Triangulation tria; MappingQ mapping; - FE_DGQ * dg_fe; + FE_DGQ *dg_fe; std::unique_ptr> ah; // no hanging node in DG discretization, we define an AffineConstraints // object @@ -258,7 +258,7 @@ class Poisson Vector system_rhs; std::unique_ptr> cached_tria; std::unique_ptr> rhs_function; - Function * analytical_solution; + Function *analytical_solution; public: Poisson(const SolutionType &solution_type); @@ -550,7 +550,7 @@ Poisson::assemble_system() M21 = 0.; M22 = 0.; - const auto & normals = fe_faces0.get_normal_vectors(); + const auto &normals = fe_faces0.get_normal_vectors(); const double penalty = penalty_constant / std::fabs(polytope->diameter()); diff --git a/test/polydeal/distributed_poisson_sanity_check_01.cc b/test/polydeal/distributed_poisson_sanity_check_01.cc index e05dae93..ae5a0f0f 100644 --- a/test/polydeal/distributed_poisson_sanity_check_01.cc +++ b/test/polydeal/distributed_poisson_sanity_check_01.cc @@ -80,7 +80,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/ = 0) const override; }; @@ -88,7 +88,7 @@ class RightHandSide : public Function template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -102,7 +102,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); Assert(n_ranks == 3, ExcMessage("This test is meant to be run with 3 ranks only.")); diff --git a/test/polydeal/distributed_poisson_sanity_check_02.cc b/test/polydeal/distributed_poisson_sanity_check_02.cc index 62700e51..d2f62abe 100644 --- a/test/polydeal/distributed_poisson_sanity_check_02.cc +++ b/test/polydeal/distributed_poisson_sanity_check_02.cc @@ -81,7 +81,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/ = 0) const override; }; @@ -89,7 +89,7 @@ class RightHandSide : public Function template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -103,7 +103,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); Assert( n_ranks == 3, diff --git a/test/polydeal/exact_solutions.cc b/test/polydeal/exact_solutions.cc index 8b0adc23..5635de74 100644 --- a/test/polydeal/exact_solutions.cc +++ b/test/polydeal/exact_solutions.cc @@ -53,7 +53,7 @@ class LinearFunction : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; std::vector coefficients; @@ -74,7 +74,7 @@ LinearFunction::value(const Point &p, const unsigned int) const template void LinearFunction::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -94,7 +94,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; SolutionType sol_type; @@ -104,7 +104,7 @@ class RightHandSide : public Function template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { (void)points; @@ -133,11 +133,11 @@ class SolutionLinear : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; virtual Tensor<1, dim> - gradient(const Point & p, + gradient(const Point &p, const unsigned int component = 0) const override; }; @@ -164,7 +164,7 @@ SolutionLinear::gradient(const Point &p, const unsigned int) const template void SolutionLinear::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -186,11 +186,11 @@ class SolutionQuadratic : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; virtual Tensor<1, dim> - gradient(const Point & p, + gradient(const Point &p, const unsigned int component = 0) const override; }; @@ -218,7 +218,7 @@ SolutionQuadratic::gradient(const Point &p, const unsigned int) const template void SolutionQuadratic::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -245,7 +245,7 @@ class Poisson Triangulation tria; MappingQ mapping; - FE_DGQ * dg_fe; + FE_DGQ *dg_fe; std::unique_ptr> ah; // no hanging node in DG discretization, we define an AffineConstraints // object @@ -258,7 +258,7 @@ class Poisson Vector system_rhs; std::unique_ptr> cached_tria; std::unique_ptr> rhs_function; - Function * analytical_solution; + Function *analytical_solution; public: Poisson(const SolutionType &solution_type); @@ -551,7 +551,7 @@ Poisson::assemble_system() M21 = 0.; M22 = 0.; - const auto & normals = fe_faces0.get_normal_vectors(); + const auto &normals = fe_faces0.get_normal_vectors(); const double penalty = penalty_constant / std::fabs(polytope->diameter()); diff --git a/test/polydeal/exact_solutions_distributed.cc b/test/polydeal/exact_solutions_distributed.cc index f9fe8652..ece09a82 100644 --- a/test/polydeal/exact_solutions_distributed.cc +++ b/test/polydeal/exact_solutions_distributed.cc @@ -60,7 +60,7 @@ class LinearFunction : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; std::vector coefficients; @@ -81,7 +81,7 @@ LinearFunction::value(const Point &p, const unsigned int) const template void LinearFunction::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -98,7 +98,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/ = 0) const override; }; @@ -106,7 +106,7 @@ class RightHandSide : public Function template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { (void)points; @@ -129,11 +129,11 @@ class SolutionLinear : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; virtual Tensor<1, dim> - gradient(const Point & p, + gradient(const Point &p, const unsigned int component = 0) const override; }; @@ -160,7 +160,7 @@ SolutionLinear::gradient(const Point &p, const unsigned int) const template void SolutionLinear::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -264,7 +264,7 @@ do_test() const auto &agglo_values = ah.reinit(polytope); - const auto & q_points = agglo_values.get_quadrature_points(); + const auto &q_points = agglo_values.get_quadrature_points(); const unsigned int n_qpoints = q_points.size(); std::vector rhs(n_qpoints); rhs_function->value_list(q_points, rhs); diff --git a/test/polydeal/fully_distributed_poisson_sanity_check_01.cc b/test/polydeal/fully_distributed_poisson_sanity_check_01.cc index 7f3c4774..06cbb68b 100644 --- a/test/polydeal/fully_distributed_poisson_sanity_check_01.cc +++ b/test/polydeal/fully_distributed_poisson_sanity_check_01.cc @@ -104,7 +104,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/ = 0) const override; }; @@ -112,7 +112,7 @@ class RightHandSide : public Function template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -126,7 +126,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; unsigned int my_rank = Utilities::MPI::this_mpi_process(comm); static constexpr int dim = 2; diff --git a/test/polydeal/fully_distributed_poisson_sanity_check_02.cc b/test/polydeal/fully_distributed_poisson_sanity_check_02.cc index 7046cd00..dc7e5f18 100644 --- a/test/polydeal/fully_distributed_poisson_sanity_check_02.cc +++ b/test/polydeal/fully_distributed_poisson_sanity_check_02.cc @@ -83,7 +83,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/ = 0) const override; }; @@ -91,7 +91,7 @@ class RightHandSide : public Function template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -105,7 +105,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; unsigned int my_rank = Utilities::MPI::this_mpi_process(comm); static constexpr int dim = 2; diff --git a/test/polydeal/ghosted_bbox_01.cc b/test/polydeal/ghosted_bbox_01.cc index f68e9835..74642a40 100644 --- a/test/polydeal/ghosted_bbox_01.cc +++ b/test/polydeal/ghosted_bbox_01.cc @@ -57,7 +57,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); Assert(n_ranks == 3, ExcMessage("This test is meant to be run with 3 ranks only.")); diff --git a/test/polydeal/ghosted_dofs_01.cc b/test/polydeal/ghosted_dofs_01.cc index 57a91baf..f6e878fd 100644 --- a/test/polydeal/ghosted_dofs_01.cc +++ b/test/polydeal/ghosted_dofs_01.cc @@ -57,7 +57,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); Assert(n_ranks == 3, ExcMessage("This test is meant to be run with 3 ranks only.")); diff --git a/test/polydeal/locally_owned_polytope_01.cc b/test/polydeal/locally_owned_polytope_01.cc index 27b9570a..65c11f4d 100644 --- a/test/polydeal/locally_owned_polytope_01.cc +++ b/test/polydeal/locally_owned_polytope_01.cc @@ -34,7 +34,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); if (Utilities::MPI::this_mpi_process(comm) == 0) std::cout << "Running with " << Utilities::MPI::n_mpi_processes(comm) diff --git a/test/polydeal/locally_owned_polytope_02.cc b/test/polydeal/locally_owned_polytope_02.cc index 4b19155c..a0c15c80 100644 --- a/test/polydeal/locally_owned_polytope_02.cc +++ b/test/polydeal/locally_owned_polytope_02.cc @@ -51,7 +51,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); Assert(n_ranks == 3, ExcMessage("This test is meant to be run with 3 ranks only.")); diff --git a/test/polydeal/locally_owned_polytope_03.cc b/test/polydeal/locally_owned_polytope_03.cc index 5eea4a30..6d3298bc 100644 --- a/test/polydeal/locally_owned_polytope_03.cc +++ b/test/polydeal/locally_owned_polytope_03.cc @@ -57,7 +57,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); AssertThrow(n_ranks == 3, ExcMessage("This test is meant to be run with 3 ranks only.")); diff --git a/test/polydeal/locally_owned_polytope_04.cc b/test/polydeal/locally_owned_polytope_04.cc index 19e79bb3..1b9cc07d 100644 --- a/test/polydeal/locally_owned_polytope_04.cc +++ b/test/polydeal/locally_owned_polytope_04.cc @@ -36,7 +36,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); Assert(n_ranks == 3, ExcMessage("This test is meant to be run with 3 ranks only.")); diff --git a/test/polydeal/locally_owned_polytope_05.cc b/test/polydeal/locally_owned_polytope_05.cc index 631a12f5..8b2f0f15 100644 --- a/test/polydeal/locally_owned_polytope_05.cc +++ b/test/polydeal/locally_owned_polytope_05.cc @@ -58,7 +58,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); AssertThrow(n_ranks == 3, ExcMessage("This test is meant to be run with 3 ranks only.")); @@ -169,7 +169,7 @@ main(int argc, char *argv[]) std::accumulate(agglo_values.get_JxW_values().cbegin(), agglo_values.get_JxW_values().cend(), 0.); - const auto & q_points = agglo_values.get_quadrature_points(); + const auto &q_points = agglo_values.get_quadrature_points(); const unsigned int n_qpoints = q_points.size(); // Face terms diff --git a/test/polydeal/minimal_SIP_Poisson.cc b/test/polydeal/minimal_SIP_Poisson.cc index 42771e02..6d80e7c8 100644 --- a/test/polydeal/minimal_SIP_Poisson.cc +++ b/test/polydeal/minimal_SIP_Poisson.cc @@ -41,7 +41,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; }; @@ -49,7 +49,7 @@ class RightHandSide : public Function template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -278,7 +278,7 @@ Poisson::assemble_system() cell_rhs = 0; const auto &agglo_values = ah->reinit(polytope); - const auto & q_points = agglo_values.get_quadrature_points(); + const auto &q_points = agglo_values.get_quadrature_points(); const unsigned int n_qpoints = q_points.size(); std::vector rhs(n_qpoints); rhs_function->value_list(q_points, rhs); @@ -311,7 +311,7 @@ Poisson::assemble_system() if (polytope->at_boundary(f)) { - const auto & fe_face = ah->reinit(polytope, f); + const auto &fe_face = ah->reinit(polytope, f); const unsigned int dofs_per_cell = fe_face.dofs_per_cell; // Get normal vectors seen from each agglomeration. @@ -518,7 +518,7 @@ test() { Poisson standard_problem(false); standard_problem.run(); - const auto & standard_matrix = standard_problem.get_matrix(); + const auto &standard_matrix = standard_problem.get_matrix(); Poisson agglo_problem(true); agglo_problem.run(); const auto &agglo_matrix = agglo_problem.get_matrix(); diff --git a/test/polydeal/poisson.cc b/test/polydeal/poisson.cc index 3f2a765b..4631c3c2 100644 --- a/test/polydeal/poisson.cc +++ b/test/polydeal/poisson.cc @@ -22,7 +22,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; }; @@ -34,14 +34,14 @@ class Solution : public Function value(const Point &p, const unsigned int component = 0) const override; virtual Tensor<1, dim> - gradient(const Point & p, + gradient(const Point &p, const unsigned int component = 0) const override; }; template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -284,7 +284,7 @@ Poisson::assemble_system() cell_rhs = 0; const auto &agglo_values = ah->reinit(polytope); - const auto & q_points = agglo_values.get_quadrature_points(); + const auto &q_points = agglo_values.get_quadrature_points(); const unsigned int n_qpoints = q_points.size(); std::vector rhs(n_qpoints); rhs_function->value_list(q_points, rhs); diff --git a/test/polydeal/poisson_sanity_check_01.cc b/test/polydeal/poisson_sanity_check_01.cc index a493ac9f..937f1855 100644 --- a/test/polydeal/poisson_sanity_check_01.cc +++ b/test/polydeal/poisson_sanity_check_01.cc @@ -183,7 +183,7 @@ LaplaceOperator::assemble_system() cell_rhs = 0; const auto &agglo_values = ah->reinit(polytope); - const auto & q_points = agglo_values.get_quadrature_points(); + const auto &q_points = agglo_values.get_quadrature_points(); const unsigned int n_qpoints = q_points.size(); std::vector rhs(n_qpoints); diff --git a/test/polydeal/poisson_sanity_check_02.cc b/test/polydeal/poisson_sanity_check_02.cc index b9e57656..c73bd111 100644 --- a/test/polydeal/poisson_sanity_check_02.cc +++ b/test/polydeal/poisson_sanity_check_02.cc @@ -193,7 +193,7 @@ LaplaceOperator::assemble_system() cell_rhs = 0; const auto &agglo_values = ah->reinit(polytope); - const auto & q_points = agglo_values.get_quadrature_points(); + const auto &q_points = agglo_values.get_quadrature_points(); const unsigned int n_qpoints = q_points.size(); std::vector rhs(n_qpoints); diff --git a/test/polydeal/poisson_sanity_check_03.cc b/test/polydeal/poisson_sanity_check_03.cc index c86b68b8..ac778d5e 100644 --- a/test/polydeal/poisson_sanity_check_03.cc +++ b/test/polydeal/poisson_sanity_check_03.cc @@ -178,7 +178,7 @@ LaplaceOperator::assemble_system() cell_rhs = 0; const auto &agglo_values = ah->reinit(polytope); - const auto & q_points = agglo_values.get_quadrature_points(); + const auto &q_points = agglo_values.get_quadrature_points(); const unsigned int n_qpoints = q_points.size(); std::vector rhs(n_qpoints); diff --git a/test/polydeal/polytope_iterator.cc b/test/polydeal/polytope_iterator.cc index 7fa70e5a..ae113f51 100644 --- a/test/polydeal/polytope_iterator.cc +++ b/test/polydeal/polytope_iterator.cc @@ -24,7 +24,7 @@ class RightHandSide : public Function virtual void value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const override; }; @@ -36,14 +36,14 @@ class Solution : public Function value(const Point &p, const unsigned int component = 0) const override; virtual Tensor<1, dim> - gradient(const Point & p, + gradient(const Point &p, const unsigned int component = 0) const override; }; template void RightHandSide::value_list(const std::vector> &points, - std::vector & values, + std::vector &values, const unsigned int /*component*/) const { for (unsigned int i = 0; i < values.size(); ++i) @@ -316,7 +316,7 @@ TestIterator::test3() { std::cout << "Polytope number: " << polytope->index() << "\t volume: " << polytope->volume() << std::endl; - const auto & boundary = polytope->polytope_boundary(); + const auto &boundary = polytope->polytope_boundary(); unsigned int face_index = 0; for (const auto &face : boundary) { diff --git a/test/polydeal/reinit_cell_face_master_master.cc b/test/polydeal/reinit_cell_face_master_master.cc index 38ffac16..0d963bef 100644 --- a/test/polydeal/reinit_cell_face_master_master.cc +++ b/test/polydeal/reinit_cell_face_master_master.cc @@ -128,7 +128,7 @@ test_q_points_agglomerated_face(Triangulation &tria) { if (!polytope->at_boundary(f)) { - const auto & neigh_polytope = polytope->neighbor(f); + const auto &neigh_polytope = polytope->neighbor(f); unsigned int nofn = polytope->neighbor_of_agglomerated_neighbor(f); std::cout << "Neighbor is: " << neigh_polytope->index() diff --git a/test/polydeal/reinit_cell_face_quad_pts.cc b/test/polydeal/reinit_cell_face_quad_pts.cc index cde73fe3..1545bba3 100644 --- a/test/polydeal/reinit_cell_face_quad_pts.cc +++ b/test/polydeal/reinit_cell_face_quad_pts.cc @@ -113,7 +113,7 @@ test_q_points_agglomerated_face(Triangulation &tria) { if (!polytope->at_boundary(f)) { - const auto & neigh_polytope = polytope->neighbor(f); + const auto &neigh_polytope = polytope->neighbor(f); unsigned int nofn = polytope->neighbor_of_agglomerated_neighbor(f); std::cout << "Neighbor is: " diff --git a/test/polydeal/reinit_ghosted_neighbor_01.cc b/test/polydeal/reinit_ghosted_neighbor_01.cc index 48774213..e9b99556 100644 --- a/test/polydeal/reinit_ghosted_neighbor_01.cc +++ b/test/polydeal/reinit_ghosted_neighbor_01.cc @@ -50,7 +50,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); Assert(n_ranks == 3, ExcMessage("This test is meant to be run with 3 ranks only.")); diff --git a/test/polydeal/reinit_ghosted_neighbor_02.cc b/test/polydeal/reinit_ghosted_neighbor_02.cc index 238c9578..01895ea4 100644 --- a/test/polydeal/reinit_ghosted_neighbor_02.cc +++ b/test/polydeal/reinit_ghosted_neighbor_02.cc @@ -57,7 +57,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); AssertThrow(n_ranks == 3, ExcMessage("This test is meant to be run with 3 ranks only.")); diff --git a/test/polydeal/reinit_ghosted_neighbor_03.cc b/test/polydeal/reinit_ghosted_neighbor_03.cc index cf39b476..afb00486 100644 --- a/test/polydeal/reinit_ghosted_neighbor_03.cc +++ b/test/polydeal/reinit_ghosted_neighbor_03.cc @@ -50,7 +50,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); Assert(n_ranks == 3, ExcMessage("This test is meant to be run with 3 ranks only.")); diff --git a/test/polydeal/rtree_mesh.cc b/test/polydeal/rtree_mesh.cc index 6170d872..f3021fee 100644 --- a/test/polydeal/rtree_mesh.cc +++ b/test/polydeal/rtree_mesh.cc @@ -47,7 +47,7 @@ class Poisson template -Poisson::Poisson(const GridTypes & grid_type, +Poisson::Poisson(const GridTypes &grid_type, const unsigned int extraction_level) : mapping(1) , grid_type(grid_type) diff --git a/test/polydeal/sparsity_distributed_tria.cc b/test/polydeal/sparsity_distributed_tria.cc index 5680935f..f9a4932f 100644 --- a/test/polydeal/sparsity_distributed_tria.cc +++ b/test/polydeal/sparsity_distributed_tria.cc @@ -57,7 +57,7 @@ int main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - const MPI_Comm & comm = MPI_COMM_WORLD; + const MPI_Comm &comm = MPI_COMM_WORLD; const unsigned n_ranks = Utilities::MPI::n_mpi_processes(comm); Assert(n_ranks == 3, ExcMessage("This test is meant to be run with 3 ranks only."));