]> https://gitweb.dealii.org/ - dealii.git/commitdiff
9.5: run codespell.
authorDavid Wells <drwells@email.unc.edu>
Tue, 20 Jun 2023 13:38:17 +0000 (09:38 -0400)
committerDavid Wells <drwells@email.unc.edu>
Tue, 20 Jun 2023 13:38:17 +0000 (09:38 -0400)
26 files changed:
include/deal.II/base/mpi_remote_point_evaluation.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/tensor.h
include/deal.II/lac/generic_linear_algebra.h
include/deal.II/lac/la_parallel_vector.h
include/deal.II/lac/petsc_communication_pattern.h
include/deal.II/lac/petsc_snes.h
include/deal.II/lac/petsc_snes.templates.h
include/deal.II/lac/petsc_sparse_matrix.h
include/deal.II/lac/petsc_ts.h
include/deal.II/lac/petsc_ts.templates.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/fe_point_evaluation.h
include/deal.II/matrix_free/tools.h
include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h
include/deal.II/multigrid/multigrid.h
include/deal.II/opencascade/utilities.h
include/deal.II/trilinos/nox.h
include/deal.II/trilinos/nox.templates.h
source/base/mpi.cc
source/base/path_search.cc
source/dofs/dof_tools.cc
source/grid/grid_tools.cc
source/lac/petsc_parallel_block_sparse_matrix.cc
source/lac/petsc_solver.cc

index 0a48238afccc337363b96c7bd8144bfd88fa2191..2f88977d8516a78fbedc8b5460dca8df9bb877dd 100644 (file)
@@ -100,7 +100,7 @@ namespace Utilities
        * GridTools::internal::DistributedComputePointLocationsInternal.
        *
        * This function is called internally by the reinit() function above.
-       * Having it as a seperate function makes it possible to setup the class
+       * Having it as a separate function makes it possible to setup the class
        * if it is known in which cells corresponding reference points are
        * located (e.g. if intersections of cells are known).
        */
index 7a86cc2d37be42466d16d66175e86cfbf9355732..3fd37b9211309b6aa8f97a02b536726c30f04daa 100644 (file)
@@ -212,7 +212,7 @@ class MultipleParameterLoop;
  *     }
  *   @endcode
  * The advantage of using json-files is that this format is natively supported
- * by Python, simplifying the running of paramter studies tremendously.
+ * by Python, simplifying the running of parameter studies tremendously.
  *
  * <h3>Including other input files</h3>
  *
index 159882376ca6fc5eabc5da5b9c17efd407cbca94..b7a69bdfd28f32cc2848135bd82156ea39ec8005 100644 (file)
@@ -579,7 +579,6 @@ public:
    *
    * This constructor obviously requires that the @p ElementType type is
    * either equal to @p Number, or is convertible to @p Number.
-   * Number.
    *
    * @note This function can also be used in @ref GlossDevice "device" code.
    */
index 05679059c955c0eb5c9887fadd9dfbb5b1ce488d..cdeb2238c23008779d3d662e7bedd3d31cec4d88 100644 (file)
@@ -183,7 +183,7 @@ namespace LinearAlgebraTrilinos
   using SolverCG = TrilinosWrappers::SolverCG;
 
   /**
-   * Typdef for the GMRES solver type used.
+   * Typedef for the GMRES solver type used.
    */
   using SolverGMRES = TrilinosWrappers::SolverGMRES;
 
index 37a1f961b66570400c5eb060d3bdd94c022379a7..0cbc03648da9e37fafee573146fce47271ac3297 100644 (file)
@@ -221,7 +221,7 @@ namespace LinearAlgebra
      *
      * @note By default, the GPU @ref GlossDevice "device" id is chosen in a round-robin fashion
      * according to the local MPI rank id. To choose a different @ref GlossDevice "device", Kokkos
-     * has to be initialized explicitly providing the respective devide id
+     * has to be initialized explicitly providing the respective device id
      * explicitly.
      *
      * <h4>MPI-3 shared-memory support</h4>
index 532e89b136244ed4715990ac868ac778c84a685e..415b2752b105ae0d544793b7e3cbd5a59252a337 100644 (file)
@@ -75,7 +75,7 @@ namespace PETScWrappers
      * associated to the @p indices_want only.
      *
      * This emulates the corresponding constructor in
