]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Unify spelling 2. 12688/head
authorMarc Fehling <mafehling.git@gmail.com>
Fri, 20 Aug 2021 02:42:38 +0000 (20:42 -0600)
committerMarc Fehling <mafehling.git@gmail.com>
Fri, 20 Aug 2021 03:03:11 +0000 (21:03 -0600)
examples/doxygen/step_3_mixed.cc
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/numerics/solution_transfer.h
source/non_matching/mesh_classifier.cc

index 0d61428d757cbc2923dbc25f4f32cc62c24a2ab0..4373f6eddd9871935d619d2da044d0e5bbaad551 100644 (file)
@@ -84,7 +84,7 @@
  * cell via the method hp::FEValues::get_present_fe_values().
  *
  * For hp::FEValues, to be able to select the right finite element/quadrature
- * rule/ mapping object set, it queries the active_fe_index of the given cell
+ * rule/mapping object set, it queries the active FE index of the given cell
  * during hp::FEValues::reinit(). The indices have to be set - as shown below -
  * before calling DoFHandler::distribute_dofs() by the user.
  *
@@ -241,7 +241,7 @@ void Step3::make_grid()
 // @sect4{Step3::setup_system}
 //
 // In contrast to step-3 and step-3simplex, we need here a preprocessing step
-// that assigns an active_fe_index to each cell consistently according to the
+// that assigns an active FE index to each cell consistently according to the
 // indices in the collections and the cell type.
 void Step3::setup_system()
 {
index 582405f1c1b5d7aef8d907186da6d3f706643eb0..95223ebe548f3ac8a6bf44a3fec59021003bc11f 100644 (file)
@@ -296,7 +296,7 @@ namespace internal
         Assert(ptr != dof_handler.hp_object_fe_indices[structdim].begin() +
                         dof_handler.hp_object_fe_ptr[structdim][obj_index + 1],
                ExcMessage(
-                 "You are requesting an active_fe_index that is not assigned "
+                 "You are requesting an active FE index that is not assigned "
                  "to any of the cells connected to this entity."));
 
         const unsigned int fe_index_ =
index 77488a55979d1d5823b0bb089634ee737f59f124..c63110990ec579948ae4b8876b68d07db85bb2be 100644 (file)
@@ -1473,20 +1473,20 @@ public:
     const unsigned int                           dof_handler_index = 0) const;
 
   /**
-   * In the hp-adaptive case, return number of active_fe_indices.
+   * In the hp-adaptive case, return number of active FE indices.
    */
   unsigned int
   n_active_fe_indices() const;
 
   /**
-   * In the hp-adaptive case, return the active_fe_index of a cell range.
+   * In the hp-adaptive case, return the active FE index of a cell range.
    */
   unsigned int
   get_cell_active_fe_index(
     const std::pair<unsigned int, unsigned int> range) const;
 
   /**
-   * In the hp-adaptive case, return the active_fe_index of a face range.
+   * In the hp-adaptive case, return the active FE index of a face range.
    */
   unsigned int
   get_face_active_fe_index(const std::pair<unsigned int, unsigned int> range,
index 506607a55646cb6bd8d00f8a404a6f866b54e383..57681697ddc573bf938782f4ae9ea67b24aec851 100644 (file)
@@ -504,7 +504,7 @@ MatrixFree<dim, Number, VectorizedArrayType>::internal_reinit(
 
 
   // subdivide cell, face and boundary face partitioner data, s.t., all
-  // ranges have the same active_fe_indices
+  // ranges have the same active FE indices
   if (task_info.scheme != internal::MatrixFreeFunctions::TaskInfo::
                             TasksParallelScheme::partition_color)
     {
@@ -754,8 +754,8 @@ MatrixFree<dim, Number, VectorizedArrayType>::internal_reinit(
       if (dof_handler.size() > 1)
         {
           // check if all DoHandlers are in the same hp-mode; and if hp-
-          // capabilities are enabled: check if active_fe_indices of all
-          // DoFHandler are the same.
+          // capabilities are enabled: check if active FE indices of all
+          // DoFHandlers are the same.
           for (unsigned int i = 1; i < dof_handler.size(); ++i)
             {
               Assert(dof_handler[0]->has_hp_capabilities() ==
index cc4929f3d1c4f7a522c18dda57c9a2efa880f32b..ce42509c374a7bf58e916528dbb3400de1cd1841 100644 (file)
@@ -298,7 +298,7 @@ DEAL_II_NAMESPACE_OPEN
  * 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
- * non- active cells using DoFAccessor::set_active_fe_index().
+ * non-active cells using DoFAccessor::set_active_fe_index().
  *
  * It is, thus, not entirely natural what should happen if, for example, a few
  * cells are coarsened away. This class then implements the following
index 4b8b9941d358fbc1582a9a45158bd46ec303d765..9af37da25c2ddc50e10b5a0b5550a9f737a2fc11 100644 (file)
@@ -90,7 +90,7 @@ namespace NonMatching
         get_fe_collection() const override;
 
         /**
-         * Return the active_fe_index of the DoFCellAccessor associated with the
+         * Return the active FE index of the DoFCellAccessor associated with the
          * DoFHandler and the the incoming cell in the triangulation.
          */
         unsigned int

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.