]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Run codespell 13968/head
authorDavid Wells <drwells@email.unc.edu>
Mon, 13 Jun 2022 16:49:22 +0000 (12:49 -0400)
committerDavid Wells <drwells@email.unc.edu>
Mon, 13 Jun 2022 17:02:57 +0000 (13:02 -0400)
28 files changed:
examples/doxygen/step_3_mixed.cc
examples/step-66/doc/results.dox
examples/step-70/doc/results.dox
examples/step-71/step-71.cc
examples/step-81/doc/intro.dox
examples/step-82/doc/intro.dox
examples/step-82/step-82.cc
include/deal.II/base/mpi.h
include/deal.II/base/subscriptor.h
include/deal.II/cgal/utilities.h
include/deal.II/distributed/tria.h
include/deal.II/dofs/dof_renumbering.h
include/deal.II/fe/fe_q_iso_q1.h
include/deal.II/fe/fe_values.h
include/deal.II/lac/affine_constraints.templates.h
include/deal.II/lac/solver_qmrs.h
include/deal.II/matrix_free/evaluation_kernels.h
include/deal.II/matrix_free/evaluation_kernels_hanging_nodes.h
include/deal.II/matrix_free/tools.h
include/deal.II/multigrid/mg_transfer_global_coarsening.h
include/deal.II/multigrid/mg_transfer_matrix_free.h
include/deal.II/non_matching/quadrature_generator.h
source/base/polynomials_raviart_thomas.cc
source/distributed/tria.cc
source/dofs/dof_handler_policy.cc
source/fe/fe_simplex_p_bubbles.cc
source/grid/tria.cc
source/non_matching/quadrature_generator.cc

index 4373f6eddd9871935d619d2da044d0e5bbaad551..0c87661973748be0b40ba9f6eb5787868aaccd25 100644 (file)
@@ -68,7 +68,7 @@
  * quadrilaterals, we have discussed in step-3: we selected an appropriate
  * finite element, quadrature rule and mapping object, e.g., FE_Q, QGauss, and
  * MappingFE (initialized with FE_Q). For simplex meshes, we selected in
