From: Marc Fehling Date: Thu, 19 Nov 2020 21:26:29 +0000 (-0700) Subject: Remove underscores for active and future FE indices in the documentation. X-Git-Tag: v9.3.0-rc1~743^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=fc8eef083fa0e166ac3e4a61b83c8939226e2dd1;p=dealii.git Remove underscores for active and future FE indices in the documentation. Write standalone FE in capitals. --- diff --git a/include/deal.II/distributed/solution_transfer.h b/include/deal.II/distributed/solution_transfer.h index f8b7082aac..23d0c8084c 100644 --- a/include/deal.II/distributed/solution_transfer.h +++ b/include/deal.II/distributed/solution_transfer.h @@ -167,7 +167,7 @@ namespace parallel * * Transferring a solution across refinement works exactly like in the * non-hp-case. However, when considering serialization, we also have to - * store the active_fe_indices in an additional step. A code snippet + * store the active FE indices in an additional step. A code snippet * demonstrating serialization with the * parallel::distributed::SolutionTransfer class with DoFHandler objects * with hp-capabilities is provided in the following. Here VectorType is @@ -197,7 +197,7 @@ namespace parallel * * DoFHandler hp_dof_handler(triangulation); * // We need to introduce our dof_handler to the fe_collection - * // before setting all active_fe_indices. + * // before setting all active FE indices. * hp_dof_handler.deserialize_active_fe_indices(); * hp_dof_handler.distribute_dofs(fe_collection); * diff --git a/include/deal.II/dofs/dof_accessor.h b/include/deal.II/dofs/dof_accessor.h index bea7a6188b..081f1bbd64 100644 --- a/include/deal.II/dofs/dof_accessor.h +++ b/include/deal.II/dofs/dof_accessor.h @@ -539,8 +539,8 @@ public: n_active_fe_indices() const; /** - * Return the @p n-th active fe index on this object. For cells and all non- - * hp-objects, there is only a single active fe index, so the argument must + * Return the @p n-th active FE index on this object. For cells and all non- + * hp-objects, there is only a single active FE index, so the argument must * be equal to zero. For lower-dimensional hp-objects, there are * n_active_fe_indices() active finite elements, and this function can be * queried for their indices. @@ -549,7 +549,7 @@ public: nth_active_fe_index(const unsigned int n) const; /** - * Returns all active fe indices on this object. + * Returns all active FE indices on this object. * * The size of the returned set equals the number of finite elements that * are active on this object. @@ -1047,7 +1047,7 @@ public: n_active_fe_indices() const; /** - * Return the @p n-th active fe index on this object. + * Return the @p n-th active FE index on this object. * * Since vertices do not store the information necessary for this to be * calculated, this method just raises an exception and only exists to diff --git a/include/deal.II/dofs/dof_accessor.templates.h b/include/deal.II/dofs/dof_accessor.templates.h index b564ce783c..d0d544490d 100644 --- a/include/deal.II/dofs/dof_accessor.templates.h +++ b/include/deal.II/dofs/dof_accessor.templates.h @@ -605,7 +605,7 @@ namespace internal /** - * Return the fe index of the n-th finite element active on a given + * Return the FE index of the n-th finite element active on a given * vertex. */ template @@ -618,7 +618,7 @@ namespace internal { Assert(d == dim || obj_level == 0, ExcNotImplemented()); - // for cells only one active fe index available + // for cells only one active FE index available Assert(((d == dim) && (local_index != DoFHandler::default_fe_index)) == false, @@ -648,7 +648,7 @@ namespace internal /** - * Returns all active fe indices on a given vertex. + * Returns all active FE indices on a given vertex. * * The size of the returned set equals the number of finite elements that * are active on this vertex. @@ -1641,7 +1641,7 @@ DoFAccessor::get_fe( const unsigned int fe_index) const { Assert(fe_index_is_active(fe_index) == true, - ExcMessage("This function can only be called for active fe indices")); + ExcMessage("This function can only be called for active FE indices")); return this->dof_handler->get_fe(fe_index); } @@ -2201,7 +2201,7 @@ namespace internal const DoFCellAccessor &accessor) { if (accessor.dof_handler->hp_capability_enabled == false) - return 0; // ::DoFHandler only supports a single active fe with index + return 0; // ::DoFHandler only supports a single active FE with index // zero Assert( @@ -2229,7 +2229,7 @@ namespace internal { if (accessor.dof_handler->hp_capability_enabled == false) { - // ::DoFHandler only supports a single active fe with index zero + // ::DoFHandler only supports a single active FE with index zero AssertDimension(i, (DoFHandler::default_fe_index)); return; } @@ -2260,7 +2260,7 @@ namespace internal if (accessor.dof_handler->hp_capability_enabled == false) return DoFHandler:: default_fe_index; // ::DoFHandler only supports - // a single active fe with + // a single active FE with // index zero Assert( @@ -2293,7 +2293,7 @@ namespace internal { if (accessor.dof_handler->hp_capability_enabled == false) { - // ::DoFHandler only supports a single active fe with index zero + // ::DoFHandler only supports a single active FE with index zero AssertDimension(i, (DoFHandler::default_fe_index)); return; } @@ -2322,7 +2322,7 @@ namespace internal const DoFCellAccessor &accessor) { if (accessor.dof_handler->hp_capability_enabled == false) - return false; // ::DoFHandler only supports a single active fe with + return false; // ::DoFHandler only supports a single active FE with // index zero Assert( @@ -2350,7 +2350,7 @@ namespace internal const DoFCellAccessor &accessor) { if (accessor.dof_handler->hp_capability_enabled == false) - return; // ::DoFHandler only supports a single active fe with index + return; // ::DoFHandler only supports a single active FE with index // zero Assert( @@ -2777,13 +2777,13 @@ DoFCellAccessor:: Assert((this->dof_handler->hp_capability_enabled == false) || this->is_active(), ExcMessage( - "You can not ask for the active_fe_index on a cell that has " + "You can not ask for the active FE index on a cell that has " "children because no degrees of freedom are assigned " "to this cell and, consequently, no finite element " "is associated with it.")); Assert((this->dof_handler->hp_capability_enabled == false) || (this->is_locally_owned() || this->is_ghost()), - ExcMessage("You can only query active_fe_index information on cells " + ExcMessage("You can only query active FE index information on cells " "that are either locally owned or (after distributing " "degrees of freedom) are ghost cells.")); @@ -2800,13 +2800,13 @@ DoFCellAccessor:: { Assert((this->dof_handler->hp_capability_enabled == false) || this->is_active(), - ExcMessage("You can not set the active_fe_index on a cell that has " + ExcMessage("You can not set the active FE index on a cell that has " "children because no degrees of freedom will be assigned " "to this cell.")); Assert((this->dof_handler->hp_capability_enabled == false) || this->is_locally_owned(), - ExcMessage("You can only set active_fe_index information on cells " + ExcMessage("You can only set active FE index information on cells " "that are locally owned. On ghost cells, this information " "will automatically be propagated from the owning process " "of that cell, and there is no information at all on " @@ -2844,13 +2844,13 @@ DoFCellAccessor:: Assert((this->dof_handler->hp_capability_enabled == false) || (this->has_children() == false), ExcMessage( - "You can not ask for the future_fe_index on a cell that has " + "You can not ask for the future FE index on a cell that has " "children because no degrees of freedom are assigned " "to this cell and, consequently, no finite element " "is associated with it.")); Assert((this->dof_handler->hp_capability_enabled == false) || (this->is_locally_owned()), - ExcMessage("You can only query future_fe_index information on cells " + ExcMessage("You can only query future FE index information on cells " "that are locally owned.")); return dealii::internal::DoFCellAccessorImplementation::Implementation:: @@ -2866,13 +2866,13 @@ DoFCellAccessor:: { Assert((this->dof_handler->hp_capability_enabled == false) || (this->has_children() == false), - ExcMessage("You can not set the future_fe_index on a cell that has " + ExcMessage("You can not set the future FE index on a cell that has " "children because no degrees of freedom will be assigned " "to this cell.")); Assert((this->dof_handler->hp_capability_enabled == false) || this->is_locally_owned(), - ExcMessage("You can only set future_fe_index information on cells " + ExcMessage("You can only set future FE index information on cells " "that are locally owned.")); dealii::internal::DoFCellAccessorImplementation::Implementation:: @@ -2889,13 +2889,13 @@ DoFCellAccessor:: Assert((this->dof_handler->hp_capability_enabled == false) || (this->has_children() == false), ExcMessage( - "You can not ask for the future_fe_index on a cell that has " + "You can not ask for the future FE index on a cell that has " "children because no degrees of freedom are assigned " "to this cell and, consequently, no finite element " "is associated with it.")); Assert((this->dof_handler->hp_capability_enabled == false) || (this->is_locally_owned()), - ExcMessage("You can only query future_fe_index information on cells " + ExcMessage("You can only query future FE index information on cells " "that are locally owned.")); return dealii::internal::DoFCellAccessorImplementation::Implementation:: @@ -2912,13 +2912,13 @@ DoFCellAccessor:: Assert((this->dof_handler->hp_capability_enabled == false) || (this->has_children() == false), ExcMessage( - "You can not ask for the future_fe_index on a cell that has " + "You can not ask for the future FE index on a cell that has " "children because no degrees of freedom are assigned " "to this cell and, consequently, no finite element " "is associated with it.")); Assert((this->dof_handler->hp_capability_enabled == false) || (this->is_locally_owned()), - ExcMessage("You can only query future_fe_index information on cells " + ExcMessage("You can only query future FE index information on cells " "that are locally owned.")); dealii::internal::DoFCellAccessorImplementation::Implementation:: diff --git a/include/deal.II/dofs/dof_handler.h b/include/deal.II/dofs/dof_handler.h index a2291ac533..47ecf1098f 100644 --- a/include/deal.II/dofs/dof_handler.h +++ b/include/deal.II/dofs/dof_handler.h @@ -534,8 +534,8 @@ public: using offset_type = unsigned int; /** - * Invalid active_fe_index which will be used as a default value to determine - * whether a future_fe_index has been set or not. + * Invalid active FE index which will be used as a default value to determine + * whether a future FE index has been set or not. */ static const active_fe_index_type invalid_active_fe_index = static_cast(-1); @@ -1270,7 +1270,7 @@ public: /** * Whenever serialization with a parallel::distributed::Triangulation as the * underlying triangulation is considered, we also need to consider storing - * the active_fe_indices on all active cells as well. + * the active FE indices on all active cells as well. * * This function registers that these indices are to be stored whenever the * parallel::distributed::Triangulation::save() function is called on the @@ -1289,10 +1289,10 @@ public: /** * Whenever serialization with a parallel::distributed::Triangulation as the * underlying triangulation is considered, we also need to consider storing - * the active_fe_indices on all active cells as well. + * the active FE indices on all active cells as well. * * This function deserializes and distributes the previously stored - * active_fe_indices on all active cells. + * active FE indices on all active cells. * * @note Currently only implemented for triangulations of type * parallel::distributed::Triangulation. An assertion will be triggered if @@ -1376,7 +1376,7 @@ public: DeclException2(ExcInvalidFEIndex, int, int, - << "The mesh contains a cell with an active_fe_index of " + << "The mesh contains a cell with an active FE index of " << arg1 << ", but the finite element collection only has " << arg2 << " elements"); @@ -1477,7 +1477,7 @@ private: /** * Whenever the underlying triangulation changes by either - * h/p refinement/coarsening and serialization, the active_fe_index of cells + * h/p-refinement/coarsening and serialization, the active FE index of cells * needs to be transferred. This structure stores all temporary information * required during that process. */ @@ -1502,14 +1502,14 @@ private: std::map coarsened_cells_fe_index; /** - * Container to temporarily store the active_fe_index of every locally + * Container to temporarily store the active FE index of every locally * owned cell for transfer across parallel::distributed::Triangulation * objects. */ std::vector active_fe_indices; /** - * Helper object to transfer all active_fe_indices on + * Helper object to transfer all active FE indices on * parallel::distributed::Triangulation objects during * refinement/coarsening and serialization. */ @@ -1600,7 +1600,7 @@ private: object_dof_ptr; /** - * Active fe indices of each geometric object. Identification + * Active FE indices of each geometric object. Identification * of the appropriate position of a cell in the vectors is done via * hp_object_fe_ptr (CRS scheme). */ @@ -1608,19 +1608,19 @@ private: hp_object_fe_indices; /** - * Pointer to the first fe index of a geometric object. + * Pointer to the first FE index of a geometric object. */ mutable std::array, dim + 1> hp_object_fe_ptr; /** - * Active fe index of an active cell (identified by level and level index). + * Active FE index of an active cell (identified by level and level index). * This vector is only used in hp-mode. */ mutable std::vector> hp_cell_active_fe_indices; /** - * Future fe index of an active cell (identified by level and level index). + * Future FE index of an active cell (identified by level and level index). * This vector is only used in hp-mode. */ mutable std::vector> @@ -1721,7 +1721,7 @@ private: * Update tables for active and future fe_indices. * * Whenever the underlying triangulation changes (either by adaptation or - * deserialization), active and future fe index tables will be adjusted to the + * deserialization), active and future FE index tables will be adjusted to the * current structure of the triangulation. Missing values of active and future * indices will be initialized with their defaults (see * create_active_fe_table()). @@ -1737,7 +1737,7 @@ private: * signal just before the associated Triangulation or * parallel::shared::Triangulation is modified. * - * The function that stores the active_fe_indices of all cells that will + * The function that stores the active FE indices of all cells that will * be refined or coarsened before the refinement happens, so that * they can be set again after refinement. */ @@ -1749,7 +1749,7 @@ private: * signal just after the associated Triangulation or * parallel::shared::Triangulation is modified. * - * The function that restores the active_fe_indices of all cells that + * The function that restores the active FE indices of all cells that * were refined or coarsened. */ void @@ -1760,7 +1760,7 @@ private: * signal just before the associated parallel::distributed::Triangulation is * modified. * - * The function that stores all active_fe_indices on locally owned cells for + * The function that stores all active FE indices on locally owned cells for * distribution over all participating processors. */ void @@ -1771,7 +1771,7 @@ private: * signal just after the associated parallel::distributed::Triangulation is * modified. * - * The function that restores all active_fe_indices on locally owned cells + * The function that restores all active FE indices on locally owned cells * that have been communicated. */ void diff --git a/include/deal.II/fe/fe_tools.templates.h b/include/deal.II/fe/fe_tools.templates.h index 53cfaa1f0c..4a72f1d9cd 100644 --- a/include/deal.II/fe/fe_tools.templates.h +++ b/include/deal.II/fe/fe_tools.templates.h @@ -219,7 +219,7 @@ namespace FETools // given FEs unsigned int n_shape_functions = 0; for (unsigned int i = 0; i < fes.size(); ++i) - if (multiplicities[i] > 0) // check needed as fe might be nullptr + if (multiplicities[i] > 0) // check needed as FE might be nullptr n_shape_functions += fes[i]->n_dofs_per_cell() * multiplicities[i]; // generate the array that will hold the output @@ -386,27 +386,27 @@ namespace FETools // given FEs unsigned int n_shape_functions = 0; for (unsigned int i = 0; i < fes.size(); ++i) - if (multiplicities[i] > 0) // needed because fe might be nullptr + if (multiplicities[i] > 0) // needed because FE might be nullptr n_shape_functions += fes[i]->n_dofs_per_cell() * multiplicities[i]; unsigned int n_components = 0; if (do_tensor_product) { for (unsigned int i = 0; i < fes.size(); ++i) - if (multiplicities[i] > 0) // needed because fe might be nullptr + if (multiplicities[i] > 0) // needed because FE might be nullptr n_components += fes[i]->n_components() * multiplicities[i]; } else { for (unsigned int i = 0; i < fes.size(); ++i) - if (multiplicities[i] > 0) // needed because fe might be nullptr + if (multiplicities[i] > 0) // needed because FE might be nullptr { n_components = fes[i]->n_components(); break; } // Now check that all FEs have the same number of components: for (unsigned int i = 0; i < fes.size(); ++i) - if (multiplicities[i] > 0) // needed because fe might be nullptr + if (multiplicities[i] > 0) // needed because FE might be nullptr Assert(n_components == fes[i]->n_components(), ExcDimensionMismatch(n_components, fes[i]->n_components())); diff --git a/include/deal.II/fe/fe_tools_interpolate.templates.h b/include/deal.II/fe/fe_tools_interpolate.templates.h index 47344852b9..cac9b99d74 100644 --- a/include/deal.II/fe/fe_tools_interpolate.templates.h +++ b/include/deal.II/fe/fe_tools_interpolate.templates.h @@ -297,7 +297,7 @@ namespace FETools cell = dof1.begin_active(), endc = dof1.end(); - // map from possible fe objects in + // map from possible FE objects in // dof1 to the back_interpolation // matrices std::map *, std::unique_ptr>> diff --git a/include/deal.II/hp/fe_values.h b/include/deal.II/hp/fe_values.h index f4dfefe931..690fd6ea00 100644 --- a/include/deal.II/hp/fe_values.h +++ b/include/deal.II/hp/fe_values.h @@ -248,7 +248,7 @@ namespace hp * hp::FECollection and hp::QCollection. Later on, when one sits on a * concrete cell, one would call the reinit() function for this particular * cell, just as one does for a regular ::FEValues object. The difference is - * that this time, the reinit() function looks up the active_fe_index of + * that this time, the reinit() function looks up the active FE index of * that cell, if necessary creates a ::FEValues object that matches the * finite element and quadrature formulas with that particular index in * their collections, and then re-initializes it for the current cell. The @@ -260,7 +260,7 @@ namespace hp * The reinit() functions have additional arguments with default values. If * not specified, the function takes the index into the hp::FECollection, * hp::QCollection, and hp::MappingCollection objects from the - * active_fe_index of the cell, as explained above. However, one can also + * active FE index of the cell, as explained above. However, one can also * select different indices for a current cell. For example, by specifying a * different index into the hp::QCollection class, one does not need to sort * the quadrature objects in the quadrature collection so that they match diff --git a/include/deal.II/hp/mapping_collection.h b/include/deal.II/hp/mapping_collection.h index d24a622963..e0f321582c 100644 --- a/include/deal.II/hp/mapping_collection.h +++ b/include/deal.II/hp/mapping_collection.h @@ -100,7 +100,7 @@ namespace hp /** * Return the mapping object which was specified by the user for the - * active_fe_index which is provided as a parameter to this method. + * active FE index which is provided as a parameter to this method. * * @pre @p index must be between zero and the number of elements of the * collection. diff --git a/include/deal.II/matrix_free/dof_info.h b/include/deal.II/matrix_free/dof_info.h index f1a2dc13ae..2d84bcad13 100644 --- a/include/deal.II/matrix_free/dof_info.h +++ b/include/deal.II/matrix_free/dof_info.h @@ -634,7 +634,7 @@ namespace internal * account. This information is encoded in the row_starts variables * directly. * - * The outer vector goes through the various fe indices in the hp-case, + * The outer vector goes through the various FE indices in the hp-case, * similarly to the @p dofs_per_cell variable. */ std::vector> component_dof_indices_offset; diff --git a/include/deal.II/matrix_free/dof_info.templates.h b/include/deal.II/matrix_free/dof_info.templates.h index b34582b003..432f2d505f 100644 --- a/include/deal.II/matrix_free/dof_info.templates.h +++ b/include/deal.II/matrix_free/dof_info.templates.h @@ -520,7 +520,7 @@ namespace internal { (void)constraint_pool_row_index; - // first reorder the active fe index. + // first reorder the active FE index. const bool have_hp = dofs_per_cell.size() > 1; if (cell_active_fe_index.size() > 0) { diff --git a/include/deal.II/matrix_free/face_setup_internal.h b/include/deal.II/matrix_free/face_setup_internal.h index a2f0c5462e..d480a4db25 100644 --- a/include/deal.II/matrix_free/face_setup_internal.h +++ b/include/deal.II/matrix_free/face_setup_internal.h @@ -1072,7 +1072,7 @@ namespace internal operator()(const FaceToCellTopology &face1, const FaceToCellTopology &face2) const { - // check if active fe indices match + // check if active FE indices match if (active_fe_indices.size() > 0) { // ... for interior faces diff --git a/include/deal.II/matrix_free/fe_evaluation.h b/include/deal.II/matrix_free/fe_evaluation.h index 3662a970c4..1cd5f8ac8b 100644 --- a/include/deal.II/matrix_free/fe_evaluation.h +++ b/include/deal.II/matrix_free/fe_evaluation.h @@ -257,7 +257,7 @@ public: get_current_cell_index() const; /** - * Return the active fe index for this class for efficient indexing in the hp- + * Return the active FE index for this class for efficient indexing in the hp- * case. */ unsigned int @@ -360,7 +360,7 @@ protected: VectorizedArrayType> *mapping_data; /** - * The active fe index for this class for efficient indexing in the hp-case. + * The active FE index for this class for efficient indexing in the hp-case. */ const unsigned int active_fe_index; diff --git a/include/deal.II/matrix_free/mapping_info.templates.h b/include/deal.II/matrix_free/mapping_info.templates.h index d6cddd792b..98c48fe756 100644 --- a/include/deal.II/matrix_free/mapping_info.templates.h +++ b/include/deal.II/matrix_free/mapping_info.templates.h @@ -961,7 +961,7 @@ namespace internal dealii::FEValues &fe_val = *fe_values[my_q][fe_index]; cell_data.resize(n_q_points); - // if the fe index has changed from the previous cell, set the + // if the FE index has changed from the previous cell, set the // old cell type to invalid (otherwise, we might detect // similarity due to some cells further ahead) if (my_q > 0) @@ -1846,9 +1846,9 @@ namespace internal 1); #endif - // We assume that we have the faces sorted by the active fe - // indices so that the active fe index of the interior side of the - // face batch is the same as the fe index of the interior side of + // We assume that we have the faces sorted by the active FE + // indices so that the active FE index of the interior side of the + // face batch is the same as the FE index of the interior side of // its first entry. const unsigned int fe_index = active_fe_index.size() > 0 ? @@ -2026,9 +2026,9 @@ namespace internal GeometryInfo::max_children_per_cell) { // We assume that we have the faces sorted by the - // active fe indices so that the active fe index of + // active FE indices so that the active FE index of // the exterior side of the face batch is the same as - // the fe index of the exterior side of its first + // the FE index of the exterior side of its first // entry. const unsigned int fe_index = active_fe_index.size() > 0 ? diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index 1f82ed4fd7..df9daf21f4 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -1484,8 +1484,8 @@ public: /** * In the hp-adaptive case, a subrange of internal faces as computed during * loop() might contain internal faces with elements of different active - * fe indices. Use this function to compute what the subrange for a given pair - * of active fe indices is. + * FE indices. Use this function to compute what the subrange for a given pair + * of active FE indices is. */ std::pair create_inner_face_subrange_hp_by_index( @@ -1497,8 +1497,8 @@ public: /** * In the hp-adaptive case, a subrange of boundary faces as computed during * loop() might contain boundary faces with elements of different active - * fe indices. Use this function to compute what the subrange for a given - * active fe indices is. + * FE indices. Use this function to compute what the subrange for a given + * active FE indices is. */ std::pair create_boundary_face_subrange_hp_by_index( diff --git a/include/deal.II/matrix_free/matrix_free.templates.h b/include/deal.II/matrix_free/matrix_free.templates.h index b2f3fab893..de7aac6761 100644 --- a/include/deal.II/matrix_free/matrix_free.templates.h +++ b/include/deal.II/matrix_free/matrix_free.templates.h @@ -106,7 +106,7 @@ MatrixFree::create_cell_subrange_hp_by_index( Assert( fe_indices[i] >= fe_indices[i - 1], ExcMessage( - "Cell range must be over sorted range of fe indices in hp-case!")); + "Cell range must be over sorted range of FE indices in hp-case!")); AssertIndexRange(range.first, fe_indices.size() + 1); AssertIndexRange(range.second, fe_indices.size() + 1); #endif diff --git a/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h b/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h index 17fd993f73..2dda8777c6 100644 --- a/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h +++ b/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h @@ -948,7 +948,7 @@ namespace internal dof_handler_coarse.get_fe(0).dofs_per_cell * GeometryInfo::max_children_per_cell; - // degree of fe on coarse and fine cell + // degree of FE on coarse and fine cell transfer.schemes[0].degree_coarse = transfer.schemes[0].degree_fine = transfer.schemes[1].degree_coarse = dof_handler_coarse.get_fe(0).degree; transfer.schemes[1].degree_fine = diff --git a/include/deal.II/numerics/solution_transfer.h b/include/deal.II/numerics/solution_transfer.h index 2da1e585e9..4a124e1a1e 100644 --- a/include/deal.II/numerics/solution_transfer.h +++ b/include/deal.II/numerics/solution_transfer.h @@ -297,7 +297,7 @@ DEAL_II_NAMESPACE_OPEN * finite elements that are part of the hp::FECollection associated with the * DoFHandler, should be considered on cells that are not active (i.e., that * have children). This is because degrees of freedom are only allocated for - * active cells and, in fact, it is not allowed to set an active_fe_index on + * active cells and, in fact, it is not allowed to set an active FE index on * non- active cells using DoFAccessor::set_active_fe_index(). * * It is, thus, not entirely natural what should happen if, for example, a few @@ -320,7 +320,7 @@ DEAL_II_NAMESPACE_OPEN * cell. After refinement, this Q3 function on the mother cell is then * interpolated into the space the user has selected for this cell (which may * be different from Q3, in this example, if the user has set the - * active_fe_index for a different space post-refinement and before calling + * active FE index for a different space post-refinement and before calling * DoFHandler::distribute_dofs()). * * @note In the context of hp-refinement, if cells are coarsened or the diff --git a/include/deal.II/numerics/vector_tools_boundary.templates.h b/include/deal.II/numerics/vector_tools_boundary.templates.h index 350ab9c5dc..18e5379abc 100644 --- a/include/deal.II/numerics/vector_tools_boundary.templates.h +++ b/include/deal.II/numerics/vector_tools_boundary.templates.h @@ -367,7 +367,7 @@ namespace VectorTools } } else - // fe has only one component, so save some computations + // FE has only one component, so save some computations { // get only the one component that this function has dof_values_scalar.resize(fe.n_dofs_per_face(face_no)); diff --git a/include/deal.II/numerics/vector_tools_interpolate.templates.h b/include/deal.II/numerics/vector_tools_interpolate.templates.h index ace6175041..235d6ee785 100644 --- a/include/deal.II/numerics/vector_tools_interpolate.templates.h +++ b/include/deal.II/numerics/vector_tools_interpolate.templates.h @@ -188,7 +188,7 @@ namespace VectorTools for (unsigned int m = 0; m < multiplicity; ++m) { // recursively call apply_transform to make sure to - // correctly handle nested fe systems. + // correctly handle nested FE systems. current_offset = apply_transform(base_fe, current_offset, fe_values_jacobians, @@ -276,7 +276,7 @@ namespace VectorTools std::vector dofs_on_cell(fe.max_dofs_per_cell()); // Temporary storage for cell-wise interpolation operation. We store a - // variant for every fe we encounter to speed up resizing operations. + // variant for every FE we encounter to speed up resizing operations. // The first vector is used for local function evaluation. The vector // dof_values is used to store intermediate cell-wise interpolation // results (see the detailed explanation in the for loop further down diff --git a/include/deal.II/numerics/vector_tools_point_value.h b/include/deal.II/numerics/vector_tools_point_value.h index 9d73967bbd..3636aa34ea 100644 --- a/include/deal.II/numerics/vector_tools_point_value.h +++ b/include/deal.II/numerics/vector_tools_point_value.h @@ -152,9 +152,9 @@ namespace VectorTools * Call the create_point_source_vector() function, see above, with * an implied default $Q_1$ mapping object. * - * Note that if your DoFHandler uses any active fe index other than zero, then + * Note that if your DoFHandler uses any active FE index other than zero, then * you need to call the function above that provides a mapping object for each - * active fe index. + * active FE index. */ template void @@ -204,9 +204,9 @@ namespace VectorTools * Call the create_point_source_vector() function for vector-valued finite * elements, see above, with an implied default $Q_1$ mapping object. * - * Note that if your DoFHandler uses any active fe index other than zero, then + * Note that if your DoFHandler uses any active FE index other than zero, then * you need to call the function above that provides a mapping object for each - * active fe index. + * active FE index. */ template void diff --git a/include/deal.II/numerics/vector_tools_rhs.h b/include/deal.II/numerics/vector_tools_rhs.h index d5894d315d..7516611332 100644 --- a/include/deal.II/numerics/vector_tools_rhs.h +++ b/include/deal.II/numerics/vector_tools_rhs.h @@ -165,7 +165,7 @@ namespace VectorTools /** * Call the create_boundary_right_hand_side() function, see above, with a * single Q1 mapping as collection. This function therefore will only work - * if the only active fe index in use is zero. + * if the only active FE index in use is zero. * * @see * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" diff --git a/source/distributed/error_predictor.cc b/source/distributed/error_predictor.cc index b854bd7307..1fb13c38f9 100644 --- a/source/distributed/error_predictor.cc +++ b/source/distributed/error_predictor.cc @@ -214,7 +214,7 @@ namespace parallel (**estimated_error_it)[cell->active_cell_index()] * (gamma_h * std::pow(.5, future_fe_degree)); - // If the future fe index differs from the active one, also take + // If the future FE index differs from the active one, also take // into account p-adaptation. if (cell->future_fe_index_set()) *predicted_error_it *= diff --git a/source/distributed/solution_transfer.cc b/source/distributed/solution_transfer.cc index b255be2780..779cbe1620 100644 --- a/source/distributed/solution_transfer.cc +++ b/source/distributed/solution_transfer.cc @@ -308,7 +308,7 @@ namespace parallel dim, DoFHandlerType::space_dimension>::CELL_COARSEN: { - // In case of coarsening, we need to find a suitable fe index + // In case of coarsening, we need to find a suitable FE index // for the parent cell. We choose the 'least dominant fe' // on all children from the associated FECollection. # ifdef DEBUG @@ -383,10 +383,10 @@ namespace parallel DoFHandlerType::space_dimension>::CELL_REFINE: { // After refinement, this particular cell is no longer active, - // and its children have inherited its fe index. However, to - // unpack the data on the old cell, we need to recover its fe + // and its children have inherited its FE index. However, to + // unpack the data on the old cell, we need to recover its FE // index from one of the children. Just to be sure, we also - // check if all children have the same fe index. + // check if all children have the same FE index. fe_index = cell->child(0)->active_fe_index(); for (unsigned int child_index = 1; child_index < cell->n_children(); diff --git a/source/dofs/dof_accessor_get.cc b/source/dofs/dof_accessor_get.cc index b920452d47..136aed8a7d 100644 --- a/source/dofs/dof_accessor_get.cc +++ b/source/dofs/dof_accessor_get.cc @@ -111,7 +111,7 @@ DoFCellAccessor::get_interpolated_dof_values( "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " - "the active_fe_index has been set.")); + "the active FE index has been set.")); const FiniteElement &fe = this->get_dof_handler().get_fe(fe_index); diff --git a/source/dofs/dof_accessor_set.cc b/source/dofs/dof_accessor_set.cc index f4689c96a6..ca5dc3cf96 100644 --- a/source/dofs/dof_accessor_set.cc +++ b/source/dofs/dof_accessor_set.cc @@ -101,7 +101,7 @@ DoFCellAccessor::set_dof_values_by_interpolation( "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " - "the active_fe_index has been set.")); + "the active FE index has been set.")); const FiniteElement &fe = this->get_dof_handler().get_fe(fe_index); diff --git a/source/dofs/dof_handler.cc b/source/dofs/dof_handler.cc index 47ee62b991..f6becc1322 100644 --- a/source/dofs/dof_handler.cc +++ b/source/dofs/dof_handler.cc @@ -1010,7 +1010,7 @@ namespace internal struct Implementation { /** - * No future_fe_indices should have been assigned when partitioning a + * No future FE indices should have been assigned when partitioning a * triangulation, since they are only available locally and will not be * communicated. */ @@ -1068,7 +1068,7 @@ namespace internal [cell->vertex_index(v)] = true; // in debug mode, make sure that each vertex is associated - // with at least one fe (note that except for unused + // with at least one FE (note that except for unused // vertices, all vertices are actually active). this is of // course only true for vertices that are part of either // ghost or locally owned cells @@ -1237,7 +1237,7 @@ namespace internal // description in hp::DoFLevel) with the indices we will // need. Note that our task is more complicated than for the // cell case above since two adjacent cells may have different - // active_fe_indices, in which case we need to allocate + // active FE indices, in which case we need to allocate // *two* sets of face dofs for the same face. But they don't // *have* to be different, and so we need to prepare for this // as well. @@ -1698,7 +1698,7 @@ namespace internal /** * Given a DoFHandler object in hp-mode, make sure that the - * active_fe_indices that a user has set for locally owned cells are + * active FE indices that a user has set for locally owned cells are * communicated to all other relevant cells as well. * * For parallel::shared::Triangulation objects, @@ -1722,9 +1722,9 @@ namespace internal { // we have a shared triangulation. in this case, every processor // knows about all cells, but every processor only has knowledge - // about the active_fe_index on the cells it owns. + // about the active FE index on the cells it owns. // - // we can create a complete set of active_fe_indices by letting + // we can create a complete set of active FE indices by letting // every processor create a vector of indices for all cells, // filling only those on the cells it owns and setting the indices // on the other cells to zero. then we add all of these vectors @@ -1741,7 +1741,7 @@ namespace internal tr->get_communicator(), active_fe_indices); - // now go back and fill the active_fe_index on all other + // now go back and fill the active FE index on all other // cells. we would like to call cell->set_active_fe_index(), // but that function does not allow setting these indices on // non-locally_owned cells. so we have to work around the @@ -1809,7 +1809,7 @@ namespace internal * future refinement and coarsening. Further, prepare those indices to * be distributed on on the updated triangulation later. * - * On cells to be refined, the active_fe_index will be inherited to + * On cells to be refined, the active FE index will be inherited to * their children and thus will be stored as such. * * On cells to be coarsened, we choose the finite element on the parent @@ -1821,7 +1821,7 @@ namespace internal * information. * * On cells intended for p-refinement or p-coarsening, those - * active_fe_indices will be determined by the corresponding flags that + * active FE indices will be determined by the corresponding flags that * have been set on the relevant cells. */ template @@ -1836,7 +1836,7 @@ namespace internal { if (cell->refine_flag_set()) { - // Store the active_fe_index of each cell that will be + // Store the active FE index of each cell that will be // refined to and distribute it later on its children. // Pick their future index if flagged for p-refinement. fe_transfer->refined_cells_fe_index.insert( @@ -1845,18 +1845,18 @@ namespace internal else if (cell->coarsen_flag_set()) { // From all cells that will be coarsened, determine their - // parent and calculate its proper active_fe_index, so that + // parent and calculate its proper active FE index, so that // it can be set after refinement. But first, check if that // particular cell has a parent at all. Assert(cell->level() > 0, ExcInternalError()); const auto &parent = cell->parent(); - // Check if the active_fe_index for the current cell has + // Check if the active FE index for the current cell has // been determined already. if (fe_transfer->coarsened_cells_fe_index.find(parent) == fe_transfer->coarsened_cells_fe_index.end()) { - // Find a suitable active_fe_index for the parent cell + // Find a suitable active FE index for the parent cell // based on the 'least dominant finite element' of its // children. Consider the childrens' hypothetical future // index when they have been flagged for p-refinement. @@ -1879,7 +1879,7 @@ namespace internal { // No h-refinement is scheduled for this cell. // However, it may have p-refinement indicators, so we - // choose a new active_fe_index based on its flags. + // choose a new active FE index based on its flags. if (cell->future_fe_index_set() == true) fe_transfer->persisting_cells_fe_index.insert( {cell, cell->future_fe_index()}); @@ -1900,7 +1900,7 @@ namespace internal { const auto &fe_transfer = dof_handler.active_fe_index_transfer; - // Set active_fe_indices on persisting cells. + // Set active FE indices on persisting cells. for (const auto &persist : fe_transfer->persisting_cells_fe_index) { const auto &cell = persist.first; @@ -1912,7 +1912,7 @@ namespace internal } } - // Distribute active_fe_indices from all refined cells on their + // Distribute active FE indices from all refined cells on their // respective children. for (const auto &refine : fe_transfer->refined_cells_fe_index) { @@ -1926,7 +1926,7 @@ namespace internal } } - // Set active_fe_indices on coarsened cells that have been determined + // Set active FE indices on coarsened cells that have been determined // before the actual coarsening happened. for (const auto &coarsen : fe_transfer->coarsened_cells_fe_index) { @@ -1940,7 +1940,7 @@ namespace internal /** * Coarsening strategy for the CellDataTransfer object responsible for - * transferring the active_fe_index of each cell on + * transferring the active FE index of each cell on * parallel::distributed::Triangulation objects that have been refined. * * A finite element index needs to be determined for the (not yet @@ -2440,7 +2440,7 @@ DoFHandler::set_fe(const hp::FECollection &ff) this->hp_cell_future_fe_indices.shrink_to_fit(); } - // re-enabling hp-mode is not permitted since the active and future fe + // re-enabling hp-mode is not permitted since the active and future FE // tables are no longer available AssertThrow( hp_capability_enabled || !contains_multiple_fes, @@ -2451,13 +2451,13 @@ DoFHandler::set_fe(const hp::FECollection &ff) if (hp_capability_enabled) { - // make sure every processor knows the active_fe_indices + // make sure every processor knows the active FE indices // on both its own cells and all ghost cells dealii::internal::hp::DoFHandlerImplementation::Implementation:: communicate_active_fe_indices(*this); - // make sure that the fe collection is large enough to - // cover all fe indices presently in use on the mesh + // make sure that the FE collection is large enough to + // cover all FE indices presently in use on the mesh for (const auto &cell : this->active_cell_iterators()) if (!cell->is_artificial()) Assert(cell->active_fe_index() < this->fe_collection.size(), @@ -2519,7 +2519,7 @@ DoFHandler::distribute_dofs( this->hp_cell_future_fe_indices.shrink_to_fit(); } - // re-enabling hp-mode is not permitted since the active and future fe + // re-enabling hp-mode is not permitted since the active and future FE // tables are no longer available AssertThrow( hp_capability_enabled || !contains_multiple_fes, @@ -2534,14 +2534,14 @@ DoFHandler::distribute_dofs( // if (hp_capability_enabled) { - // make sure every processor knows the active_fe_indices + // make sure every processor knows the active FE indices // on both its own cells and all ghost cells internal::hp::DoFHandlerImplementation::Implementation:: communicate_active_fe_indices(*this); #ifdef DEBUG - // make sure that the fe collection is large enough to - // cover all fe indices presently in use on the mesh + // make sure that the FE collection is large enough to + // cover all FE indices presently in use on the mesh for (const auto &cell : this->active_cell_iterators()) { if (!cell->is_artificial()) @@ -3043,7 +3043,7 @@ DoFHandler::connect_to_triangulation_signals() [this]() { this->create_active_fe_table(); })); // attach corresponding callback functions dealing with the transfer of - // active_fe_indices depending on the type of triangulation + // active FE indices depending on the type of triangulation if (dynamic_cast< const dealii::parallel::DistributedTriangulationBase *>( &this->get_triangulation())) @@ -3123,7 +3123,7 @@ DoFHandler::create_active_fe_table() this->hp_cell_future_fe_indices.resize(this->tria->n_levels()); // then make sure that on each level we have the appropriate size - // of active_fe_indices; preset them to zero, i.e. the default FE + // of active FE indices; preset them to zero, i.e. the default FE for (unsigned int level = 0; level < this->hp_cell_future_fe_indices.size(); ++level) { @@ -3137,7 +3137,7 @@ DoFHandler::create_active_fe_table() } else { - // Either the active_fe_indices have size zero because + // Either the active FE indices have size zero because // they were just created, or the correct size. Other // sizes indicate that something went wrong. Assert(this->hp_cell_active_fe_indices[level].size() == @@ -3148,7 +3148,7 @@ DoFHandler::create_active_fe_table() } // it may be that the previous table was compressed; in that - // case, restore the correct active_fe_index. the fact that + // case, restore the correct active FE index. the fact that // this no longer matches the indices in the table is of no // importance because the current function is called at a // point where we have to recreate the dof_indices tables in @@ -3183,13 +3183,13 @@ DoFHandler::update_active_fe_table() for (unsigned int i = 0; i < this->hp_cell_future_fe_indices.size(); ++i) { - // Resize active_fe_indices vectors. Use zero indicator to extend. + // Resize active FE indices vectors. Use zero indicator to extend. this->hp_cell_active_fe_indices[i].resize(this->tria->n_raw_cells(i), 0); - // Resize future_fe_indices vectors. Make sure that all - // future_fe_indices have been cleared after refinement happened. + // Resize future FE indices vectors. Make sure that all + // future FE indices have been cleared after refinement happened. // - // We have used future_fe_indices to update all active_fe_indices + // We have used future FE indices to update all active FE indices // before refinement happened, thus we are safe to clear them now. this->hp_cell_future_fe_indices[i].assign(this->tria->n_raw_cells(i), invalid_active_fe_index); @@ -3233,12 +3233,12 @@ DoFHandler::pre_distributed_transfer_action() active_fe_index_transfer = std::make_unique(); // If we work on a p::d::Triangulation, we have to transfer all - // active_fe_indices since ownership of cells may change. We will + // active FE indices since ownership of cells may change. We will // use our p::d::CellDataTransfer member to achieve this. Further, // we prepare the values in such a way that they will correspond to - // the active_fe_indices on the new mesh. + // the active FE indices on the new mesh. - // Gather all current future_fe_indices. + // Gather all current future FE indices. active_fe_index_transfer->active_fe_indices.resize( get_triangulation().n_active_cells(), numbers::invalid_unsigned_int); @@ -3289,7 +3289,7 @@ DoFHandler::post_transfer_action() dealii::internal::hp::DoFHandlerImplementation::Implementation:: distribute_fe_indices_on_refined_cells(*this); - // We have to distribute the information about active_fe_indices + // We have to distribute the information about active FE indices // of all cells (including the artificial ones) on all processors, // if a parallel::shared::Triangulation has been used. dealii::internal::hp::DoFHandlerImplementation::Implementation:: @@ -3312,17 +3312,17 @@ DoFHandler::post_distributed_transfer_action() Assert(this->active_fe_index_transfer != nullptr, ExcInternalError()); - // Unpack active_fe_indices. + // Unpack active FE indices. this->active_fe_index_transfer->active_fe_indices.resize( this->get_triangulation().n_active_cells(), numbers::invalid_unsigned_int); this->active_fe_index_transfer->cell_data_transfer->unpack( this->active_fe_index_transfer->active_fe_indices); - // Update all locally owned active_fe_indices. + // Update all locally owned active FE indices. this->set_active_fe_indices( this->active_fe_index_transfer->active_fe_indices); - // Update active_fe_indices on ghost cells. + // Update active FE indices on ghost cells. dealii::internal::hp::DoFHandlerImplementation::Implementation:: communicate_active_fe_indices(*this); @@ -3378,9 +3378,9 @@ DoFHandler::prepare_for_serialization_of_active_fe_indices() }); // If we work on a p::d::Triangulation, we have to transfer all - // active fe indices since ownership of cells may change. + // active FE indices since ownership of cells may change. - // Gather all current active_fe_indices + // Gather all current active FE indices get_active_fe_indices(active_fe_index_transfer->active_fe_indices); // Attach to transfer object @@ -3435,16 +3435,16 @@ DoFHandler::deserialize_active_fe_indices() fe_collection); }); - // Unpack active_fe_indices. + // Unpack active FE indices. active_fe_index_transfer->active_fe_indices.resize( get_triangulation().n_active_cells(), numbers::invalid_unsigned_int); active_fe_index_transfer->cell_data_transfer->deserialize( active_fe_index_transfer->active_fe_indices); - // Update all locally owned active_fe_indices. + // Update all locally owned active FE indices. set_active_fe_indices(active_fe_index_transfer->active_fe_indices); - // Update active_fe_indices on ghost cells. + // Update active FE indices on ghost cells. dealii::internal::hp::DoFHandlerImplementation::Implementation:: communicate_active_fe_indices(*this); diff --git a/source/dofs/dof_handler_policy.cc b/source/dofs/dof_handler_policy.cc index 62f5531d9f..1a0b4d583e 100644 --- a/source/dofs/dof_handler_policy.cc +++ b/source/dofs/dof_handler_policy.cc @@ -223,7 +223,7 @@ namespace internal // Note: we may wish to have something here similar to what // we do for lines and quads, namely that we only identify - // dofs for any fe towards the most dominating one. however, + // dofs for any FE towards the most dominating one. however, // it is not clear whether this is actually necessary for // vertices at all, I can't think of a finite element that // would make that necessary... @@ -297,7 +297,7 @@ namespace internal // are not yet constrained to anything else, // except for to each other. use the rule that // we will always constrain the dof with the - // higher fe index to the one with the lower, + // higher FE index to the one with the lower, // to avoid circular reasoning. for (const auto &identity : identities) { @@ -1070,7 +1070,7 @@ namespace internal // Note: we may wish to have something here similar to what // we do for lines and quads, namely that we only identify - // dofs for any fe towards the most dominating one. however, + // dofs for any FE towards the most dominating one. however, // it is not clear whether this is actually necessary for // vertices at all, I can't think of a finite element that // would make that necessary... @@ -1157,7 +1157,7 @@ namespace internal // are not yet constrained to anything else, // except for to each other. use the rule that // we will always constrain the dof with the - // higher fe index to the one with the lower, + // higher FE index to the one with the lower, // to avoid circular reasoning. for (const auto &identity : identities) { @@ -1186,7 +1186,7 @@ namespace internal // we need to work on. // // all degrees of freedom belonging to - // dominating fe indices or to a processor + // dominating FE indices or to a processor // with a higher rank have been set at this // point (either in Phase 2, or after the // first ghost exchange in Phase 5). thus, @@ -1459,7 +1459,7 @@ namespace internal // we need to work on. // // all degrees of freedom belonging to - // dominating fe indices or to a processor + // dominating FE indices or to a processor // with a higher rank have been set at this // point (either in Phase 2, or after the // first ghost exchange in Phase 5). thus, @@ -1614,7 +1614,7 @@ namespace internal // we need to work on. // // all degrees of freedom belonging to - // dominating fe indices or to a processor with + // dominating FE indices or to a processor with // a higher rank have been set at this point // (either in Phase 2, or after the first ghost // exchange in Phase 5). thus, we only have to @@ -1935,7 +1935,7 @@ namespace internal // the previous indices were all valid. this really should // be the case: we allocated space for these vertex dofs, // i.e., at least one adjacent cell has a valid - // active_fe_index, so there are DoFs that really live + // active FE index, so there are DoFs that really live // on this vertex. if check_validity is set, then we // must make sure that they have been set to something // useful @@ -3919,7 +3919,7 @@ namespace internal // If the DoFHandler has hp-capabilities enabled, then we may have // received valid indices of degrees of freedom that are dominated - // by a fe object adjacent to a ghost interface. thus, we overwrite + // by a FE object adjacent to a ghost interface. thus, we overwrite // the remaining invalid indices with the valid ones in this step. Implementation::merge_invalid_dof_indices_on_ghost_interfaces( *dof_handler); @@ -4432,7 +4432,7 @@ namespace internal // if the DoFHandler has hp-capabilities then we may have // received valid indices of degrees of freedom that are - // dominated by a fe object adjacent to a ghost interface. + // dominated by a FE object adjacent to a ghost interface. // thus, we overwrite the remaining invalid indices with the // valid ones in this step. Implementation::merge_invalid_dof_indices_on_ghost_interfaces( diff --git a/source/dofs/dof_tools.cc b/source/dofs/dof_tools.cc index 773eec8ed4..55d820ce8c 100644 --- a/source/dofs/dof_tools.cc +++ b/source/dofs/dof_tools.cc @@ -701,7 +701,7 @@ namespace DoFTools // non-primitive, but use usual convention (see docs) { // first get at the cell-global number of a face dof, - // to ask the fe certain questions + // to ask the FE certain questions const unsigned int cell_index = (dim == 1 ? i : @@ -2201,7 +2201,7 @@ namespace DoFTools for (unsigned int fe_index = 0; fe_index < fe_collection.size(); ++fe_index) { - // check whether every fe in the collection has support points + // check whether every FE in the collection has support points Assert(fe_collection[fe_index].has_support_points(), typename FiniteElement::ExcFEHasNoSupportPoints()); q_coll_dummy.push_back(Quadrature( diff --git a/source/dofs/dof_tools_constraints.cc b/source/dofs/dof_tools_constraints.cc index d1998c278f..d249d23b29 100644 --- a/source/dofs/dof_tools_constraints.cc +++ b/source/dofs/dof_tools_constraints.cc @@ -646,7 +646,7 @@ namespace DoFTools for (const unsigned int face : cell->face_indices()) if (cell->face(face)->has_children()) { - // in any case, faces can have at most two active fe indices, + // in any case, faces can have at most two active FE indices, // but here the face can have only one (namely the same as that // from the cell we're sitting on), and each of the children can // have only one as well. check this @@ -664,7 +664,7 @@ namespace DoFTools ExcInternalError()); // right now, all that is implemented is the case that both - // sides use the same fe + // sides use the same FE for (unsigned int c = 0; c < cell->face(face)->n_children(); ++c) if (!cell->neighbor_child_on_subface(face, c) @@ -747,7 +747,7 @@ namespace DoFTools else { // this face has no children, but it could still be that it is - // shared by two cells that use a different fe index. check a + // shared by two cells that use a different FE index. check a // couple of things, but ignore the case that the neighbor is an // artificial cell if (!cell->at_boundary(face) && @@ -808,7 +808,7 @@ namespace DoFTools RefinementCase::isotropic_refinement, ExcNotImplemented()); - // in any case, faces can have at most two active fe indices, + // in any case, faces can have at most two active FE indices, // but here the face can have only one (namely the same as that // from the cell we're sitting on), and each of the children can // have only one as well. check this @@ -825,7 +825,7 @@ namespace DoFTools // right now, all that is implemented is the case that both // sides use the same fe, and not only that but also that all - // lines bounding this face and the children have the same fe + // lines bounding this face and the children have the same FE for (unsigned int c = 0; c < cell->face(face)->n_children(); ++c) if (!cell->neighbor_child_on_subface(face, c) @@ -991,7 +991,7 @@ namespace DoFTools else { // this face has no children, but it could still be that it is - // shared by two cells that use a different fe index. check a + // shared by two cells that use a different FE index. check a // couple of things, but ignore the case that the neighbor is an // artificial cell if (!cell->at_boundary(face) && @@ -1086,7 +1086,7 @@ namespace DoFTools // so now we've found a face of an active cell that has // children. that means that there are hanging nodes here. - // in any case, faces can have at most two sets of active fe + // in any case, faces can have at most two sets of active FE // indices, but here the face can have only one (namely the same // as that from the cell we're sitting on), and each of the // children can have only one as well. check this @@ -1466,7 +1466,7 @@ namespace DoFTools else { // this face has no children, but it could still be that it is - // shared by two cells that use a different fe index + // shared by two cells that use a different FE index Assert(cell->face(face)->fe_index_is_active( cell->active_fe_index()) == true, ExcInternalError()); @@ -1474,12 +1474,12 @@ namespace DoFTools // see if there is a neighbor that is an artificial cell. in // that case, we're not interested in this interface. we test // this case first since artificial cells may not have an - // active_fe_index set, etc + // active FE index set, etc if (!cell->at_boundary(face) && cell->neighbor(face)->is_artificial()) continue; - // Only if there is a neighbor with a different active_fe_index + // Only if there is a neighbor with a different active FE index // and the same h-level, some action has to be taken. if ((dof_handler.has_hp_capabilities()) && !cell->face(face)->at_boundary() && diff --git a/source/fe/fe_bernstein.cc b/source/fe/fe_bernstein.cc index ee1c0f1a69..635e92e65f 100644 --- a/source/fe/fe_bernstein.cc +++ b/source/fe/fe_bernstein.cc @@ -260,7 +260,7 @@ std::vector> FE_Bernstein::hp_line_dof_identities( const FiniteElement &) const { - // Since this fe is not interpolatory but on the vertices, we can + // Since this FE is not interpolatory but on the vertices, we can // not identify dofs on lines and on quads even if there are dofs // on lines and on quads. // @@ -276,7 +276,7 @@ FE_Bernstein::hp_quad_dof_identities( const FiniteElement &, const unsigned int) const { - // Since this fe is not interpolatory but on the vertices, we can + // Since this FE is not interpolatory but on the vertices, we can // not identify dofs on lines and on quads even if there are dofs // on lines and on quads. // diff --git a/source/fe/fe_enriched.cc b/source/fe/fe_enriched.cc index f470b2e008..4ecc154a16 100644 --- a/source/fe/fe_enriched.cc +++ b/source/fe/fe_enriched.cc @@ -428,7 +428,7 @@ FE_Enriched::initialize( Assert(fes.size() == multiplicities.size(), ExcDimensionMismatch(fes.size(), multiplicities.size())); - // Note that we need to skip every fe with multiplicity 0 in the following + // Note that we need to skip every FE with multiplicity 0 in the following // block of code this->base_to_block_indices.reinit(0, 0); @@ -475,7 +475,7 @@ FE_Enriched::initialize( // However, functions like interpolate_boundary_values() need all FEs inside // FECollection to be able to provide support points irrespectively whether // this FE sits on the boundary or not. Thus for moment just copy support - // points from fe system: + // points from FE system: { this->unit_support_points = fe_system->unit_support_points; this->unit_face_support_points = fe_system->unit_face_support_points; @@ -1296,8 +1296,8 @@ namespace ColorEnriched * on adjacent cells, an enriched FE [0 0 1] should exist and is * found as the least dominating finite element for the two cells by * DoFTools::make_hanging_node_constraints, using the above mentioned - * hp::FECollection functions. Denoting the fe set in adjacent cells as - * {1,3} and {2,3}, this implies that an fe set {3} needs to be added! + * hp::FECollection functions. Denoting the FE set in adjacent cells as + * {1,3} and {2,3}, this implies that an FE set {3} needs to be added! * Based on the predicate configuration, this may not be automatically * done without the following special treatment. */ @@ -1319,10 +1319,10 @@ namespace ColorEnriched const auto nbr_fe_index = cell->neighbor(face)->active_fe_index(); - // find corresponding fe set + // find corresponding FE set const auto nbr_fe_set = fe_sets.at(nbr_fe_index); - // find intersection of the fe sets: fe_set and nbr_fe_set + // find intersection of the FE sets: fe_set and nbr_fe_set std::set intersection_set; std::set_intersection( fe_set.begin(), diff --git a/source/fe/fe_nothing.cc b/source/fe/fe_nothing.cc index 721f34f8a8..8f786e39c5 100644 --- a/source/fe/fe_nothing.cc +++ b/source/fe/fe_nothing.cc @@ -220,7 +220,7 @@ FE_Nothing::compare_for_domination( // if it does and the other is FE_Nothing, either can dominate return FiniteElementDomination::either_element_can_dominate; else - // otherwise we dominate whatever fe is provided + // otherwise we dominate whatever FE is provided return FiniteElementDomination::this_element_dominates; } diff --git a/source/fe/fe_system.cc b/source/fe/fe_system.cc index de8169987e..dc12e9a2eb 100644 --- a/source/fe/fe_system.cc +++ b/source/fe/fe_system.cc @@ -1625,7 +1625,7 @@ FESystem::initialize( Assert(count_nonzeros(multiplicities) > 0, ExcMessage("You only passed FiniteElements with multiplicity 0.")); - // Note that we need to skip every fe with multiplicity 0 in the following + // Note that we need to skip every FE with multiplicity 0 in the following // block of code this->base_to_block_indices.reinit(0, 0); diff --git a/source/numerics/derivative_approximation.cc b/source/numerics/derivative_approximation.cc index 32822082ef..f8b75fb40e 100644 --- a/source/numerics/derivative_approximation.cc +++ b/source/numerics/derivative_approximation.cc @@ -787,7 +787,7 @@ namespace DerivativeApproximation // derivatives typename DerivativeDescription::Derivative projected_derivative; - // reinit fe values object... + // reinit FE values object... x_fe_midpoint_value.reinit(cell); const FEValues &fe_midpoint_value = x_fe_midpoint_value.get_present_fe_values(); @@ -825,7 +825,7 @@ namespace DerivativeApproximation { const auto neighbor = *neighbor_ptr; - // reinit fe values object... + // reinit FE values object... x_fe_midpoint_value.reinit(neighbor); const FEValues &neighbor_fe_midpoint_value = x_fe_midpoint_value.get_present_fe_values(); diff --git a/source/numerics/point_value_history.cc b/source/numerics/point_value_history.cc index 7fe5560a53..2c190caf41 100644 --- a/source/numerics/point_value_history.cc +++ b/source/numerics/point_value_history.cc @@ -278,7 +278,7 @@ PointValueHistory::add_point(const Point &location) // the requested point for all finite // element components lie in the same cell. // this could possibly be violated if - // components use different fe orders, + // components use different FE orders, // requested points are on the edge or // vertex of a cell and we are unlucky with // floating point rounding. Worst case diff --git a/source/numerics/solution_transfer.cc b/source/numerics/solution_transfer.cc index 1d6b1d147f..585c15f3dd 100644 --- a/source/numerics/solution_transfer.cc +++ b/source/numerics/solution_transfer.cc @@ -505,7 +505,7 @@ SolutionTransfer::interpolate( { // make sure that the size of the stored indices is the same // as dofs_per_cell. this is kind of a test if we use the same - // fe in the hp-case. to really do that test we would have to + // FE in the hp-case. to really do that test we would have to // store the fe_index of all cells const Vector *data = nullptr; const unsigned int active_fe_index = cell->active_fe_index(); diff --git a/tests/bits/fe_tools_09.cc b/tests/bits/fe_tools_09.cc index 14295bed50..cf2401586c 100644 --- a/tests/bits/fe_tools_09.cc +++ b/tests/bits/fe_tools_09.cc @@ -29,8 +29,8 @@ template void check_this(const FiniteElement &fe1, const FiniteElement &fe2) { - // check that the name of the fe - // and the name of the fe that we + // check that the name of the FE + // and the name of the FE that we // re-create from this name are // identitical. this is also a // pretty good indication that the diff --git a/tests/bits/fe_tools_10.cc b/tests/bits/fe_tools_10.cc index 59758c7ddf..1a00e2d3f6 100644 --- a/tests/bits/fe_tools_10.cc +++ b/tests/bits/fe_tools_10.cc @@ -51,8 +51,8 @@ template void check_this(const FiniteElement &fe1, const FiniteElement &fe2) { - // check that the name of the fe - // and the name of the fe that we + // check that the name of the FE + // and the name of the FE that we // re-create from this name are // identitical. this is also a // pretty good indication that the diff --git a/tests/bits/fe_tools_11.cc b/tests/bits/fe_tools_11.cc index 73a9059c0a..833ba6e6fd 100644 --- a/tests/bits/fe_tools_11.cc +++ b/tests/bits/fe_tools_11.cc @@ -50,8 +50,8 @@ template void check_this(const FiniteElement &fe1, const FiniteElement &fe2) { - // check that the name of the fe - // and the name of the fe that we + // check that the name of the FE + // and the name of the FE that we // re-create from this name are // identitical. this is also a // pretty good indication that the diff --git a/tests/bits/fe_tools_cpfqpm_01.cc b/tests/bits/fe_tools_cpfqpm_01.cc index 1cb8ef0e67..b9e3037082 100644 --- a/tests/bits/fe_tools_cpfqpm_01.cc +++ b/tests/bits/fe_tools_cpfqpm_01.cc @@ -45,7 +45,7 @@ check_this(const FiniteElement &fe, const FiniteElement & /*fe2*/) if (fe.n_components() != 1) return; - // ignore this check if this fe has already + // ignore this check if this FE has already // been treated static std::set already_checked; if (already_checked.find(fe.get_name()) != already_checked.end()) diff --git a/tests/bits/fe_tools_cpfqpm_02.cc b/tests/bits/fe_tools_cpfqpm_02.cc index b7a56809b7..3b2f06c2fa 100644 --- a/tests/bits/fe_tools_cpfqpm_02.cc +++ b/tests/bits/fe_tools_cpfqpm_02.cc @@ -44,7 +44,7 @@ check_this(const FiniteElement &fe, const FiniteElement & /*fe2*/) if (fe.n_components() != 1) return; - // ignore this check if this fe has already + // ignore this check if this FE has already // been treated static std::set already_checked; if (already_checked.find(fe.get_name()) != already_checked.end()) diff --git a/tests/bits/fe_tools_cpfqpm_03.cc b/tests/bits/fe_tools_cpfqpm_03.cc index 5115894aba..cea83da1ed 100644 --- a/tests/bits/fe_tools_cpfqpm_03.cc +++ b/tests/bits/fe_tools_cpfqpm_03.cc @@ -45,7 +45,7 @@ check_this(const FiniteElement &fe, const FiniteElement & /*fe2*/) if (fe.n_components() != 1) return; - // ignore this check if this fe has already + // ignore this check if this FE has already // been treated static std::set already_checked; if (already_checked.find(fe.get_name()) != already_checked.end()) diff --git a/tests/bits/fe_tools_cpfqpm_04.cc b/tests/bits/fe_tools_cpfqpm_04.cc index 6575dc41d2..44040c6c50 100644 --- a/tests/bits/fe_tools_cpfqpm_04.cc +++ b/tests/bits/fe_tools_cpfqpm_04.cc @@ -44,7 +44,7 @@ check_this(const FiniteElement &fe, const FiniteElement & /*fe2*/) if (fe.n_components() != 1) return; - // ignore this check if this fe has already + // ignore this check if this FE has already // been treated static std::set already_checked; if (already_checked.find(fe.get_name()) != already_checked.end()) diff --git a/tests/bits/fe_tools_cpfqpm_05.cc b/tests/bits/fe_tools_cpfqpm_05.cc index d33e8854be..a14fca62cd 100644 --- a/tests/bits/fe_tools_cpfqpm_05.cc +++ b/tests/bits/fe_tools_cpfqpm_05.cc @@ -90,7 +90,7 @@ check_this(const FiniteElement &fe, if (fe.n_components() != 1) return; - // ignore this check if this fe has already + // ignore this check if this FE has already // been treated static std::set already_checked; if (already_checked.find(fe.get_name()) != already_checked.end()) diff --git a/tests/dofs/dof_tools_10.cc b/tests/dofs/dof_tools_10.cc index 8bac2814e5..da251762af 100644 --- a/tests/dofs/dof_tools_10.cc +++ b/tests/dofs/dof_tools_10.cc @@ -31,7 +31,7 @@ template void check_this(const DoFHandler &dof_handler) { - // don't check if fe has no support + // don't check if FE has no support // points if (dof_handler.get_fe().get_unit_support_points().size() == 0) return; diff --git a/tests/fe/fe_enriched_color_03.cc b/tests/fe/fe_enriched_color_03.cc index 270a806f30..863f54dd62 100644 --- a/tests/fe/fe_enriched_color_03.cc +++ b/tests/fe/fe_enriched_color_03.cc @@ -16,7 +16,7 @@ /* * Test function - ColorEnriched::internal::set_cellwise_color_set_and_fe_index * for a set of predicates. - * Check for each cell, if appropriate fe index and color-index map is set. + * Check for each cell, if appropriate FE index and color-index map is set. * Color-index map associates different colors of different enrichment * functions with corresponding enrichment function index. */ @@ -123,13 +123,13 @@ main(int argc, char **argv) fe_sets); /* - * Run through active cells to check fe index, colors of + * Run through active cells to check FE index, colors of * enrichment functions associated with it. * - * A unique color set corresponds to an fe index. + * A unique color set corresponds to an FE index. * - * Eg: If an fe index 1 corresponds to color set {2,3}, - * means that a cell with fe index 1 has enrichment functions + * Eg: If an FE index 1 corresponds to color set {2,3}, + * means that a cell with FE index 1 has enrichment functions * which are colored 2 and 3. Here different enrichment function * have same color 2 but for a given cell only one of them would * be relevant. So all additional information we need is which @@ -162,7 +162,7 @@ main(int argc, char **argv) << color_predicate_pair.second << "):"; } - // For a cell, print fe active index and corresponding fe set. + // For a cell, print FE active index and corresponding FE set. //{1,2} indicates 2 enrichment functions of color 1 and 2 are relevant. deallog << ":fe_active_index:" << cell->active_fe_index() << ":fe_set:"; for (auto fe_set_element : fe_sets[cell->active_fe_index()]) diff --git a/tests/fe/fe_enriched_color_05.cc b/tests/fe/fe_enriched_color_05.cc index a737d0e687..79a65fc38f 100644 --- a/tests/fe/fe_enriched_color_05.cc +++ b/tests/fe/fe_enriched_color_05.cc @@ -233,7 +233,7 @@ main(int argc, char **argv) fe_nothing, fe_collection); - // print all the different fe sets needed by different cells + // print all the different FE sets needed by different cells deallog << "fe sets:" << std::endl; for (auto fe_set : fe_sets) { diff --git a/tests/fe/fe_enriched_color_06.cc b/tests/fe/fe_enriched_color_06.cc index 61e15e1d8a..e846f62daa 100644 --- a/tests/fe/fe_enriched_color_06.cc +++ b/tests/fe/fe_enriched_color_06.cc @@ -118,7 +118,7 @@ main(int argc, char **argv) vec_enrichments.push_back(std::make_shared>(func)); } - // Construct helper class to construct fe collection + // Construct helper class to construct FE collection FE_Q fe_base(2); FE_Q fe_enriched(1); static ColorEnriched::Helper fe_space(fe_base, diff --git a/tests/fe/fe_enriched_color_07.cc b/tests/fe/fe_enriched_color_07.cc index 91bd139807..8356942c7d 100644 --- a/tests/fe/fe_enriched_color_07.cc +++ b/tests/fe/fe_enriched_color_07.cc @@ -1350,7 +1350,7 @@ LaplaceProblem::build_fe_space() { pcout << "...start print fe indices" << std::endl; - // print fe index + // print FE index const std::string base_filename = "fe_indices" + dealii::Utilities::int_to_string(dim) + "_p" + dealii::Utilities::int_to_string(0); @@ -1739,7 +1739,7 @@ LaplaceProblem::run() pcout << "...run problem" << std::endl; double norm_soln_old(0), norm_rel_change_old(1); - // Run making grids and building fe space only once. + // Run making grids and building FE space only once. initialize(); build_fe_space(); diff --git a/tests/fe/fe_enriched_color_08.cc b/tests/fe/fe_enriched_color_08.cc index dc687540e0..618d4cf554 100644 --- a/tests/fe/fe_enriched_color_08.cc +++ b/tests/fe/fe_enriched_color_08.cc @@ -247,7 +247,7 @@ main(int argc, char **argv) std::make_shared>(func)); } - // Construct helper class to construct fe collection + // Construct helper class to construct FE collection FE_Q fe_base(2); FE_Q fe_enriched(1); diff --git a/tests/fe/fe_enriched_step-36.cc b/tests/fe/fe_enriched_step-36.cc index 64b41895bc..d8918c9d34 100644 --- a/tests/fe/fe_enriched_step-36.cc +++ b/tests/fe/fe_enriched_step-36.cc @@ -246,7 +246,7 @@ namespace Step36 fe_collection.push_back( FE_Enriched(FE_Q(2), FE_Q(1), &enrichment)); - // assign fe index in the constructor so that FE/FE+POU is determined + // assign FE index in the constructor so that FE/FE+POU is determined // on the coarsest mesh to avoid issues like // +---------+----+----+ // | | fe | | diff --git a/tests/fe/fe_enriched_step-36b.cc b/tests/fe/fe_enriched_step-36b.cc index a306ec268c..cc386abea1 100644 --- a/tests/fe/fe_enriched_step-36b.cc +++ b/tests/fe/fe_enriched_step-36b.cc @@ -256,7 +256,7 @@ namespace Step36 // enriched elements (active_fe_index==1): fe_collection.push_back(FESystem(FE_Q(2), 1, FE_Q(1), 1)); - // assign fe index in the constructor so that FE/FE+POU is determined + // assign FE index in the constructor so that FE/FE+POU is determined // on the coarsest mesh to avoid issues like // +---------+----+----+ // | | fe | | diff --git a/tests/fe/fe_nedelec_sz_non_rect_face.cc b/tests/fe/fe_nedelec_sz_non_rect_face.cc index 567713cd92..e032441ff9 100644 --- a/tests/fe/fe_nedelec_sz_non_rect_face.cc +++ b/tests/fe/fe_nedelec_sz_non_rect_face.cc @@ -251,7 +251,7 @@ namespace Maxwell // Store computed values at quad points: fe_values[E_re].get_function_values(solution, sol); - // Calc values of curlE from fe solution: + // Calc values of curlE from FE solution: cell->get_dof_indices(local_dof_indices); // Loop over quad points to calculate solution: for (const auto q_point : fe_values.quadrature_point_indices()) diff --git a/tests/fe/injection_common.h b/tests/fe/injection_common.h index 60256e6dbd..65bbbf999d 100644 --- a/tests/fe/injection_common.h +++ b/tests/fe/injection_common.h @@ -80,7 +80,7 @@ do_check(const FiniteElement &coarse_fe, const FiniteElement &fine_fe) } // check 2: first to finer cells, - // then to finer fe + // then to finer FE { FullMatrix tmp1(coarse_fe.dofs_per_cell, coarse_fe.dofs_per_cell); diff --git a/tests/fe/multiple_redistribute_dofs_01.cc b/tests/fe/multiple_redistribute_dofs_01.cc index 3d59c9f4c7..77afe618ab 100644 --- a/tests/fe/multiple_redistribute_dofs_01.cc +++ b/tests/fe/multiple_redistribute_dofs_01.cc @@ -50,7 +50,7 @@ test() DoFHandler dh(tria); dh.distribute_dofs(fe); - // This stores a pointer to the fe in dh. + // This stores a pointer to the FE in dh. FEValues fe_v(dh.get_fe(), QGauss(1), update_values); tria.refine_global(1); diff --git a/tests/fe/multiple_redistribute_dofs_02.cc b/tests/fe/multiple_redistribute_dofs_02.cc index d466074277..42f8c35e6f 100644 --- a/tests/fe/multiple_redistribute_dofs_02.cc +++ b/tests/fe/multiple_redistribute_dofs_02.cc @@ -51,7 +51,7 @@ test() DoFHandler dh(tria); dh.distribute_dofs(fe_collection); - // This stores a pointer to the fe in dh. + // This stores a pointer to the FE in dh. hp::FEValues fe_v(dh.get_fe_collection(), hp::QCollection(QGauss(1)), update_values); diff --git a/tests/fe/nedelec_crash_hp.cc b/tests/fe/nedelec_crash_hp.cc index ef8d46a992..598be2871d 100644 --- a/tests/fe/nedelec_crash_hp.cc +++ b/tests/fe/nedelec_crash_hp.cc @@ -83,7 +83,7 @@ test() deallog << "Testing " << fe[i].get_name() << " vs. " << fe[j].get_name() << std::endl; - // set fe on coarse cell to 'i', on + // set FE on coarse cell to 'i', on // all fine cells to 'j' typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(); diff --git a/tests/fe/nedelec_non_rect_face.cc b/tests/fe/nedelec_non_rect_face.cc index 36c750c6f0..638d5da022 100644 --- a/tests/fe/nedelec_non_rect_face.cc +++ b/tests/fe/nedelec_non_rect_face.cc @@ -252,7 +252,7 @@ namespace Maxwell // Store computed values at quad points: fe_values[E_re].get_function_values(solution, sol); - // Calc values of curlE from fe solution: + // Calc values of curlE from FE solution: cell->get_dof_indices(local_dof_indices); // Loop over quad points to calculate solution: for (const auto q_point : fe_values.quadrature_point_indices()) diff --git a/tests/grid/grid_tools_extract_used_vertices_03.cc b/tests/grid/grid_tools_extract_used_vertices_03.cc index eaf86935c2..31a762c614 100644 --- a/tests/grid/grid_tools_extract_used_vertices_03.cc +++ b/tests/grid/grid_tools_extract_used_vertices_03.cc @@ -40,7 +40,7 @@ test(const Point &p) GridGenerator::hyper_cube(tria); tria.refine_global(1); - // Vector fe + // Vector FE FESystem fe{FE_Q(1), spacedim}; DoFHandler dh(tria); dh.distribute_dofs(fe); diff --git a/tests/grid/grid_tools_find_closest_vertex_01.cc b/tests/grid/grid_tools_find_closest_vertex_01.cc index f69f2c4b52..ba573cbcd3 100644 --- a/tests/grid/grid_tools_find_closest_vertex_01.cc +++ b/tests/grid/grid_tools_find_closest_vertex_01.cc @@ -40,7 +40,7 @@ test(const Point &p) GridGenerator::hyper_cube(tria); tria.refine_global(1); - // Vector fe + // Vector FE FESystem fe{FE_Q(1), spacedim}; DoFHandler dh(tria); dh.distribute_dofs(fe); diff --git a/tests/grid/grid_tools_find_closest_vertex_02.cc b/tests/grid/grid_tools_find_closest_vertex_02.cc index 9859dd7568..3a5e4de627 100644 --- a/tests/grid/grid_tools_find_closest_vertex_02.cc +++ b/tests/grid/grid_tools_find_closest_vertex_02.cc @@ -40,7 +40,7 @@ test(const Point &p, double displacement) GridGenerator::hyper_cube(tria); tria.refine_global(); - // Vector fe + // Vector FE FESystem fe{FE_Q(1), spacedim}; DoFHandler dh(tria); dh.distribute_dofs(fe); diff --git a/tests/grid/grid_tools_halo_layer_04.cc b/tests/grid/grid_tools_halo_layer_04.cc index 8fd4c8a149..cb838440d5 100644 --- a/tests/grid/grid_tools_halo_layer_04.cc +++ b/tests/grid/grid_tools_halo_layer_04.cc @@ -114,7 +114,7 @@ test() write_vtk(dof_handler, filename.c_str()); } - // Compute a halo layer around active fe index 2 and set it to active fe index + // Compute a halo layer around active FE index 2 and set it to active FE index // 3 std::function predicate = IteratorFilters::ActiveFEIndexEqualTo(2, true); diff --git a/tests/grid/grid_tools_halo_layer_05.cc b/tests/grid/grid_tools_halo_layer_05.cc index 0394e4349a..08258d8a4b 100644 --- a/tests/grid/grid_tools_halo_layer_05.cc +++ b/tests/grid/grid_tools_halo_layer_05.cc @@ -119,7 +119,7 @@ test() write_vtk(dof_handler, filename.c_str()); } - // Compute a halo layer around active fe indices 2,3 and set it to active fe + // Compute a halo layer around active FE indices 2,3 and set it to active FE // index 4 std::set index_set; index_set.insert(2); diff --git a/tests/hp/crash_09.cc b/tests/hp/crash_09.cc index e114c77ec5..59316d67c4 100644 --- a/tests/hp/crash_09.cc +++ b/tests/hp/crash_09.cc @@ -116,7 +116,7 @@ main() // out the numbers of the dofs that // belong to the shared edge // (that's the one that has three - // different fe indices associated + // different FE indices associated // with it). note that there is // only one such line so we can // quit the loop once we find it diff --git a/tests/hp/crash_11.cc b/tests/hp/crash_11.cc index afc1f7f643..83ed24cc88 100644 --- a/tests/hp/crash_11.cc +++ b/tests/hp/crash_11.cc @@ -98,7 +98,7 @@ main() // out the numbers of the dofs that // belong to the shared edge // (that's the one that has four - // different fe indices associated + // different FE indices associated // with it). note that there is // only one such line so we can // quit the loop once we find it diff --git a/tests/hp/crash_12.cc b/tests/hp/crash_12.cc index 5d2ce3fd68..fe5365303b 100644 --- a/tests/hp/crash_12.cc +++ b/tests/hp/crash_12.cc @@ -20,7 +20,7 @@ // // this code in particular tests some compensating code in // dof_tools.cc, where we have to make sure that we select a suitable -// set of primary dofs. this is mostly trivial in 2d and for most fe +// set of primary dofs. this is mostly trivial in 2d and for most FE // combinations in 3d as well. the exceptions are that it doesn't work // as easily in 3d for the combinations Q4/Q3, Q5/Q3, and // Q5/Q4. Higher order finite elements in 3d will probably only @@ -91,7 +91,7 @@ test() deallog << "Testing " << fe[i].get_name() << " vs. " << fe[j].get_name() << std::endl; - // set fe on coarse cell to 'i', on + // set FE on coarse cell to 'i', on // all fine cells to 'j' typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(); diff --git a/tests/hp/crash_15.cc b/tests/hp/crash_15.cc index 8c9443bd0c..2d28efd72a 100644 --- a/tests/hp/crash_15.cc +++ b/tests/hp/crash_15.cc @@ -102,9 +102,9 @@ test() } - // if there are multiple active fe + // if there are multiple active FE // indices, make sure that all their - // fe indices were unified + // FE indices were unified for (unsigned int i = 0; i < cell->line(line)->n_active_fe_indices(); ++i) for (unsigned int j = i + 1; diff --git a/tests/hp/crash_20.cc b/tests/hp/crash_20.cc index 65738b2d5e..5b92cb53b3 100644 --- a/tests/hp/crash_20.cc +++ b/tests/hp/crash_20.cc @@ -16,8 +16,8 @@ // if the mesh is generated after the hp::DoFHandler is attached to the -// triangulation object, then we can't set active fe indices -- which is -// somewhat tragic since we have to assign active fe indices before we can +// triangulation object, then we can't set active FE indices -- which is +// somewhat tragic since we have to assign active FE indices before we can // call distribute_dofs // // originally, this problem was avoided because the hp::DoFHandler listens to diff --git a/tests/hp/create_rhs_01.cc b/tests/hp/create_rhs_01.cc index 552b933545..99ff83b956 100644 --- a/tests/hp/create_rhs_01.cc +++ b/tests/hp/create_rhs_01.cc @@ -63,7 +63,7 @@ test() DoFHandler<2> hp_dof_handler(triangulation); DoFHandler<2> hp_dof_handler2(triangulation); - // set different fe for testing + // set different FE for testing DoFHandler<2>::active_cell_iterator cell = hp_dof_handler.begin_active(), endc = hp_dof_handler.end(); diff --git a/tests/hp/fe_collection_05.cc b/tests/hp/fe_collection_05.cc index 849c51c0ab..ed1a306074 100644 --- a/tests/hp/fe_collection_05.cc +++ b/tests/hp/fe_collection_05.cc @@ -15,7 +15,7 @@ /* clang-format off */ -// find the least dominating fe from a set of fes on faces (codim=1). +// find the least dominating FE from a set of FEs on faces (codim=1). // for this task we concatenate the two functions // FECollection::find_common_subspace() and FECollection::find_dominated_fe(). // we test the results for the following collections: diff --git a/tests/hp/fe_collection_06.cc b/tests/hp/fe_collection_06.cc index b940318944..d833d549f4 100644 --- a/tests/hp/fe_collection_06.cc +++ b/tests/hp/fe_collection_06.cc @@ -15,7 +15,7 @@ /* clang-format off */ -// find the most dominating fe from a set of fes on faces (codim=1). +// find the most dominating FE from a set of FEs on faces (codim=1). // for this task we concatenate the two functions // FECollection::find_encapsulating_space() and FECollection::find_dominating_fe(). // we test the results for the following collections: diff --git a/tests/hp/fe_hierarchy.cc b/tests/hp/fe_hierarchy.cc index 185421afa4..7ccf54c407 100644 --- a/tests/hp/fe_hierarchy.cc +++ b/tests/hp/fe_hierarchy.cc @@ -35,7 +35,7 @@ test() while (fe_collection.size() < 3) { - // add dummy fe to collection + // add dummy FE to collection fe_collection.push_back(FE_Q(1)); deallog << "size:" << fe_collection.size() << std::endl; diff --git a/tests/hp/future_fe_indices.cc b/tests/hp/future_fe_indices.cc index f358edcb47..0f8c1734ce 100644 --- a/tests/hp/future_fe_indices.cc +++ b/tests/hp/future_fe_indices.cc @@ -15,7 +15,7 @@ -// check if future fe indices will be set correctly +// check if future FE indices will be set correctly #include diff --git a/tests/hp/get_interpolated_dof_values_01.debug.output b/tests/hp/get_interpolated_dof_values_01.debug.output index 800f428388..9a1b361bc6 100644 --- a/tests/hp/get_interpolated_dof_values_01.debug.output +++ b/tests/hp/get_interpolated_dof_values_01.debug.output @@ -2,12 +2,12 @@ DEAL::Yes, exception 1! DEAL::ExcMessage( "For DoFHandler objects in hp-mode, finite elements are only " "associated with active cells. Consequently, you can not ask " "for the active finite element on cells with children.") DEAL::Yes, exception 2! -DEAL::ExcMessage( "You cannot call this function on non-active cells " "of DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active_fe_index has been set.") +DEAL::ExcMessage( "You cannot call this function on non-active cells " "of DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active FE index has been set.") DEAL::Yes, exception 1! DEAL::ExcMessage( "For DoFHandler objects in hp-mode, finite elements are only " "associated with active cells. Consequently, you can not ask " "for the active finite element on cells with children.") DEAL::Yes, exception 2! -DEAL::ExcMessage( "You cannot call this function on non-active cells " "of DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active_fe_index has been set.") +DEAL::ExcMessage( "You cannot call this function on non-active cells " "of DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active FE index has been set.") DEAL::Yes, exception 1! DEAL::ExcMessage( "For DoFHandler objects in hp-mode, finite elements are only " "associated with active cells. Consequently, you can not ask " "for the active finite element on cells with children.") DEAL::Yes, exception 2! -DEAL::ExcMessage( "You cannot call this function on non-active cells " "of DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active_fe_index has been set.") +DEAL::ExcMessage( "You cannot call this function on non-active cells " "of DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active FE index has been set.") diff --git a/tests/hp/hp_constraints_common.h b/tests/hp/hp_constraints_common.h index 10918f767c..ccd669d8c2 100644 --- a/tests/hp/hp_constraints_common.h +++ b/tests/hp/hp_constraints_common.h @@ -369,7 +369,7 @@ test_interpolation_base(const hp::FECollection & fe, deallog << "Testing " << fe[fe1].get_name() << " vs. " << fe[fe2].get_name() << std::endl; - // set fe on coarse cell to 'i', on + // set FE on coarse cell to 'i', on // all fine cells to 'j' typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(); diff --git a/tests/hp/hp_constraints_common_no_support.h b/tests/hp/hp_constraints_common_no_support.h index d94968f377..7c6ecca2d2 100644 --- a/tests/hp/hp_constraints_common_no_support.h +++ b/tests/hp/hp_constraints_common_no_support.h @@ -14,7 +14,7 @@ // --------------------------------------------------------------------- -// common framework to check hp-constraints for fe without support points +// common framework to check hp-constraints for FE without support points #include #include @@ -365,7 +365,7 @@ test_interpolation_base(const hp::FECollection & fe, deallog << "Testing " << fe[fe1].get_name() << " vs. " << fe[fe2].get_name() << std::endl; - // set fe on coarse cell to 'i', on + // set FE on coarse cell to 'i', on // all fine cells to 'j' typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(); diff --git a/tests/hp/hp_q_hierarchical_constraints.cc b/tests/hp/hp_q_hierarchical_constraints.cc index 002975d150..296e69e7c0 100644 --- a/tests/hp/hp_q_hierarchical_constraints.cc +++ b/tests/hp/hp_q_hierarchical_constraints.cc @@ -72,7 +72,7 @@ test(const bool apply_constrains, const unsigned int hp) AffineConstraints constraints; // for boundary conditions - // populate fe system: + // populate FE system: fe.push_back(FE_Q_Hierarchical(2)); fe.push_back(FE_Q_Hierarchical(4)); @@ -82,7 +82,7 @@ test(const bool apply_constrains, const unsigned int hp) cell->set_active_fe_index(1); // need to distribute dofs before refinement, - // otherwise active fe index will not transfer to child cells + // otherwise active FE index will not transfer to child cells dof_handler.distribute_dofs(fe); // refine first cell (simple case) diff --git a/tests/hp/interpolate_nothing_02.cc b/tests/hp/interpolate_nothing_02.cc index bb0ad7026b..8261d15a45 100644 --- a/tests/hp/interpolate_nothing_02.cc +++ b/tests/hp/interpolate_nothing_02.cc @@ -166,7 +166,7 @@ diffusionMechanics::cell_is_in_omega2_domain( return (cell->material_id() == omega2_domain_id); } -// Set active fe indices in each sub-domain +// Set active FE indices in each sub-domain template void diffusionMechanics::set_active_fe_indices() diff --git a/tests/hp/matrices_hp.cc b/tests/hp/matrices_hp.cc index 756c5aceef..56374fc6bc 100644 --- a/tests/hp/matrices_hp.cc +++ b/tests/hp/matrices_hp.cc @@ -15,7 +15,7 @@ -// like hp/matrices, but with different fe objects +// like hp/matrices, but with different FE objects #include diff --git a/tests/hp/p_adaptivity_absolute_threshold.cc b/tests/hp/p_adaptivity_absolute_threshold.cc index 667cf574ea..891621068c 100644 --- a/tests/hp/p_adaptivity_absolute_threshold.cc +++ b/tests/hp/p_adaptivity_absolute_threshold.cc @@ -57,7 +57,7 @@ setup(Triangulation &tria, const DoFHandler &dh) GridGenerator::hyper_cube(tria); tria.refine_global(2); - // Set all active fe indices to 1. + // Set all active FE indices to 1. // Flag first half of cells for refinement, and the other half for coarsening. typename DoFHandler::cell_iterator cell = dh.begin(1), endc = dh.end(1); for (unsigned int counter = 0; cell != endc; ++counter, ++cell) diff --git a/tests/hp/p_adaptivity_fixed_number.cc b/tests/hp/p_adaptivity_fixed_number.cc index f015a4b738..6016701313 100644 --- a/tests/hp/p_adaptivity_fixed_number.cc +++ b/tests/hp/p_adaptivity_fixed_number.cc @@ -57,7 +57,7 @@ setup(Triangulation &tria, const DoFHandler &dh) GridGenerator::hyper_cube(tria); tria.refine_global(2); - // Set all active fe indices to 1. + // Set all active FE indices to 1. // Flag first half of cells for refinement, and the other half for coarsening. typename DoFHandler::cell_iterator cell = dh.begin(1), endc = dh.end(1); for (unsigned int counter = 0; cell != endc; ++counter, ++cell) diff --git a/tests/hp/p_adaptivity_flags.cc b/tests/hp/p_adaptivity_flags.cc index f8e66eb71e..1bdd24940a 100644 --- a/tests/hp/p_adaptivity_flags.cc +++ b/tests/hp/p_adaptivity_flags.cc @@ -57,7 +57,7 @@ setup(Triangulation &tria, const DoFHandler &dh) GridGenerator::hyper_cube(tria); tria.refine_global(2); - // Set all active fe indices to 1. + // Set all active FE indices to 1. // Flag first half of cells for refinement, and the other half for coarsening. typename DoFHandler::cell_iterator cell = dh.begin(1), endc = dh.end(1); for (unsigned int counter = 0; cell != endc; ++counter, ++cell) diff --git a/tests/hp/p_adaptivity_full.cc b/tests/hp/p_adaptivity_full.cc index c9f6584ba1..8948f2b277 100644 --- a/tests/hp/p_adaptivity_full.cc +++ b/tests/hp/p_adaptivity_full.cc @@ -57,7 +57,7 @@ setup(Triangulation &tria, const DoFHandler &dh) GridGenerator::hyper_cube(tria); tria.refine_global(2); - // Set all active fe indices to 1. + // Set all active FE indices to 1. // Flag first half of cells for refinement, and the other half for coarsening. typename DoFHandler::cell_iterator cell = dh.begin(1), endc = dh.end(1); for (unsigned int counter = 0; cell != endc; ++counter, ++cell) diff --git a/tests/hp/p_adaptivity_reference.cc b/tests/hp/p_adaptivity_reference.cc index e9dcdc5e18..d90956c457 100644 --- a/tests/hp/p_adaptivity_reference.cc +++ b/tests/hp/p_adaptivity_reference.cc @@ -57,7 +57,7 @@ setup(Triangulation &tria, const DoFHandler &dh) GridGenerator::hyper_cube(tria); tria.refine_global(2); - // Set all active fe indices to 1. + // Set all active FE indices to 1. // Flag first half of cells for refinement, and the other half for coarsening. typename DoFHandler::cell_iterator cell = dh.begin(1), endc = dh.end(1); for (unsigned int counter = 0; cell != endc; ++counter, ++cell) diff --git a/tests/hp/p_adaptivity_regularity.cc b/tests/hp/p_adaptivity_regularity.cc index 8bf7e1de3a..1587a86d4a 100644 --- a/tests/hp/p_adaptivity_regularity.cc +++ b/tests/hp/p_adaptivity_regularity.cc @@ -57,7 +57,7 @@ setup(Triangulation &tria, const DoFHandler &dh) GridGenerator::hyper_cube(tria); tria.refine_global(2); - // Set all active fe indices to 1. + // Set all active FE indices to 1. // Flag first half of cells for refinement, and the other half for coarsening. typename DoFHandler::cell_iterator cell = dh.begin(1), endc = dh.end(1); for (unsigned int counter = 0; cell != endc; ++counter, ++cell) diff --git a/tests/hp/p_adaptivity_relative_threshold.cc b/tests/hp/p_adaptivity_relative_threshold.cc index 53aab49f80..eb87fd9e7f 100644 --- a/tests/hp/p_adaptivity_relative_threshold.cc +++ b/tests/hp/p_adaptivity_relative_threshold.cc @@ -57,7 +57,7 @@ setup(Triangulation &tria, const DoFHandler &dh) GridGenerator::hyper_cube(tria); tria.refine_global(2); - // Set all active fe indices to 1. + // Set all active FE indices to 1. // Flag first half of cells for refinement, and the other half for coarsening. typename DoFHandler::cell_iterator cell = dh.begin(1), endc = dh.end(1); for (unsigned int counter = 0; cell != endc; ++counter, ++cell) diff --git a/tests/hp/refinement_01.cc b/tests/hp/refinement_01.cc index e858486315..8d7bb2cf97 100644 --- a/tests/hp/refinement_01.cc +++ b/tests/hp/refinement_01.cc @@ -57,7 +57,7 @@ test() for (cell = dh.begin_active(); cell != dh.end(); ++cell) { - // set active fe index + // set active FE index if (i >= fe_collection.size()) i = 0; cell->set_active_fe_index(i++); diff --git a/tests/hp/set_dof_values_by_interpolation_01.debug.output b/tests/hp/set_dof_values_by_interpolation_01.debug.output index a305d959e2..db079c63ab 100644 --- a/tests/hp/set_dof_values_by_interpolation_01.debug.output +++ b/tests/hp/set_dof_values_by_interpolation_01.debug.output @@ -2,12 +2,12 @@ DEAL::Yes, exception 1! DEAL::ExcMessage( "For DoFHandler objects in hp-mode, finite elements are only " "associated with active cells. Consequently, you can not ask " "for the active finite element on cells with children.") DEAL::Yes, exception! -DEAL::ExcMessage( "You cannot call this function on non-active cells " "of DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active_fe_index has been set.") +DEAL::ExcMessage( "You cannot call this function on non-active cells " "of DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active FE index has been set.") DEAL::Yes, exception 1! DEAL::ExcMessage( "For DoFHandler objects in hp-mode, finite elements are only " "associated with active cells. Consequently, you can not ask " "for the active finite element on cells with children.") DEAL::Yes, exception! -DEAL::ExcMessage( "You cannot call this function on non-active cells " "of DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active_fe_index has been set.") +DEAL::ExcMessage( "You cannot call this function on non-active cells " "of DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active FE index has been set.") DEAL::Yes, exception 1! DEAL::ExcMessage( "For DoFHandler objects in hp-mode, finite elements are only " "associated with active cells. Consequently, you can not ask " "for the active finite element on cells with children.") DEAL::Yes, exception! -DEAL::ExcMessage( "You cannot call this function on non-active cells " "of DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active_fe_index has been set.") +DEAL::ExcMessage( "You cannot call this function on non-active cells " "of DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active FE index has been set.") diff --git a/tests/hp/solution_transfer_09.cc b/tests/hp/solution_transfer_09.cc index f0c510bf82..a7b06b577e 100644 --- a/tests/hp/solution_transfer_09.cc +++ b/tests/hp/solution_transfer_09.cc @@ -15,7 +15,7 @@ -// Like _07 but with all same fe indices. This triggered yet another place +// Like _07 but with all same FE indices. This triggered yet another place // where we had the same kind of error. #include diff --git a/tests/lac/constraints.cc b/tests/lac/constraints.cc index d68a6b57cc..21b47fa2a9 100644 --- a/tests/lac/constraints.cc +++ b/tests/lac/constraints.cc @@ -285,7 +285,7 @@ main() constraints.print(logfile); - // release fe + // release FE dof.clear(); deallog << std::endl; diff --git a/tests/mpi/error_predictor_02.cc b/tests/mpi/error_predictor_02.cc index 96984b0225..2c1242c734 100644 --- a/tests/mpi/error_predictor_02.cc +++ b/tests/mpi/error_predictor_02.cc @@ -66,7 +66,7 @@ test() DoFHandler dh(tria); for (const auto &cell : dh.active_cell_iterators()) { - // set active fe index + // set active FE index if (cell->is_locally_owned()) cell->set_active_fe_index(1); } diff --git a/tests/mpi/hp_active_fe_indices_transfer_01.cc b/tests/mpi/hp_active_fe_indices_transfer_01.cc index 8b04903b90..0f2bfd5ce7 100644 --- a/tests/mpi/hp_active_fe_indices_transfer_01.cc +++ b/tests/mpi/hp_active_fe_indices_transfer_01.cc @@ -15,7 +15,7 @@ -// active fe indices transfer on refinement +// active FE indices transfer on refinement #include @@ -55,7 +55,7 @@ test() for (auto &cell : dh.active_cell_iterators()) if (cell->is_locally_owned()) { - // set active fe index + // set active FE index if (!(cell->is_artificial())) { if (i >= fe_collection.size()) diff --git a/tests/mpi/hp_active_fe_indices_transfer_02.cc b/tests/mpi/hp_active_fe_indices_transfer_02.cc index e23bf012d1..7840535abf 100644 --- a/tests/mpi/hp_active_fe_indices_transfer_02.cc +++ b/tests/mpi/hp_active_fe_indices_transfer_02.cc @@ -15,7 +15,7 @@ -// active fe indices transfer on serialization +// active FE indices transfer on serialization #include @@ -54,7 +54,7 @@ test() for (auto &cell : dh.active_cell_iterators()) if (cell->is_locally_owned()) { - // set active fe index + // set active FE index if (!(cell->is_artificial())) { if (i >= fe_collection.size()) diff --git a/tests/mpi/hp_active_fe_indices_transfer_03.cc b/tests/mpi/hp_active_fe_indices_transfer_03.cc index ea74872e76..d4716c39a2 100644 --- a/tests/mpi/hp_active_fe_indices_transfer_03.cc +++ b/tests/mpi/hp_active_fe_indices_transfer_03.cc @@ -15,7 +15,7 @@ -// active fe indices transfer on repartitioning +// active FE indices transfer on repartitioning #include @@ -54,7 +54,7 @@ test() for (auto &cell : dh.active_cell_iterators()) if (cell->is_locally_owned()) { - // set active fe index + // set active FE index if (!(cell->is_artificial())) cell->set_active_fe_index(myid); diff --git a/tests/mpi/hp_active_fe_indices_transfer_04.cc b/tests/mpi/hp_active_fe_indices_transfer_04.cc index 1d5b2c6020..0d2f747b7d 100644 --- a/tests/mpi/hp_active_fe_indices_transfer_04.cc +++ b/tests/mpi/hp_active_fe_indices_transfer_04.cc @@ -15,7 +15,7 @@ -// active fe indices serialization with a different number of cpus +// active FE indices serialization with a different number of cpus #include @@ -63,7 +63,7 @@ test() for (auto &cell : dh.active_cell_iterators()) if (cell->is_locally_owned()) { - // set active fe index + // set active FE index if (i >= fe_collection.size()) i = 0; cell->set_active_fe_index(i++); diff --git a/tests/mpi/hp_constraints_consistent_01.cc b/tests/mpi/hp_constraints_consistent_01.cc index 75781fa08e..b37045a17d 100644 --- a/tests/mpi/hp_constraints_consistent_01.cc +++ b/tests/mpi/hp_constraints_consistent_01.cc @@ -84,7 +84,7 @@ test(const unsigned int degree_center, for (const auto &cell : dh.active_cell_iterators()) if (cell->is_locally_owned() && cell->id().to_string() == "1_0:") { - // set different fe on center cell + // set different FE on center cell cell->set_active_fe_index(1); #ifdef DEBUG diff --git a/tests/mpi/hp_constraints_consistent_02.cc b/tests/mpi/hp_constraints_consistent_02.cc index 549afd01a5..ab40d3f1db 100644 --- a/tests/mpi/hp_constraints_consistent_02.cc +++ b/tests/mpi/hp_constraints_consistent_02.cc @@ -84,7 +84,7 @@ test(const unsigned int degree_center, for (const auto &cell : dh.active_cell_iterators()) if (cell->is_locally_owned() && cell->id().to_string() == "1_0:") { - // set different fe on center cell + // set different FE on center cell cell->set_active_fe_index(1); #ifdef DEBUG diff --git a/tests/mpi/hp_constraints_consistent_03.cc b/tests/mpi/hp_constraints_consistent_03.cc index f43bde7056..d547d16f6b 100644 --- a/tests/mpi/hp_constraints_consistent_03.cc +++ b/tests/mpi/hp_constraints_consistent_03.cc @@ -86,7 +86,7 @@ test(const unsigned int degree_center, { if (cell->id().to_string() == "1_0:") { - // set different fe on center cell + // set different FE on center cell cell->set_active_fe_index(1); #ifdef DEBUG diff --git a/tests/mpi/hp_refinement_01.cc b/tests/mpi/hp_refinement_01.cc index 15d2d6b329..65e63017e1 100644 --- a/tests/mpi/hp_refinement_01.cc +++ b/tests/mpi/hp_refinement_01.cc @@ -73,7 +73,7 @@ test() if (cell->is_locally_owned()) { - // set active fe index + // set active FE index if (i >= fe_collection.size()) i = 0; cell->set_active_fe_index(i++); diff --git a/tests/mpi/hp_refinement_02.cc b/tests/mpi/hp_refinement_02.cc index f63ecf6b1f..665aec2124 100644 --- a/tests/mpi/hp_refinement_02.cc +++ b/tests/mpi/hp_refinement_02.cc @@ -73,7 +73,7 @@ test() if (cell->is_locally_owned()) { - // set active fe index + // set active FE index if (i >= fe_collection.size()) i = 0; cell->set_active_fe_index(i++); diff --git a/tests/mpi/hp_unify_dof_indices_09.cc b/tests/mpi/hp_unify_dof_indices_09.cc index 08050fe345..7c633d66a0 100644 --- a/tests/mpi/hp_unify_dof_indices_09.cc +++ b/tests/mpi/hp_unify_dof_indices_09.cc @@ -16,7 +16,7 @@ // This test provides a hp::DoFHandler with two FE_Q(2) elements // assigned on a p::d::Triangulation consisting of 64x64 cells, on which -// active fe indices are mostly randomly distributed. This DoF +// active FE indices are mostly randomly distributed. This DoF // distribution test repeats for an increasing amount of processors. // // At some point, this test failed to provide a consistent number of diff --git a/tests/mpi/p_adaptivity_fixed_number.cc b/tests/mpi/p_adaptivity_fixed_number.cc index fe8a8eff9e..4c9f51485d 100644 --- a/tests/mpi/p_adaptivity_fixed_number.cc +++ b/tests/mpi/p_adaptivity_fixed_number.cc @@ -66,7 +66,7 @@ setup(Triangulation &tria, const DoFHandler &dh) GridGenerator::subdivided_hyper_cube(tria, 4); Assert(tria.n_cells(0) == tria.n_global_active_cells(), ExcInternalError()); - // Set all active fe indices to 1. + // Set all active FE indices to 1. // Flag first half of cells for refinement, and the other half for coarsening. for (const auto &cell : dh.active_cell_iterators()) if (!cell->is_artificial() && cell->is_locally_owned()) diff --git a/tests/mpi/solution_transfer_04.cc b/tests/mpi/solution_transfer_04.cc index 1353091daf..c87a31fc16 100644 --- a/tests/mpi/solution_transfer_04.cc +++ b/tests/mpi/solution_transfer_04.cc @@ -61,7 +61,7 @@ test() { if (cell->is_locally_owned()) { - // set active fe index + // set active FE index if (!(cell->is_artificial())) { if (i >= fe_collection.size()) diff --git a/tests/mpi/solution_transfer_05.cc b/tests/mpi/solution_transfer_05.cc index ea18d63309..5166081744 100644 --- a/tests/mpi/solution_transfer_05.cc +++ b/tests/mpi/solution_transfer_05.cc @@ -60,7 +60,7 @@ test() DoFHandler dgq_dof_handler(tria); - // randomly assign fes + // randomly assign FEs for (const auto &cell : dgq_dof_handler.active_cell_iterators()) if (cell->is_locally_owned()) cell->set_active_fe_index(Testing::rand() % max_degree); diff --git a/tests/numerics/project_parallel_qpmf_common.h b/tests/numerics/project_parallel_qpmf_common.h index 966597fba3..a864470299 100644 --- a/tests/numerics/project_parallel_qpmf_common.h +++ b/tests/numerics/project_parallel_qpmf_common.h @@ -266,7 +266,7 @@ test_with_hanging_nodes(const FiniteElement &fe, const unsigned int p) } -// same as above but for multiple fes +// same as above but for multiple FEs template void test_with_hanging_nodes(const std::vector *> &fes,