-     * Utilies::MPI::NoncontiguousPartitioner.
+     * Utilities::MPI::NoncontiguousPartitioner.
      */
     void
     reinit(const std::vector<types::global_dof_index> &indices_locally_owned,
index cf0050427203fa05508bb952f012fb868ea9390e..82513b26916e9e0995400d68ae1551d81357f5c1 100644 (file)
@@ -66,7 +66,7 @@ namespace PETScWrappers
      * @param maximum_non_linear_iterations Maximum number of iterations allowed.
      * @param max_n_function_evaluations Maximum number of function evaluations allowed.
      *
-     * @note All parameters values specified here can be overriden by
+     * @note All parameters values specified here can be overridden by
      * command line choices.
      *
      * @ingroup PETScWrappers
index f9dbfb674e641b7eaab1e17c4607a68830c0c945..bd5516e410507c406b8a8892a0a372099cf41fca 100644 (file)
@@ -571,7 +571,7 @@ namespace PETScWrappers
           // case is to use FD and thus assemble a dense operator by finite
           // differencing the residual callbacks. Here instead we decide to
           // use a full matrix-free approach by default. This choice can always
-          // be overriden from command line.
+          // be overridden from command line.
           {
             set_use_matrix_free(snes, false, true);
           }
@@ -580,7 +580,7 @@ namespace PETScWrappers
     // In case solve_with_jacobian is provided, create a shell
     // preconditioner wrapping the user call. The internal Krylov
     // solver will apply the preconditioner only once. This choice
-    // can be overriden by command line and users can use any other
+    // can be overridden by command line and users can use any other
     // Krylov method if their solve is not accurate enough.
     // Using solve_with_jacobian as a preconditioner allows users
     // to provide approximate solvers and possibly iterate on a matrix-free
index dc301454efcb244b4c60c22fcc6fc05ef54ae222..8859a7e02ba5b25ed4927ff0b414401016b1413b 100644 (file)
@@ -79,7 +79,7 @@ namespace PETScWrappers
      * Initialize a Matrix from a PETSc Mat object. Note that we do not copy
      * the matrix. The Mat object is referenced by the newly created instance
      * of the class using PetscObjectReference. This is in line with the PETSc
-     * approach to object ownership, which mimicks std::shared_ptr.
+     * approach to object ownership, which mimics std::shared_ptr.
      */
     explicit SparseMatrix(const Mat &);
 
@@ -400,7 +400,7 @@ namespace PETScWrappers
        * Initialize a SparseMatrix from a PETSc Mat object. Note that we do not
        * copy the matrix. The Mat object is referenced by the newly created
        * instance of the class using PetscObjectReference. This is in line with
-       * the PETSc approach to object ownership, which mimicks std::shared_ptr.
+       * the PETSc approach to object ownership, which mimics std::shared_ptr.
        */
       explicit SparseMatrix(const Mat &);
 
index ea745c28f5cbef19a93722ec4100125d82d22281..92a088b3094da86bb23e09d4dde3c7810174ae59 100644 (file)
@@ -80,7 +80,7 @@ namespace PETScWrappers
      * Adaptive time stepping is disabled by default.
      * Negative values indicate using PETSc's default.
      *
-     * @note All parameters values specified here can be overriden by
+     * @note All parameters values specified here can be overridden by
      * command line choices.
      *
      * @ingroup PETScWrappers
index f071222ad9fe433ac962a90fc21bb8272b0ea666..412d594ea3aca6165ed21db8d5e86a15d0a0a9d4 100644 (file)
@@ -795,7 +795,7 @@ namespace PETScWrappers
         // case is to use FD and thus assemble a dense operator by finite
         // differencing the residual callbacks. Here instead we decide to
         // use a full matrix-free approach by default. This choice can always
-        // be overriden from command line.
+        // be overridden from command line.
         if (!explicit_jacobian && !implicit_jacobian)
           {
             set_use_matrix_free(ts, false, true);
@@ -805,7 +805,7 @@ namespace PETScWrappers
     // In case solve_with_jacobian is provided, create a shell
     // preconditioner wrapping the user call. The default internal Krylov
     // solver only applies the preconditioner. This choice
-    // can be overriden by command line and users can use any other
+    // can be overridden by command line and users can use any other
     // Krylov method if their solve is not accurate enough.
     // Using solve_with_jacobian as a preconditioner allow users
     // to provide approximate solvers and possibly iterate on a matrix-free
index 1180fcd6a04062ad5d3b77a0c1cd54ba6f0e0867..0311a9229f29f9535c31551c335c078f614b9af2 100644 (file)
@@ -364,7 +364,7 @@ public:
   };
 
   /**
-   * Consturctor.
+   * Constructor.
    */
   TensorProductMatrixSymmetricSumCollection(
     const AdditionalData &additional_data = AdditionalData());
index fdd8a8a7b900eb6d85cd19a3d9ac4ed6cdade2fa..a47e64c23d24a29945b30c37ca0c3edcaa6213ec 100644 (file)
@@ -1714,7 +1714,7 @@ protected:
  * want to compile all degrees up to eight; recommended setting) or by
  * compiling `evaluation_template_factory.templates.h` and
  * `evaluation_template_face_factory.templates.h` with the