- * step-3simplex FE_SimplexP, QGaussSimplex, and MappingFE (intialized with
+ * step-3simplex FE_SimplexP, QGaussSimplex, and MappingFE (initialized with
  * FE_SimplexP).
  *
  * For mixed meshes, we need multiple finite elements, quadrature rules, and
index 28a7f95b286642a5e2854bb92ce26cd07f742faa..d640fd5f15867e2a0c397d68718b97dc36fe13cd 100644 (file)
@@ -191,7 +191,7 @@ reduces the number of CG iterations by a few steps.
 
 
 <h3>Possibilities for extensions</h3>
-A couple of possible extensions are available concerning minor updates fo the
+A couple of possible extensions are available concerning minor updates to the
 present code as well as a deeper numerical investigation of the Gelfand problem.
 
 <h4>More sophisticated Newton iteration</h4>
index 7fdb2d546968be72e9833563864ae0217bb0ee2c..cfe15bf5e9556a18f94d60484a88b4e48979f85d 100644 (file)
@@ -226,7 +226,7 @@ The rationale behind creating first `parameters.prm` file (the first time the
 program is run) and then a `output/parameters_22.prm` (every time you
 run the program with an existing input file), is because you may want
 to leave most parameters to their
-default values, and only modify a handful of them, while still beeing able to
+default values, and only modify a handful of them, while still being able to
 reproduce the results and inspect what parameters were used for a specific
 simulation. It is generally good scientific practice to store the
 parameter file you used for a simulation along with the simulation
index cd68cdb3b55a753c6232432b152faf64e3ffe1fc..da0f91306c8b749e4197ea1bce30734a2a4c2239 100644 (file)
@@ -1797,7 +1797,7 @@ namespace Step71
       // calculations. These essentially act as the input arguments to
       // all dependent functions that the @p optimizer must evaluate.
       // They are, collectively, the independent variables
-      // for the problem, the history variables, the time step sie and the
+      // for the problem, the history variables, the time step size and the
       // constitutive parameters (since we've not hard encoded them in the
       // energy density function).
       //
index 886405df79ade097dde4c061eced97745bce3539..4c46d4bd7e717b1837a6de3f71cda0e77c9d8d70 100644 (file)
@@ -114,7 +114,7 @@ atomic thickness it is an example of a so-called 2D material: Compared to
 the other spatial dimensions (where graphene samples can reach up to
 several centimeters) the atomistic thickness of graphene typically ranges
 around 2.5 ångstrom ($2.5\times10^{-10}\text{m}$). We will thus model
-graphene as a lower-dimensional interface $\Sigma$ imbedded into the
+graphene as a lower-dimensional interface $\Sigma$ embedded into the
 computational domain $\Omega\subset\mathbb{R}^d$. More precisely, $\Sigma$
 is a two-dimensional sheet in three spatial dimensions, or a
 one-dimensional line in two spatial dimensions. The special electronic
index a2754071dd5e2ac737133448b4a9c458e96238c0..6796fc041238fd68f4c965e3e13f446a795ecf8f 100644 (file)
@@ -9,7 +9,7 @@
 
 <a name="Intro"></a>
 <h1>Introduction</h1>
-<h3>Problem statment</h3>
+<h3>Problem Statement</h3>
 
 In this example, we consider the <i>local discontinuous Galerkin</i> (LDG) method for approximating the solution to the bi-Laplacian problem,
 @f{align*}{
@@ -17,7 +17,7 @@ In this example, we consider the <i>local discontinuous Galerkin</i> (LDG) metho
 \nabla u & = \mathbf{0} \quad \mbox{on } \partial\Omega, \\
 u & = 0 \quad \mbox{on } \partial\Omega,
 @f}
-where $\Omega\subset\mathbb{R}^d$ $(d=2,3)$ is an open bounded Lipschitz domain and $f\in L^2(\Omega)$. This is the same problem we have already considered in step-47, but we will take here a different approach towards solving it: Rather than using continuous finite elements and the interior penalty method, we consider discontinuous finite elements and the local discontinous Galerkin method defined using lifting operators.
+where $\Omega\subset\mathbb{R}^d$ $(d=2,3)$ is an open bounded Lipschitz domain and $f\in L^2(\Omega)$. This is the same problem we have already considered in step-47, but we will take here a different approach towards solving it: Rather than using continuous finite elements and the interior penalty method, we consider discontinuous finite elements and the local discontinuous Galerkin method defined using lifting operators.
 
 The weak formulation of this problem reads as follows: find $u\in H_0^2(\Omega)$ such that
 @f[
@@ -243,7 +243,7 @@ where $\mathbf{n}_{K_c}$ (resp. $\mathbf{n}_{K_n}$) denotes the outward unit nor
 @f[
 G_m=\int_e\average{{\rm div}\, \psi_m}\cdot\mathbf{n}_e\jump{\varphi^c}=\frac{1}{2}\int_e{\rm div}\, \psi_m\cdot\mathbf{n}_{K_c}\varphi^c,
 @f]
-while if $\varphi=\varphi^n$, namely $\varphi$ has support on the neighbhoring cell $K_n$, then
+while if $\varphi=\varphi^n$, namely $\varphi$ has support on the neighboring cell $K_n$, then
 @f[
 G_m=\int_e\average{{\rm div}\, \psi_m}\cdot\mathbf{n}_e\jump{\varphi^n}=\frac{1}{2}\int_e{\rm div}\, \psi_m\cdot\mathbf{n}_{K_n}\varphi^n.
 @f]
index 1f1c2b24e472956b99a23029f92b2b23ad786dac..a0f0eb3ccea814fac9bc98eb746df9e3eadd194c 100644 (file)
@@ -1260,7 +1260,7 @@ namespace Step82
 
             const bool at_boundary = face->at_boundary();
 
-            // Recall that by convention, the average of a function accross a
+            // Recall that by convention, the average of a function across a
             // boundary face $e$ reduces to the trace of the function on the
             // only element adjacent to $e$, namely there is no factor
             // $\frac{1}{2}$. We distinguish between the two cases (the current
index 9dd3af6b0a32509c70327564fd7ab79fb8e1d9e1..3391859bf373ec271f0b662725b18d72c4b3133d 100644 (file)
@@ -531,7 +531,7 @@ namespace Utilities
      * process messages of sizes larger than 2 GB with MPI_Byte as the
      * underlying data type. This helper is required for MPI versions before 4.0
      * because routines like `MPI_Send`
-     * use a signed interger for the @p count variable. Instead, you can use this
+     * use a signed integer for the @p count variable. Instead, you can use this
      * data type with the appropriate size set to the size of your message and
      * by passing
      * 1 as the @p count.
index c018b04faec3f6425b16d7213fb29513a7d9f6b3..efb009547b52f4102a4f0aba7147cad2bdee4993 100644 (file)
@@ -36,7 +36,7 @@ DEAL_II_NAMESPACE_OPEN
  * This class, as a base class, allows to keep track of other objects using a
  * specific object. It is used to avoid that pointers that point to an object of
  * a class derived from Subscriptor are referenced after that object has been
- * invalidated. Here, invalidation is assumend to happen when the object is
+ * invalidated. Here, invalidation is assumed to happen when the object is
  * moved from or destroyed.
  * The mechanism works as follows: The member function subscribe() accepts a
  * pointer to a boolean that is modified on invalidation. The object that owns
index 44e46bc51172e685ed31707c9ed43c80c486f9c0..0bb57f65804ad39a23987100fff13c61be6c30ac 100644 (file)
@@ -194,7 +194,7 @@ namespace CGALWrappers
 
   /**
    * Given a CGAL Triangulation describing a polyhedral region, create
-   * a Quadrature rule to integrate over the polygon by looping trough all the
+   * a Quadrature rule to integrate over the polygon by looping through all the
    * vertices and exploiting QGaussSimplex.
    *
    * @param[in] tria The CGAL triangulation object describing the polyhedral
index 3d314995783460c87cb66f746eb780056e298ca1..f6bbfd0850f0b5243ece77753493213066a7c26a 100644 (file)
@@ -1099,7 +1099,7 @@ namespace parallel
      * combination with the Triangulation::Signals::post_p4est_refinement
      * signal. At this stage, the p4est oracle already has been refined, but
      * the triangulation is still unchanged. After the modification, all
-     * refine and coarsen flags describe how the traingulation will actually
+     * refine and coarsen flags describe how the triangulation will actually
      * be refined.
      *
      * The use of this class is demonstrated in step-75.
index 39136671bc81d0b8a94ad66d1e042dd7a491644e..999c0310445857c108fcf9a01b47a122323eebe8 100644 (file)
@@ -1257,7 +1257,7 @@ namespace DoFRenumbering
    * distributes DoFs: i.e., for a given support point, the global dof indices
    * for component i should be less than the global dof indices for component i
    * + 1. Due to various technical complications (like DoF unification in
-   * hp-mode) this assumption needs to be satified for this function to work in
+   * hp-mode) this assumption needs to be satisfied for this function to work in
    * all relevant cases.
    */
   template <int dim, int spacedim>
index f18594b3b4db160d6ca8bf83a18d8483cb58a6cb..314e7621a0ca9d1cc09e929c92bd932b37ee09cd 100644 (file)
@@ -109,7 +109,7 @@ DEAL_II_NAMESPACE_OPEN
  * contrast with FE_Q(p) where QGauss<dim>(p+1) is the default choice. In
  * particular, care must be taken to not use a quadrature formula that
  * evaluates the basis functions (and their derivatives) on sub-element
- * boundaries as the gradients of piecewiese functions on internal boundaries
+ * boundaries as the gradients of piecewise functions on internal boundaries
  * are set to zero. No checks are performed internally to ensure that this is
  * not the case - it is the user's responsibility to avoid these situations.
  *
index d1bd1d115ac12b2f332ac2f60070eb14ffab57a8..2611e781d0e569496eb8f7545bfded9e541644bd 100644 (file)
@@ -946,7 +946,7 @@ namespace FEValuesViews
     Vector(const Vector<dim, spacedim> &) = delete;
 
     /**
-     * Move constuctor.
+     * Move constructor.
      */
     // NOLINTNEXTLINE OSX does not compile with noexcept
     Vector(Vector<dim, spacedim> &&) = default;
index 083c832e5fe39e4a25a221e436c33f1e46e3d8a7..1bcd7f2c41f12778fdd1a8c47e2778ee795c0550 100644 (file)
@@ -3265,7 +3265,7 @@ namespace internal
       else
         col_val = 0;
 
-      // account for indirect contributions by constraints in row, going trough
+      // account for indirect contributions by constraints in row, going through
       // the direct and indirect references in the given column.
       for (size_type q = 0; q < global_rows.size(i); ++q)
         {
index 9603767ca233bf8da7d79b2f654947d5534c5746..9d5dd4aec512698be03f43d18ffa710aea09bf37 100644 (file)
@@ -284,7 +284,7 @@ SolverQMRS<VectorType>::solve(const MatrixType &        A,
   LogStream::Prefix prefix("SQMR");
 
 
-  // temporary vectors, allocated trough the @p VectorMemory object at the
+  // temporary vectors, allocated through the @p VectorMemory object at the
   // start of the actual solution process and deallocated at the end.
   typename VectorMemory<VectorType>::Pointer Vr(this->memory);
   typename VectorMemory<VectorType>::Pointer Vu(this->memory);
index 665b3dd419c6cba2acc7a1440b5d61f78ae1c0ea..e9774f0af55af8951fbf0644b455d676843c5493 100644 (file)
@@ -1016,9 +1016,9 @@ namespace internal
       }
   }
 
-  // Helper function that applies the 1d evaluation kernals.
+  // Helper function that applies the 1d evaluation kernels.
   // std::integral_constant<bool, false> is the interpolation path, and
-  // std::integral_constant<bool, true> bellow is the integration path.
+  // std::integral_constant<bool, true> below is the integration path.
   template <int dim, int fe_degree, int n_q_points_1d, typename Number>
   template <int normal_dir>
   inline void
index 64f4686dbcae4d0db487505bb2047d459588706e..76e2626d971f49f4602b6004fb52730ff46b7d28 100644 (file)
@@ -47,7 +47,7 @@ namespace internal
 
 
   /**
-   * Helper enum to spefify the type of vectorization for
+   * Helper enum to specify the type of vectorization for
    * FEEvaluationImplHangingNodesRunnerTypes::scalar.
    */
   enum class VectorizationTypes
index 69a6815294724c899e8824b0fa90deabc6dec5a6..f6c7c13a80d86a18852d307570fd54b202693be2 100644 (file)
@@ -704,7 +704,7 @@ namespace MatrixFreeTools
       {
         // if we have a block vector with components with the same DoFHandler,
         // we need to figure out which component and which DoF within the
-        // comonent are we currently considering
+        // component are we currently considering
         const unsigned int n_fe_components =
           phi.get_dof_info().start_components.back();
         const unsigned int comp =
@@ -768,7 +768,7 @@ namespace MatrixFreeTools
                    phi.get_current_cell_index());
              ++v)
           // if we have a block vector with components with the same
-          // DoFHandler, we need to loop over all components manully and
+          // DoFHandler, we need to loop over all components manually and
           // need to apply the correct shift
           for (unsigned int j = 0; j < c_pools[v].row.size() - 1; ++j)
             for (unsigned int comp = 0;
index e05f427ba38335b1fc27250841963841776a65ed..159a280f7b53ecdaba9eccb856006e0d3f92571e 100644 (file)
@@ -495,9 +495,10 @@ public:
   /**
    * Similar function to MGTransferMatrixFree::build() with the difference that
    * the information for the prolongation for each level has already been built.
-   * So this function only tries to optimize the data structues of the two-level
-   * transfer operators, e.g., by enabling inplace vector operations, by
-   * checking if @p external_partitioners and the internal ones are compatible.
+   * So this function only tries to optimize the data structures of the
+   * two-level transfer operators, e.g., by enabling inplace vector operations,
+   * by checking if @p external_partitioners and the internal ones are
+   * compatible.
    */
   void
   build(const std::vector<std::shared_ptr<const Utilities::MPI::Partitioner>>
index 769af62672a3f26c774cd1697b34b50db5da144a..abbe4376c8cbbd4a66ec967fba159a6df498d4e2 100644 (file)
@@ -313,7 +313,7 @@ private:
 
 /**
  * Base class of MGTransferBlockMatrixFree. While MGTransferBlockMatrixFree
- * constains all the setup routines of the transfer operators for the blocks,
+ * contains all the setup routines of the transfer operators for the blocks,
  * this class simply applies them, e.g., for restricting and prolongating.
  */
 template <int dim, typename Number, typename TransferType>
index d8b26e4ebc546580b200db9219190a01da660d23..10031a91184e316830ee133534269341fd1e668a 100644 (file)
@@ -83,8 +83,8 @@ namespace NonMatching
      *
      * $|\frac{\partial \psi}{\partial x_i}| > 0$.
      *
-     * In practice, it might happend the bound we have for the expression in
-     * the left-hand side is only floating-point close to zero.
+     * In practice, the bound we have for the expression in the left-hand side
+     * may be near but not equal to zero due to roundoff errors.
      *
      * This constant is a safety margin, $C$, that states that the implicit
      * function theorem can be used when
@@ -1348,7 +1348,7 @@ namespace NonMatching
        *
        * $|\partial_k \psi_j| > L_{jk}$.
        *
-       * and then returns a coordindate direction, $i$, and a lower bound $L$,
+       * and then returns a coordinate direction, $i$, and a lower bound $L$,
        * such that
        *
        * @f[
index 6a6b078b7388068213961d925a7b97f67decf164..b9244d511c5b0f85f823490b4cb2b92b01207044 100644 (file)
@@ -115,7 +115,7 @@ PolynomialsRaviartThomas<dim>::evaluate(
 
   // In the following, we will access the scratch arrays declared as 'mutable'
   // in the class. In order to do so from this function, we have to make sure
-  // that we guard this access by a mutex so that the invokation of this 'const'
+  // that we guard this access by a mutex so that the invocation of this 'const'
   // function is thread-safe.
   std::lock_guard<std::mutex> lock(scratch_arrays_mutex);
 
index 64fef1ee4cdb30b19d2336e4ef78288c7934a2d6..9cc6aae0063bcf88dd999e4376186245284eaf4d 100644 (file)
@@ -623,7 +623,7 @@ namespace
 
   private:
     /**
-     * Simple struct to keep relavant data. Can be accessed though p4est's user
+     * Simple struct to keep relevant data. Can be accessed though p4est's user
      * pointer.
      */
     class QuadrantData
index 91334cf40d069c0685c8f4d7b8c85e79cac1168c..c117f5127949dcd178617a21834d6d6db65fe4ab 100644 (file)
@@ -3047,7 +3047,7 @@ namespace internal
             dof_handler.get_fe_collection().max_dofs_per_cell());
 
           // loop over all cells and record which subdomain a DoF belongs to.
-          // interface goes to proccessor with smaller subdomain id
+          // interface goes to processor with smaller subdomain id
           for (const auto &cell : dof_handler.cell_iterators_on_level(level))
             {
               // get the owner of the cell; note that we have made sure above
index 914aa2919ec5a5e3121c1fd51fd4f63406ced189..990c59cd590f01d8d74325d3d95e15666ffa0f8a 100644 (file)
@@ -246,7 +246,7 @@ FE_SimplexP_Bubbles<dim, spacedim>::FE_SimplexP_Bubbles(
       FE_P_BubblesImplementation::get_fe_data<dim>(degree),
       FE_P_BubblesImplementation::unit_support_points<dim>(degree),
       {FE_P_BubblesImplementation::unit_support_points<dim - 1>(degree)},
-      // Interface contraints are not yet implemented
+      // Interface constraints are not yet implemented
       FullMatrix<double>())
   , approximation_degree(degree)
 {}
index b1538f00e724ec19559d940acb8c2b4f547753ab..472f3979c59504f834ef564dbb0414cbc6b86907 100644 (file)
@@ -6735,7 +6735,7 @@ namespace internal
         // might have to renumber/rename children...)
 
         // we need a loop in cases c) and d), as the anisotropic
-        // children migt have a lower index than the mother quad
+        // children might have a lower index than the mother quad
         for (unsigned int loop = 0; loop < 2; ++loop)
           {
             // usually, only active objects can be refined
index 9a530fa7f25a5cb733bacda53f3602049df00870..f2167bcc003e13b67306c3e7bec2c73c323aa971 100644 (file)
@@ -471,7 +471,7 @@ namespace NonMatching
         const AdditionalQGeneratorData &additional_data,
         QPartitioning<dim> &            q_partitioning)
       {
-        // Make this int to avoid a warning signed/unsigned comparision.
+        // Make this int to avoid a warning signed/unsigned comparison.
         const int n_roots = roots.size();
 
         // The number of intervals are roots.size() + 1
@@ -1007,7 +1007,7 @@ namespace NonMatching
         if (height_direction_data)
           return height_direction_data->direction;
 
-        // We have to choose some direction, we might aswell take 0.
+        // We have to choose some direction, we might as well take 0.
         return 0;
       }
 

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.