From: David Wells Date: Wed, 22 Mar 2023 12:23:05 +0000 (-0400) Subject: dealii::DoFHandler -> DoFHandler X-Git-Tag: v9.5.0-rc1~433^2~2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=4f55ae41541179719dbfb80d4600f4db6dcd81f6;p=dealii.git dealii::DoFHandler -> DoFHandler --- diff --git a/include/deal.II/distributed/cell_weights.h b/include/deal.II/distributed/cell_weights.h index dbb16287c3..3a742de8fc 100644 --- a/include/deal.II/distributed/cell_weights.h +++ b/include/deal.II/distributed/cell_weights.h @@ -129,8 +129,8 @@ namespace parallel * @param[in] weighting_function The function that determines each * cell's weight during load balancing. */ - CellWeights(const dealii::DoFHandler &dof_handler, - const WeightingFunction & weighting_function); + CellWeights(const DoFHandler &dof_handler, + const WeightingFunction & weighting_function); /** * Destructor. diff --git a/include/deal.II/dofs/dof_accessor.templates.h b/include/deal.II/dofs/dof_accessor.templates.h index a50119e66a..6307d62a86 100644 --- a/include/deal.II/dofs/dof_accessor.templates.h +++ b/include/deal.II/dofs/dof_accessor.templates.h @@ -2113,8 +2113,8 @@ namespace internal // dealii::DoFCellAccessor, not // namespace // dealii::internal::DoFCellAccessor + using DoFHandler; using dealii::DoFCellAccessor; - using dealii::DoFHandler; /** * A class with the same purpose as the similarly named class of the diff --git a/include/deal.II/dofs/dof_faces.h b/include/deal.II/dofs/dof_faces.h index 62031a7795..7f1e5e9f1b 100644 --- a/include/deal.II/dofs/dof_faces.h +++ b/include/deal.II/dofs/dof_faces.h @@ -62,7 +62,7 @@ namespace internal * variables using the DoFHandler::get_dof_index() and corresponding * setter functions. Knowledge of the actual data format is therefore * encapsulated to the present hierarchy of classes as well as the - * dealii::DoFHandler class. + * DoFHandler class. */ template class DoFFaces diff --git a/include/deal.II/dofs/dof_levels.h b/include/deal.II/dofs/dof_levels.h index 706661b80a..7b40338071 100644 --- a/include/deal.II/dofs/dof_levels.h +++ b/include/deal.II/dofs/dof_levels.h @@ -41,7 +41,7 @@ namespace internal * Note that vertices use a storage scheme that is entirely separate from * the one used for the cells. The indices of degrees of freedom located * on vertices are therefore not stored here, but rather in member - * variables of the dealii::DoFHandler class. + * variables of the DoFHandler class. * * The indices of degrees of freedom located on lower dimensional objects, * i.e. on lines for 2d and on quads and lines for 3d are treated @@ -57,7 +57,7 @@ namespace internal * variables using the DoFHandler::get_dof_index() and corresponding * setter functions. Knowledge of the actual data format is therefore * encapsulated to the present hierarchy of classes as well as the - * dealii::DoFHandler class. + * DoFHandler class. */ template class DoFLevel diff --git a/include/deal.II/dofs/dof_objects.h b/include/deal.II/dofs/dof_objects.h index decfe958fa..bfd14f04ec 100644 --- a/include/deal.II/dofs/dof_objects.h +++ b/include/deal.II/dofs/dof_objects.h @@ -90,10 +90,10 @@ namespace internal */ template types::global_dof_index & - access_dof_index(const dealii::DoFHandler &dof_handler, - const unsigned int obj_index, - const types::fe_index fe_index, - const unsigned int local_index); + access_dof_index(const DoFHandler &dof_handler, + const unsigned int obj_index, + const types::fe_index fe_index, + const unsigned int local_index); /** * Return the value 1. The meaning of this function becomes clear by @@ -102,9 +102,8 @@ namespace internal */ template unsigned int - n_active_fe_indices( - const dealii::DoFHandler &dof_handler, - const types::global_dof_index index) const; + n_active_fe_indices(const DoFHandler &dof_handler, + const types::global_dof_index index) const; /** * Similar to the function above. Assert that the given index is zero, @@ -112,10 +111,9 @@ namespace internal */ template bool - fe_index_is_active( - const dealii::DoFHandler &dof_handler, - const types::global_dof_index index, - const types::fe_index fe_index) const; + fe_index_is_active(const DoFHandler &dof_handler, + const types::global_dof_index index, + const types::fe_index fe_index) const; /** * Determine an estimate for the memory consumption (in bytes) of this @@ -147,9 +145,8 @@ namespace internal template template inline unsigned int - DoFObjects::n_active_fe_indices( - const dealii::DoFHandler &, - const types::global_dof_index) const + DoFObjects::n_active_fe_indices(const DoFHandler &, + const types::global_dof_index) const { return 1; } @@ -159,14 +156,12 @@ namespace internal template template inline bool - DoFObjects::fe_index_is_active( - const dealii::DoFHandler &, - const types::global_dof_index, - const types::fe_index fe_index) const + DoFObjects::fe_index_is_active(const DoFHandler &, + const types::global_dof_index, + const types::fe_index fe_index) const { (void)fe_index; - Assert((fe_index == - dealii::DoFHandler::default_fe_index), + Assert((fe_index == DoFHandler::default_fe_index), ExcMessage("Only zero fe_index values are allowed for " "non-hp-DoFHandlers.")); return true; @@ -178,14 +173,13 @@ namespace internal template inline types::global_dof_index & DoFObjects::access_dof_index( - const dealii::DoFHandler &dof_handler, - const unsigned int obj_index, - const types::fe_index fe_index, - const unsigned int local_index) + const DoFHandler &dof_handler, + const unsigned int obj_index, + const types::fe_index fe_index, + const unsigned int local_index) { (void)fe_index; - Assert((fe_index == - dealii::DoFHandler::default_fe_index), + Assert((fe_index == DoFHandler::default_fe_index), ExcMessage("Only the default FE index is allowed for DoFHandler " "objects without hp capability")); AssertIndexRange(local_index, diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index a2431e8ece..5dc6be5f22 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -626,8 +626,8 @@ namespace DoFTools * in the triangulation. By default flux couplings are added over all internal * faces. @p face_has_flux_coupling should be a function that takes an * active_cell_iterator and a face index and should return true if there is a - * flux coupling over the face. When using the ::dealii::DoFHandler we could, - * for example, use + * flux coupling over the face. When using DoFHandler we could, for example, + * use * * @code * auto face_has_flux_coupling = diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 4844cc2026..01b6e63643 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -111,7 +111,7 @@ namespace internal #ifdef _MSC_VER template - class ActiveCellIterator> + class ActiveCellIterator> { public: using type = @@ -3194,7 +3194,7 @@ namespace GridTools * those processors: * @code * using active_cell_iterator = - * typename dealii::DoFHandler::active_cell_iterator; + * typename DoFHandler::active_cell_iterator; * auto pack = [] (const active_cell_iterator &cell) -> unsigned int * { * return cell->active_fe_index(); @@ -3207,7 +3207,7 @@ namespace GridTools * }; * * GridTools::exchange_cell_data_to_ghosts< - * unsigned int, dealii::DoFHandler> (dof_handler, + * unsigned int, DoFHandler> (dof_handler, * pack, * unpack); * @endcode diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index c33b4c6285..05fc689014 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -3123,8 +3123,8 @@ namespace internal template inline std::vector extract_locally_owned_index_sets( - const std::vector *> &dofh, - const unsigned int level) + const std::vector *> &dofh, + const unsigned int level) { std::vector locally_owned_set; locally_owned_set.reserve(dofh.size()); diff --git a/include/deal.II/matrix_free/matrix_free.templates.h b/include/deal.II/matrix_free/matrix_free.templates.h index 447af78ff7..7162655951 100644 --- a/include/deal.II/matrix_free/matrix_free.templates.h +++ b/include/deal.II/matrix_free/matrix_free.templates.h @@ -1125,9 +1125,9 @@ namespace internal std::vector compute_dof_info( const std::vector *> &constraint, - const std::vector &locally_owned_dofs, - const std::vector>> &dof_handler, - const Table<2, MatrixFreeFunctions::ShapeInfo> & shape_infos, + const std::vector & locally_owned_dofs, + const std::vector>> &dof_handler, + const Table<2, MatrixFreeFunctions::ShapeInfo> &shape_infos, const unsigned int cell_level_index_end_local, const unsigned int mg_level, const bool hold_all_faces_to_owned_cells, diff --git a/include/deal.II/multigrid/mg_transfer.templates.h b/include/deal.II/multigrid/mg_transfer.templates.h index 419a677488..6373a7c761 100644 --- a/include/deal.II/multigrid/mg_transfer.templates.h +++ b/include/deal.II/multigrid/mg_transfer.templates.h @@ -56,7 +56,7 @@ namespace internal */ template void - reinit_vector(const dealii::DoFHandler &dof_handler, + reinit_vector(const DoFHandler &dof_handler, const std::vector &, MGLevelObject> &v) { @@ -75,9 +75,9 @@ namespace internal */ template void - reinit_vector(const dealii::DoFHandler &dof_handler, - std::vector target_component, - MGLevelObject> & v) + reinit_vector(const DoFHandler & dof_handler, + std::vector target_component, + MGLevelObject> &v) { const unsigned int n_blocks = dof_handler.get_fe().n_blocks(); if (target_component.size() == 0) @@ -115,7 +115,7 @@ namespace internal */ template void - reinit_vector(const dealii::DoFHandler &dof_handler, + reinit_vector(const DoFHandler &dof_handler, const std::vector &, MGLevelObject &v) { @@ -143,7 +143,7 @@ namespace internal */ template void - reinit_vector(const dealii::DoFHandler &dof_handler, + reinit_vector(const DoFHandler &dof_handler, const std::vector &, MGLevelObject &v) { diff --git a/include/deal.II/multigrid/multigrid.h b/include/deal.II/multigrid/multigrid.h index 34d4306660..23864c78d7 100644 --- a/include/deal.II/multigrid/multigrid.h +++ b/include/deal.II/multigrid/multigrid.h @@ -709,15 +709,14 @@ namespace internal class TRANSFER, typename OtherVectorType> std::enable_if_t - vmult( - const std::vector *> &dof_handler_vector, - dealii::Multigrid & multigrid, - const TRANSFER & transfer, - OtherVectorType & dst, - const OtherVectorType & src, - const bool uses_dof_handler_vector, - const typename dealii::mg::Signals &signals, - int) + vmult(const std::vector *> &dof_handler_vector, + dealii::Multigrid & multigrid, + const TRANSFER & transfer, + OtherVectorType & dst, + const OtherVectorType & src, + const bool uses_dof_handler_vector, + const typename dealii::mg::Signals & signals, + int) { signals.transfer_to_mg(true); if (uses_dof_handler_vector) @@ -741,15 +740,14 @@ namespace internal class TRANSFER, typename OtherVectorType> void - vmult( - const std::vector *> &dof_handler_vector, - dealii::Multigrid & multigrid, - const TRANSFER & transfer, - OtherVectorType & dst, - const OtherVectorType & src, - const bool uses_dof_handler_vector, - const typename dealii::mg::Signals &signals, - ...) + vmult(const std::vector *> &dof_handler_vector, + dealii::Multigrid & multigrid, + const TRANSFER & transfer, + OtherVectorType & dst, + const OtherVectorType & src, + const bool uses_dof_handler_vector, + const typename dealii::mg::Signals & signals, + ...) { (void)uses_dof_handler_vector; Assert(!uses_dof_handler_vector, ExcInternalError()); @@ -770,15 +768,14 @@ namespace internal class TRANSFER, typename OtherVectorType> std::enable_if_t - vmult_add( - const std::vector *> &dof_handler_vector, - dealii::Multigrid & multigrid, - const TRANSFER & transfer, - OtherVectorType & dst, - const OtherVectorType & src, - const bool uses_dof_handler_vector, - const typename dealii::mg::Signals &signals, - int) + vmult_add(const std::vector *> &dof_handler_vector, + dealii::Multigrid & multigrid, + const TRANSFER & transfer, + OtherVectorType & dst, + const OtherVectorType & src, + const bool uses_dof_handler_vector, + const typename dealii::mg::Signals &signals, + int) { signals.transfer_to_mg(true); if (uses_dof_handler_vector) @@ -804,15 +801,14 @@ namespace internal class TRANSFER, typename OtherVectorType> void - vmult_add( - const std::vector *> &dof_handler_vector, - dealii::Multigrid & multigrid, - const TRANSFER & transfer, - OtherVectorType & dst, - const OtherVectorType & src, - const bool uses_dof_handler_vector, - const typename dealii::mg::Signals &signals, - ...) + vmult_add(const std::vector *> &dof_handler_vector, + dealii::Multigrid & multigrid, + const TRANSFER & transfer, + OtherVectorType & dst, + const OtherVectorType & src, + const bool uses_dof_handler_vector, + const typename dealii::mg::Signals &signals, + ...) { (void)uses_dof_handler_vector; Assert(!uses_dof_handler_vector, ExcInternalError()); diff --git a/include/deal.II/numerics/vector_tools_integrate_difference.templates.h b/include/deal.II/numerics/vector_tools_integrate_difference.templates.h index 1a5d334317..c9edbc2856 100644 --- a/include/deal.II/numerics/vector_tools_integrate_difference.templates.h +++ b/include/deal.II/numerics/vector_tools_integrate_difference.templates.h @@ -611,7 +611,7 @@ namespace VectorTools concepts::is_writable_dealii_vector_type) void integrate_difference( const dealii::hp::MappingCollection & mapping, - const dealii::DoFHandler & dof, + const DoFHandler & dof, const InVector & fe_function, const Function &exact_solution, OutVector & difference, @@ -635,7 +635,7 @@ namespace VectorTools DEAL_II_CXX20_REQUIRES(concepts::is_dealii_vector_type && concepts::is_writable_dealii_vector_type) void integrate_difference( - const dealii::DoFHandler & dof, + const DoFHandler & dof, const InVector & fe_function, const Function &exact_solution, OutVector & difference, diff --git a/source/distributed/cell_weights.cc b/source/distributed/cell_weights.cc index e50589df02..138e768e8c 100644 --- a/source/distributed/cell_weights.cc +++ b/source/distributed/cell_weights.cc @@ -27,8 +27,8 @@ namespace parallel { template CellWeights::CellWeights( - const dealii::DoFHandler &dof_handler, - const WeightingFunction & weighting_function) + const DoFHandler &dof_handler, + const WeightingFunction & weighting_function) { reinit(dof_handler, weighting_function); } diff --git a/source/dofs/dof_handler.cc b/source/dofs/dof_handler.cc index 62fc1523ea..aea600a604 100644 --- a/source/dofs/dof_handler.cc +++ b/source/dofs/dof_handler.cc @@ -1061,10 +1061,10 @@ namespace internal */ template static void - reserve_space(dealii::DoFHandler<1, spacedim> &dof_handler) + reserve_space(DoFHandler<1, spacedim> &dof_handler) { Assert(dof_handler.fe_collection.size() > 0, - (typename dealii::DoFHandler<1, spacedim>::ExcNoFESelected())); + (typename DoFHandler<1, spacedim>::ExcNoFESelected())); Assert(dof_handler.tria->n_levels() > 0, ExcMessage("The current Triangulation must not be empty.")); Assert(dof_handler.tria->n_levels() == @@ -1086,10 +1086,10 @@ namespace internal template static void - reserve_space(dealii::DoFHandler<2, spacedim> &dof_handler) + reserve_space(DoFHandler<2, spacedim> &dof_handler) { Assert(dof_handler.fe_collection.size() > 0, - (typename dealii::DoFHandler<1, spacedim>::ExcNoFESelected())); + (typename DoFHandler<1, spacedim>::ExcNoFESelected())); Assert(dof_handler.tria->n_levels() > 0, ExcMessage("The current Triangulation must not be empty.")); Assert(dof_handler.tria->n_levels() == @@ -1113,10 +1113,10 @@ namespace internal template static void - reserve_space(dealii::DoFHandler<3, spacedim> &dof_handler) + reserve_space(DoFHandler<3, spacedim> &dof_handler) { Assert(dof_handler.fe_collection.size() > 0, - (typename dealii::DoFHandler<1, spacedim>::ExcNoFESelected())); + (typename DoFHandler<1, spacedim>::ExcNoFESelected())); Assert(dof_handler.tria->n_levels() > 0, ExcMessage("The current Triangulation must not be empty.")); Assert(dof_handler.tria->n_levels() == @@ -1328,15 +1328,18 @@ namespace internal // to have functions that can pack and unpack the data we want to // transport -- namely, the single unsigned int active_fe_index // objects - auto pack = [](const typename dealii::DoFHandler:: - active_cell_iterator &cell) -> types::fe_index { + auto pack = + []( + const typename DoFHandler::active_cell_iterator + &cell) -> types::fe_index { return cell->active_fe_index(); }; - auto unpack = [&dof_handler]( - const typename dealii::DoFHandler:: - active_cell_iterator &cell, - const types::fe_index active_fe_index) -> void { + auto unpack = + [&dof_handler]( + const typename DoFHandler::active_cell_iterator + & cell, + const types::fe_index active_fe_index) -> void { // we would like to say // cell->set_active_fe_index(active_fe_index); // but this is not allowed on cells that are not @@ -1348,7 +1351,7 @@ namespace internal GridTools::exchange_cell_data_to_ghosts< types::fe_index, - dealii::DoFHandler>(dof_handler, pack, unpack); + DoFHandler>(dof_handler, pack, unpack); } else { @@ -1414,17 +1417,19 @@ namespace internal DistributedTriangulationBase *>( &dof_handler.get_triangulation())) { - auto pack = [&dof_handler]( - const typename dealii::DoFHandler:: - active_cell_iterator &cell) -> types::fe_index { + auto pack = + [&dof_handler]( + const typename DoFHandler::active_cell_iterator + &cell) -> types::fe_index { return dof_handler .hp_cell_future_fe_indices[cell->level()][cell->index()]; }; - auto unpack = [&dof_handler]( - const typename dealii::DoFHandler:: - active_cell_iterator &cell, - const types::fe_index future_fe_index) -> void { + auto unpack = + [&dof_handler]( + const typename DoFHandler::active_cell_iterator + & cell, + const types::fe_index future_fe_index) -> void { dof_handler .hp_cell_future_fe_indices[cell->level()][cell->index()] = future_fe_index; @@ -1432,7 +1437,7 @@ namespace internal GridTools::exchange_cell_data_to_ghosts< types::fe_index, - dealii::DoFHandler>(dof_handler, pack, unpack); + DoFHandler>(dof_handler, pack, unpack); } else { diff --git a/source/dofs/dof_handler_policy.cc b/source/dofs/dof_handler_policy.cc index c05d87f198..bba45eca09 100644 --- a/source/dofs/dof_handler_policy.cc +++ b/source/dofs/dof_handler_policy.cc @@ -50,10 +50,10 @@ namespace internal { namespace Policy { - // use class dealii::DoFHandler instead + // use class DoFHandler instead // of namespace internal::DoFHandler in // the following - using dealii::DoFHandler; + using DoFHandler; namespace { diff --git a/source/dofs/dof_tools.cc b/source/dofs/dof_tools.cc index 6b5713d870..6a676b6bb4 100644 --- a/source/dofs/dof_tools.cc +++ b/source/dofs/dof_tools.cc @@ -901,8 +901,7 @@ namespace DoFTools { template IndexSet - extract_hanging_node_dofs( - const dealii::DoFHandler<1, spacedim> &dof_handler) + extract_hanging_node_dofs(const DoFHandler<1, spacedim> &dof_handler) { // there are no hanging nodes in 1d return IndexSet(dof_handler.n_dofs()); @@ -911,8 +910,7 @@ namespace DoFTools template IndexSet - extract_hanging_node_dofs( - const dealii::DoFHandler<2, spacedim> &dof_handler) + extract_hanging_node_dofs(const DoFHandler<2, spacedim> &dof_handler) { const unsigned int dim = 2; @@ -928,8 +926,7 @@ namespace DoFTools for (const unsigned int face : cell->face_indices()) if (cell->face(face)->has_children()) { - const typename dealii::DoFHandler::line_iterator + const typename DoFHandler::line_iterator line = cell->face(face); for (unsigned int dof = 0; dof != fe.n_dofs_per_vertex(); @@ -957,8 +954,7 @@ namespace DoFTools template IndexSet - extract_hanging_node_dofs( - const dealii::DoFHandler<3, spacedim> &dof_handler) + extract_hanging_node_dofs(const DoFHandler<3, spacedim> &dof_handler) { const unsigned int dim = 3; @@ -971,8 +967,8 @@ namespace DoFTools if (!cell->is_artificial()) for (auto f : cell->face_indices()) { - const typename dealii::DoFHandler::face_iterator - face = cell->face(f); + const typename DoFHandler::face_iterator face = + cell->face(f); if (cell->face(f)->has_children()) { for (unsigned int child = 0; child < 4; ++child) diff --git a/source/dofs/dof_tools_constraints.cc b/source/dofs/dof_tools_constraints.cc index 1823435b49..3fa84bc11e 100644 --- a/source/dofs/dof_tools_constraints.cc +++ b/source/dofs/dof_tools_constraints.cc @@ -577,7 +577,7 @@ namespace DoFTools template void - make_hp_hanging_node_constraints(const dealii::DoFHandler<1> &, + make_hp_hanging_node_constraints(const DoFHandler<1> &, AffineConstraints &) { // nothing to do for regular dof handlers in 1d @@ -586,7 +586,7 @@ namespace DoFTools template void - make_oldstyle_hanging_node_constraints(const dealii::DoFHandler<1> &, + make_oldstyle_hanging_node_constraints(const DoFHandler<1> &, AffineConstraints &, std::integral_constant) { @@ -596,7 +596,7 @@ namespace DoFTools template void - make_hp_hanging_node_constraints(const dealii::DoFHandler<1, 2> &, + make_hp_hanging_node_constraints(const DoFHandler<1, 2> &, AffineConstraints &) { // nothing to do for regular dof handlers in 1d @@ -605,7 +605,7 @@ namespace DoFTools template void - make_oldstyle_hanging_node_constraints(const dealii::DoFHandler<1, 2> &, + make_oldstyle_hanging_node_constraints(const DoFHandler<1, 2> &, AffineConstraints &, std::integral_constant) { @@ -616,7 +616,7 @@ namespace DoFTools template void make_hp_hanging_node_constraints( - const dealii::DoFHandler<1, spacedim> & /*dof_handler*/, + const DoFHandler<1, spacedim> & /*dof_handler*/, AffineConstraints & /*constraints*/) { // nothing to do for dof handlers in 1d @@ -626,7 +626,7 @@ namespace DoFTools template void make_oldstyle_hanging_node_constraints( - const dealii::DoFHandler<1, spacedim> & /*dof_handler*/, + const DoFHandler<1, spacedim> & /*dof_handler*/, AffineConstraints & /*constraints*/, std::integral_constant) { @@ -2678,15 +2678,13 @@ namespace DoFTools template void compute_intergrid_weights_3( - const typename dealii::DoFHandler::active_cell_iterator - &cell, + const typename DoFHandler::active_cell_iterator &cell, const Assembler::Scratch &, - Assembler::CopyData ©_data, - const unsigned int coarse_component, - const FiniteElement &coarse_fe, - const InterGridMap> - & coarse_to_fine_grid_map, - const std::vector> ¶meter_dofs) + Assembler::CopyData & copy_data, + const unsigned int coarse_component, + const FiniteElement & coarse_fe, + const InterGridMap> &coarse_to_fine_grid_map, + const std::vector> & parameter_dofs) { // for each cell on the parameter grid: find out which degrees of // freedom on the fine grid correspond in which way to the degrees of @@ -2847,12 +2845,11 @@ namespace DoFTools template void compute_intergrid_weights_2( - const dealii::DoFHandler &coarse_grid, - const unsigned int coarse_component, - const InterGridMap> - & coarse_to_fine_grid_map, - const std::vector> & parameter_dofs, - const std::vector &weight_mapping, + const DoFHandler & coarse_grid, + const unsigned int coarse_component, + const InterGridMap> &coarse_to_fine_grid_map, + const std::vector> & parameter_dofs, + const std::vector & weight_mapping, std::vector> &weights) { Assembler::Scratch scratch; @@ -2912,10 +2909,11 @@ namespace DoFTools [coarse_component, &coarse_grid, &coarse_to_fine_grid_map, - ¶meter_dofs](const typename dealii::DoFHandler:: - active_cell_iterator & cell, - const Assembler::Scratch & scratch_data, - Assembler::CopyData ©_data) { + ¶meter_dofs]( + const typename DoFHandler::active_cell_iterator + & cell, + const Assembler::Scratch & scratch_data, + Assembler::CopyData ©_data) { compute_intergrid_weights_3(cell, scratch_data, copy_data, @@ -2964,12 +2962,11 @@ namespace DoFTools template unsigned int compute_intergrid_weights_1( - const dealii::DoFHandler &coarse_grid, - const unsigned int coarse_component, - const dealii::DoFHandler &fine_grid, - const unsigned int fine_component, - const InterGridMap> - &coarse_to_fine_grid_map, + const DoFHandler & coarse_grid, + const unsigned int coarse_component, + const DoFHandler & fine_grid, + const unsigned int fine_component, + const InterGridMap> &coarse_to_fine_grid_map, std::vector> &weights, std::vector & weight_mapping) { diff --git a/source/dofs/dof_tools_sparsity.cc b/source/dofs/dof_tools_sparsity.cc index 9309e9edd2..268395e138 100644 --- a/source/dofs/dof_tools_sparsity.cc +++ b/source/dofs/dof_tools_sparsity.cc @@ -1185,8 +1185,7 @@ namespace DoFTools // Loop over interior faces for (const unsigned int face : cell->face_indices()) { - const typename dealii::DoFHandler::face_iterator + const typename DoFHandler::face_iterator cell_face = cell->face(face); const bool periodic_neighbor = @@ -1194,8 +1193,9 @@ namespace DoFTools if ((!cell->at_boundary(face)) || periodic_neighbor) { - typename dealii::DoFHandler:: - level_cell_iterator neighbor = + typename DoFHandler::level_cell_iterator + neighbor = cell->neighbor_or_periodic_neighbor(face); // Like the non-hp-case: If the cells are on the same @@ -1247,8 +1247,7 @@ namespace DoFTools sub_nr != cell_face->n_children(); ++sub_nr) { - const typename dealii::DoFHandler:: + const typename DoFHandler:: level_cell_iterator sub_neighbor = periodic_neighbor ? cell diff --git a/source/fe/fe_q_bubbles.cc b/source/fe/fe_q_bubbles.cc index ea8d887204..10aa025bcc 100644 --- a/source/fe/fe_q_bubbles.cc +++ b/source/fe/fe_q_bubbles.cc @@ -117,7 +117,7 @@ namespace internal tr.begin_active()->set_refine_flag(RefinementCase(ref_case)); tr.execute_coarsening_and_refinement(); - dealii::DoFHandler dh(tr); + DoFHandler dh(tr); dh.distribute_dofs(fe); dealii::FEValues fine(get_default_linear_mapping(tr), @@ -136,8 +136,8 @@ namespace internal nc, std::vector(fe.n_dofs_per_cell())); // now create the mass matrix and all the right_hand sides - unsigned int child_no = 0; - typename dealii::DoFHandler::active_cell_iterator cell = + unsigned int child_no = 0; + typename DoFHandler::active_cell_iterator cell = dh.begin_active(); for (; cell != dh.end(); ++cell, ++child_no) { diff --git a/source/grid/grid_tools_dof_handlers.cc b/source/grid/grid_tools_dof_handlers.cc index 25b422a3c2..9e144c913c 100644 --- a/source/grid/grid_tools_dof_handlers.cc +++ b/source/grid/grid_tools_dof_handlers.cc @@ -1265,7 +1265,7 @@ namespace GridTools template - std::pair::active_cell_iterator, + std::pair::active_cell_iterator, Point> find_active_cell_around_point( const hp::MappingCollection &mapping, @@ -1280,7 +1280,7 @@ namespace GridTools "the FECollection.")); using cell_iterator = - typename dealii::DoFHandler::active_cell_iterator; + typename DoFHandler::active_cell_iterator; std::pair> best_cell; // If we have only one element in the MappingCollection, @@ -1384,7 +1384,7 @@ namespace GridTools if (!found && cells_searched < n_cells) { find_active_cell_around_point_internal( mesh, searched_cells, adjacent_cells); } diff --git a/source/grid/grid_tools_dof_handlers.inst.in b/source/grid/grid_tools_dof_handlers.inst.in index c8f198d660..5d8872462c 100644 --- a/source/grid/grid_tools_dof_handlers.inst.in +++ b/source/grid/grid_tools_dof_handlers.inst.in @@ -154,8 +154,8 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) \{ template std::pair< - dealii::DoFHandler::active_cell_iterator, + DoFHandler::active_cell_iterator, Point> find_active_cell_around_point( const hp::MappingCollection diff --git a/source/multigrid/mg_transfer_block.cc b/source/multigrid/mg_transfer_block.cc index e780f11ff6..c9bebf2b0f 100644 --- a/source/multigrid/mg_transfer_block.cc +++ b/source/multigrid/mg_transfer_block.cc @@ -52,7 +52,7 @@ namespace template void reinit_vector_by_blocks( - const dealii::DoFHandler & dof_handler, + const DoFHandler & dof_handler, MGLevelObject> & v, const std::vector & sel, std::vector> &ndofs) @@ -98,7 +98,7 @@ namespace template void reinit_vector_by_blocks( - const dealii::DoFHandler & dof_handler, + const DoFHandler & dof_handler, MGLevelObject> & v, const unsigned int selected_block, std::vector> &ndofs) diff --git a/source/multigrid/mg_transfer_component.cc b/source/multigrid/mg_transfer_component.cc index 3c76f557ab..60a12ce2f3 100644 --- a/source/multigrid/mg_transfer_component.cc +++ b/source/multigrid/mg_transfer_component.cc @@ -79,7 +79,7 @@ namespace template void reinit_vector_by_components( - const dealii::DoFHandler & mg_dof, + const DoFHandler & mg_dof, MGLevelObject> & v, const std::vector & sel, const std::vector & target_comp, @@ -178,7 +178,7 @@ namespace template void reinit_vector_by_components( - const dealii::DoFHandler & mg_dof, + const DoFHandler & mg_dof, MGLevelObject> & v, const ComponentMask & component_mask, const std::vector & target_component, diff --git a/source/multigrid/mg_transfer_internal.cc b/source/multigrid/mg_transfer_internal.cc index 4a4339de14..92180ed276 100644 --- a/source/multigrid/mg_transfer_internal.cc +++ b/source/multigrid/mg_transfer_internal.cc @@ -59,8 +59,8 @@ namespace internal template void fill_copy_indices( - const dealii::DoFHandler &dof_handler, - const MGConstrainedDoFs * mg_constrained_dofs, + const DoFHandler &dof_handler, + const MGConstrainedDoFs * mg_constrained_dofs, std::vector>> ©_indices, @@ -552,9 +552,9 @@ namespace internal template void - setup_element_info(ElementInfo & elem_info, - const FiniteElement<1> & fe, - const dealii::DoFHandler &dof_handler) + setup_element_info(ElementInfo & elem_info, + const FiniteElement<1> &fe, + const DoFHandler & dof_handler) { // currently, we have only FE_Q and FE_DGQ type elements implemented elem_info.n_components = dof_handler.get_fe().element_multiplicity(0); @@ -617,8 +617,8 @@ namespace internal template void setup_transfer( - const dealii::DoFHandler &dof_handler, - const MGConstrainedDoFs * mg_constrained_dofs, + const DoFHandler & dof_handler, + const MGConstrainedDoFs *mg_constrained_dofs, const std::vector> & external_partitioners, ElementInfo & elem_info, @@ -692,7 +692,7 @@ namespace internal std::vector ghosted_level_dofs_l0; // step 2.1: loop over the cells on the coarse side - typename dealii::DoFHandler::cell_iterator cell, + typename DoFHandler::cell_iterator cell, endc = dof_handler.end(level - 1); for (cell = dof_handler.begin(level - 1); cell != endc; ++cell) { diff --git a/source/multigrid/mg_transfer_internal.inst.in b/source/multigrid/mg_transfer_internal.inst.in index eb4385980e..1d69d57f7c 100644 --- a/source/multigrid/mg_transfer_internal.inst.in +++ b/source/multigrid/mg_transfer_internal.inst.in @@ -25,8 +25,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) #if deal_II_dimension <= deal_II_space_dimension template void fill_copy_indices( - const dealii::DoFHandler - &, + const DoFHandler &, const MGConstrainedDoFs *, std::vector>> &, @@ -77,7 +76,7 @@ for (deal_II_dimension : DIMENSIONS; S : REAL_SCALARS) template void setup_transfer( - const dealii::DoFHandler &, + const DoFHandler &, const MGConstrainedDoFs *, const std::vector> &, diff --git a/source/numerics/solution_transfer.cc b/source/numerics/solution_transfer.cc index a22805f9ed..0d98c90099 100644 --- a/source/numerics/solution_transfer.cc +++ b/source/numerics/solution_transfer.cc @@ -217,7 +217,7 @@ namespace internal */ template void - extract_interpolation_matrices(const dealii::DoFHandler &dof, + extract_interpolation_matrices(const DoFHandler & dof, dealii::Table<2, FullMatrix> &matrices) { if (dof.has_hp_capabilities() == false)