- * `FE_EVAL_FACTORY_DEGREE_MAX` overriden to the desired value. In the second
+ * `FE_EVAL_FACTORY_DEGREE_MAX` overridden to the desired value. In the second
  * option, symbols will be available twice, and it depends on your linker and
  * dynamic library loader whether the user-specified setting takes precedence;
  * use `LD_PRELOAD` to select the desired library. You can check if fast
index 0d7bfaf2ce3793183b8043a0d944cc5c7b72cbe0..4f71313c4668b28183d4c6f137b9810f03b2ca68 100644 (file)
@@ -1308,7 +1308,7 @@ private:
   bool fast_path;
 
   /**
-   * Connection to NonMatching::MappingInfo to check wheter mapping data
+   * Connection to NonMatching::MappingInfo to check whether mapping data
    * has been invalidated.
    */
   boost::signals2::connection connection_is_reinitialized;
index 5d61790fa2a17927d07573f3bd9e88b42f7bf486..f83790bb16c66a0540e46e7414b6e6dbf6d889ff 100644 (file)
@@ -334,7 +334,7 @@ namespace MatrixFreeTools
       matrix_free;
 
     /**
-     * Index of the valid FE. Currently, ony a single one is supported.
+     * Index of the valid FE. Currently, only a single one is supported.
      */
     unsigned int fe_index_valid;
   };
index 0248882e9ca71bbafd57e03c272e9bf587d53758..70ad11a2b24318d8cabc5f475d00e55170cef2ff 100644 (file)
@@ -3572,7 +3572,7 @@ namespace internal
         dof_handler.get_fe().n_dofs_per_cell() ==
           dof_handler_support_points.get_fe().n_dofs_per_cell(),
         ExcMessage(
-          "For now multple components are not considered and therefore DoFHandlers need the same degree."));
+          "For now multiple components are not considered and therefore DoFHandlers need the same degree."));
 
       const auto degree        = dof_handler.get_fe().degree;
       const auto dofs_per_cell = dof_handler.get_fe().n_dofs_per_cell();
index f2a62418a186cb7f0ae16bf5df528adcd788fb96..27ef91def70ff6775a0c87e0c7962f0c6f7f485b 100644 (file)
@@ -80,7 +80,7 @@ namespace mg
      * is
      * false) the call to the coarse solver on @p level.
      *
-     * The coarse solve will be done with ``defect[leve]`` and returned in
+     * The coarse solve will be done with ``defect[level]`` and returned in
      * ``solution[level]``, which can be inspected by the user using this
      * signal.
      */
index 2ec66fd1813cd111005beb1782e5e768e3edbd4f..f1e9272811a6c0dc58eef11df8d2cece234a03db 100644 (file)
@@ -114,7 +114,7 @@ namespace OpenCASCADE
    * Read IGES files and translate their content into openCascade topological
    * entities. The option scale_factor is used to compensate for different
    * units being used in the IGES files and in the target application. The
-   * standard unit for IGES files is millimiters. The return object is a
+   * standard unit for IGES files is millimeters. The return object is a
    * TopoDS_Shape which contains all objects from the file.
    */
   TopoDS_Shape
@@ -165,7 +165,7 @@ namespace OpenCASCADE
    * Read STEP files and translate their content into openCascade topological
    * entities. The option scale_factor is used to compensate for different
    * units being used in the STEP files and in the target application. The
-   * standard unit for STEP files is millimiters. The return object is a
+   * standard unit for STEP files is millimeters. The return object is a
    * TopoDS_Shape which contains all objects from the file.
    */
   TopoDS_Shape
index ff01bd7700b36ba663839aceb6ec8af8cc90b94b..4004580d922ae16b744f8551d1b442a612a9e659 100644 (file)
@@ -288,8 +288,8 @@ namespace TrilinosWrappers
      * $[\nabla_u F(u)]^{-1}$ to
      * @p y, writes the result in @p x and returns the number of
      * linear iterations the linear solver needed.
-     * The parameter @p tolerance species the error reduction if a
-     * interative solver is used. The Jacobian to be used
+     * The parameter @p tolerance species the error reduction if an
+     * iterative solver is used. The Jacobian to be used
      * (i.e., more precisely: the linearization point $u$ above) is
      * the one computed when the `setup_jacobian` function was last called.
      *
index 33c3ee36504e9645e9bb4f4e1f6d4ae09a8dba80..f91a9784b881dad01d32f7d45c8de89117dd45c3 100644 (file)
@@ -354,7 +354,7 @@ namespace TrilinosWrappers
       {
       public:
         /**
-         * Constructor. The class is intialized by the solution vector and
+         * Constructor. The class is initialized by the solution vector and
          * functions to compute the residual, to setup the jacobian, and
          * to solve the Jacobian.
          */
@@ -956,7 +956,7 @@ namespace TrilinosWrappers
   void
   NOXSolver<VectorType>::clear()
   {
-    // clear interal counters
+    // clear internal counters
     n_residual_evaluations   = 0;
     n_jacobian_applications  = 0;
     n_nonlinear_iterations   = 0;
@@ -987,7 +987,7 @@ namespace TrilinosWrappers
 
         n_residual_evaluations++;
 
-        // evalute residual
+        // evaluate residual
         return internal::NOXWrappers::call_and_possibly_capture_exception(
           residual, pending_exception, x, f);
       },
index 0e72443c5d290912236e3f93b1cc4a945ca6c34c..87307b1074ab6cc75ef7ce98d240fd3fa0342a20 100644 (file)
@@ -794,7 +794,7 @@ namespace Utilities
         argv_new[argc]     = const_cast<char *>(threads_flag_string.c_str());
         argv_new[argc + 1] = nullptr;
         // The first argument in Kokkos::initialize is of type int&. Hence, we
-        // need to define a new variable to pass to it (insted of using argc+1
+        // need to define a new variable to pass to it (instead of using argc+1
         // inline).
         int argc_new = argc + 1;
         Kokkos::initialize(argc_new, argv_new.data());
index 3d89cea8031a99e56386b131f6f5f1ced1398da4..d64f65bb80244f3a495da86866ea09561f7c7a93 100644 (file)
@@ -37,7 +37,7 @@ PathSearch::initialize_classes()
   path_lists.insert(map_type(std::string("PARAMETER"), v));
 
   /*
-   * TODO: reenable some sensible default paths. Maier, 2012
+   * TODO: re-enable some sensible default paths. Maier, 2012
    */
   path_lists.insert(map_type(std::string("MESH"), v));
 
index 8bdac599c5db36c2d94db77c682f47790ed8dec8..20994ff6909b46a08d7b52082427c0df74d8aa92 100644 (file)
@@ -2293,7 +2293,7 @@ namespace DoFTools
   }
 
 
-  // This functino is deprecated:
+  // This function is deprecated:
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED_EARLY void
   map_dofs_to_support_points(
@@ -2314,7 +2314,7 @@ namespace DoFTools
   }
 
 
-  // This functino is deprecated:
+  // This function is deprecated:
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED_EARLY void
   map_dofs_to_support_points(
index 43dead96e9e228e8d2ff04890448815973a35f69..3162580712701e2d030e8b70e4cc8cc1af9f0558 100644 (file)
@@ -6771,7 +6771,7 @@ namespace GridTools
       std::stable_sort(recv_components.begin(),
                        recv_components.end(),
                        [&](const auto &a, const auto &b) {
-                         // intersecton index
+                         // intersection index
                          if (std::get<1>(a) != std::get<1>(b))
                            return std::get<1>(a) < std::get<1>(b);
 
index 5c529a5006c079e668d1419caa81193ba2091011..9db5f83f2fc2e3aac0c9399d6db8f9355333a051 100644 (file)
@@ -164,7 +164,7 @@ namespace PETScWrappers
       PetscErrorCode ierr;
 
       // Create empty matrices if needed
-      // This is neeeded by the base class
+      // This is needed by the base class
       // not by MATNEST
       std::vector<size_type> row_sizes(m, size_type(-1));
       std::vector<size_type> col_sizes(n, size_type(-1));
index 79d2ca98fbf479d54e746d2c1d6b812eb86dda5c..d5b8b2f37e30c8ca45bee20e55c53852923c5844 100644 (file)
@@ -102,7 +102,7 @@ namespace PETScWrappers
 
         /*
          * by default we set up the preconditioner only once.
-         * this can be overriden by command line.
+         * this can be overridden by command line.
          */
         AssertPETSc(KSPSetReusePreconditioner(ksp, PETSC_TRUE));
       }
@@ -755,7 +755,7 @@ namespace PETScWrappers
 
         /*
          * by default we set up the preconditioner only once.
-         * this can be overriden by command line.
+         * this can be overridden by command line.
          */
         AssertPETSc(KSPSetReusePreconditioner(ksp, PETSC_TRUE));
       }

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.