]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix various typos
authorluz paz <luzpaz@pm.me>
Sat, 30 Jul 2022 02:55:24 +0000 (22:55 -0400)
committerluz paz <luzpaz@pm.me>
Sat, 30 Jul 2022 02:55:24 +0000 (22:55 -0400)
Fix typos found in source/, include/, and doc/
Found via `codespell -q 3 -S ./bundled,./doc/news -L ba,commend,nd,pres,ro,rotat,stoer,workd`

22 files changed:
doc/developers/testsuite.html
doc/doxygen/headers/automatic_and_symbolic_differentiation.h
doc/users/cmake_dealii.html
include/deal.II/cgal/triangulation.h
include/deal.II/fe/mapping.h
include/deal.II/grid/tria.h
include/deal.II/lac/read_write_vector.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/non_matching/fe_immersed_values.h
include/deal.II/opencascade/utilities.h
include/deal.II/optimization/line_minimization.h
include/deal.II/particles/data_out.h
source/base/parameter_handler.cc
source/distributed/tria.cc
source/dofs/dof_handler_policy.cc
source/fe/fe_system.cc
source/grid/grid_tools.cc
source/grid/grid_tools_nontemplates.cc
source/grid/tria.cc
source/lac/cuda_vector.cu
source/opencascade/utilities.cc
source/particles/generators.cc

index 55f0b4c812fbbe43c07a01815b2bcbc5d0536c30..1442d731626c1e5283f270d28789e9e3de369c25 100644 (file)
@@ -640,7 +640,7 @@ category/test.expect=run.output
 </pre>
     </p>
     <p>
-      The testsuite also suppors the special file ending
+      The testsuite also supports the special file ending
       <code>.run_only</code> that indicates that the diff stage should be
       skipped in order to reach the <code>PASSED</code> stage. You can
       specify the keyword by changing the file ending from
index 42368c46e1eeceb17a3950bf5d307c76287a1b8b..73cbd8fcc5d06b480e3b2e6315cb588e518dcb50 100644 (file)
  *
  * With the aid of the diagram below (it and some of the listed details courtesy of this
  * <a href="https://en.wikipedia.org/wiki/Automatic_differentiation">Wikipedia article</a>),
- * let us think about the represention of the calculation of the function
+ * let us think about the representation of the calculation of the function
  * $f (\mathbf{x}) = \sin (x_{1}) + x_{1} x_{2}$ and its derivatives:
  *
  * <div class="twocolumn" style="width: 80%">
index 72eec1dba75ce97d68297d103f7308933d26ef09..799e3f5f78dba923b3558f061d746aa8308c9d79 100644 (file)
@@ -423,7 +423,7 @@ library        - builds and installs the 'library' component
       you want to override this behavior, please set the C++ standard
       directly for example by configuring with
       <code>-DDEAL_II_CXX_FLAGS="-std=c++17"</code>, or by setting the
-      environement variable <code>CXXFLAGS="-std=c++17"</code>.
+      environment variable <code>CXXFLAGS="-std=c++17"</code>.
 
       Similarly, for enabling SIMD vectorization support, you have to set
       an appropriate target architecture via <code>-march=...</code>, for
index 3bc434f5de738270d657319dda175bcf271b3921..4a21a41489b40c77c7fe86609feffdbebeda7e71 100644 (file)
@@ -368,7 +368,7 @@ namespace CGALWrappers
           // This is a degenerate Triangulation_2, made of edges
           for (const auto &e : cgal_triangulation.finite_edges())
             {
-              // An edge is idendified by a face and a vertex index in the
+              // An edge is identified by a face and a vertex index in the
               // face
               const auto &  f = e.first;
               const auto &  i = e.second;
@@ -408,7 +408,7 @@ namespace CGALWrappers
           // This is a degenerate Triangulation_3, made of triangles
           for (const auto &facet : cgal_triangulation.finite_facets())
             {
-              // A facet is idenfied by a cell and the opposite vertex index
+              // A facet is identified by a cell and the opposite vertex index
               // in the face
               const auto &  c = facet.first;
               const auto &  i = facet.second;
@@ -430,7 +430,7 @@ namespace CGALWrappers
           // This is a degenerate Triangulation_3, made of edges
           for (const auto &edge : cgal_triangulation.finite_edges())
             {
-              // An edge is idenfied by a cell and its two vertices
+              // An edge is identified by a cell and its two vertices
               const auto &[c, i, j] = edge;
               CellData<dim> cell(ReferenceCells::Line.n_vertices());
               cell.vertices[0] = vertex_map[c->vertex(i)];
index 9335dce1d2dc2fc0ef0576196f6cab91484dc2cf..ab85730c037585bec909df1bd59a1cfc2007840c 100644 (file)
@@ -134,7 +134,7 @@ enum MappingKind
   /**
    * The mappings for 2-forms and third order tensors.
    *
-   * These are mappings typpically applied to hessians transformed to the
+   * These are mappings typically applied to hessians transformed to the
    * reference cell.
    *
    * Mapping of the hessian of a covariant vector field (see
index b990e26c3ed4650afc219aad5fe54bfbaa992f0f..ae36c0c9b86bcc7317a0f99b4d9ec2d61ae19f22 100644 (file)
@@ -4067,7 +4067,7 @@ private:
   reset_active_cell_indices();
 
   /**
-   * Reset global cell ids and globale level cell ids.
+   * Reset global cell ids and global level cell ids.
    */
   void
   reset_global_cell_indices();
index d7587f5712696ec57e8a776054e3d0779de84828..6972b59584d8de0f408dd536ec7e0da36c220499 100644 (file)
@@ -252,7 +252,7 @@ namespace LinearAlgebra
     if (omit_zeroing_entries == false)
       this->operator=(Number());
 
-    // reset the communication patter
+    // reset the communication pattern
     source_stored_elements.clear();
     comm_pattern.reset();
   }
@@ -272,7 +272,7 @@ namespace LinearAlgebra
     if (omit_zeroing_entries == false)
       this->operator=(Number());
 
-    // reset the communication patter
+    // reset the communication pattern
     source_stored_elements.clear();
     comm_pattern.reset();
   }
index 1c1748ddd26df0ea977eaea8f65aaf0393b8204b..2947626c3efc1e50a4c7cc5ede57dbf556f67418 100644 (file)
@@ -503,7 +503,7 @@ public:
      * Such an example is "local time stepping", where cells of different
      * caterogries progress with different time-step sizes and, as a
      * consequence, can only processed together with cells with the same
-     * cateogry.
+     * category.
      *
      * This array is accessed by the number given by cell->active_cell_index()
      * when working on the active cells (with
index b9163c620cc7ca6537dcccf5471be7891fda3428..8ee37ac395ee5cadd9df343ee1e255db4752018d 100644 (file)
@@ -76,7 +76,7 @@ namespace NonMatching
     reinit(const typename Triangulation<dim>::cell_iterator &cell);
 
     /**
-     * Reinitialize quantitites (shape function values, gradients, etc) for the
+     * Reinitialize quantities (shape function values, gradients, etc) for the
      * given cell of type "iterator into a DoFHandler object", and the finite
      * element associated with this object.
      */
index 6701c4cdbc26a31fa0414c34b8496c5dfa4e2f55..f651081bab05c7eda162cfc1d011f872da8060af 100644 (file)
@@ -142,7 +142,7 @@ namespace OpenCASCADE
    * mesh it automatically. We remark that the automatic mesh generation in
    * OpenCASCADE takes care only of the geometrical resemblance between the
    * shape and the mesh, to control the shape and regularity of the triangles
-   * you should use other meshing softwares. The two arguments `deflection` and
+   * you should use other meshing software. The two arguments `deflection` and
    * `angular_deflection` select the accuracy of the created triangulation with
    * respect to the original topological shape. The argument
    * `sew_different_faces` gives the possibility to use a Sewer from OpenCASCADE
index 4b00292e36f6c1672bf61ac5d2c4857a13f64d8b..65e2587492b1e7651420f5726493d0ce9e0c2ee2 100644 (file)
@@ -251,7 +251,7 @@ namespace LineMinimization
    *
    *   // Next we can write a function to determine if taking the full Newton
    *   // step is a good idea or not (i.e. if it offers good convergence
-   *   // characterisics). This function calls the one we defined above,
+   *   // characteristics). This function calls the one we defined above,
    *   // and actually only performs the line search if an early exit
    *   // criterion is not met.
    *   auto perform_linesearch = [&]()
index 492e4120cd4005794e50483445db8bcbd5be46e6..0f127a7e6a766e95b0643ba094d4644aefff76ae 100644 (file)
@@ -35,7 +35,7 @@ namespace Particles
    * This class generates graphical output for the particles stored by a
    * ParticleHandler object. From a particle handler, it generates patches which
    * can then be used to write traditional output files. This class currently
-   * only supports witing the particle position and their ID and does not allow
+   * only supports writing the particle position and their ID and does not allow
    * to write the properties attached to the particles
    *
    * @ingroup Particle
index 316e40271d78017e965271fd16c977d6e388234d..7da508bf4987d407a12fe20f094f75936e417a9d 100644 (file)
@@ -304,7 +304,7 @@ namespace
           (is_parameter_node(b.second) || is_alias_node(b.second));
 
         // If a is a parameter/alias and b is a subsection,
-        // a should go first, and viceversa.
+        // a should go first, and vice-versa.
         if (a_is_param && !b_is_param)
           return true;
 
index 4c23803e72d87183c7f0aaab5be90da875aaec4a..f8ba6206eb8197c3ff78109b4ec3e49c8be40e53 100644 (file)
@@ -585,7 +585,7 @@ namespace
 
   public:
     /**
-     * Callback exectuted before point function. Last argument is always
+     * Callback executed before point function. Last argument is always
      * nullptr.
      *
      * @return `int` interpreted as a C "bool". Zero means "stop the recursion".
index 010f40f17854dd8c370abaef899feff71dbed860..34986fd390a5a24fb16dc4964a61958a35eddc2a 100644 (file)
@@ -788,7 +788,7 @@ namespace internal
             (typename DoFHandler<dim, spacedim>::ExcOnlyAvailableWithHP()));
 
           // this function should only be called for dim<3 where there are
-          // no quad dof identies. for dim==3, the specialization below should
+          // no quad dof identities. for dim==3, the specialization below should
           // take care of it
           Assert(dim < 3, ExcInternalError());
 
@@ -1518,7 +1518,7 @@ namespace internal
             (typename DoFHandler<dim, spacedim>::ExcOnlyAvailableWithHP()));
 
           // this function should only be called for dim<3 where there are
-          // no quad dof identies. for dim>=3, the specialization below should
+          // no quad dof identities. for dim>=3, the specialization below should
           // take care of it
           Assert(dim < 3, ExcInternalError());
         }
index 2e7f0fd5e5fca6333dac3b64b7dafb78028938af..d74476d1a8dfe2498a7b6a021133fdc8ae6d0841 100644 (file)
@@ -1535,7 +1535,7 @@ void
 FESystem<dim, spacedim>::build_interface_constraints()
 {
   // check whether all base elements implement their interface constraint
-  // matrices. if this is not the case, then leave the interface costraints of
+  // matrices. if this is not the case, then leave the interface constraints of
   // this composed element empty as well; however, the rest of the element is
   // usable
   for (unsigned int base = 0; base < this->n_base_elements(); ++base)
index b94f8c147a6303be300fb16defcb3982dafc3238..de63f709d97d7d419ba2b7ec8394c57f202c9fb2 100644 (file)
@@ -6443,7 +6443,7 @@ namespace GridTools
     std::map<unsigned int, std::vector<unsigned int>> &coinciding_vertex_groups,
     std::map<unsigned int, unsigned int> &vertex_to_coinciding_vertex_group)
   {
-    // 1) determine for each vertex a vertex it concides with and
+    // 1) determine for each vertex a vertex it coincides with and
     //    put it into a map
     {
       static const int lookup_table_2d[2][2] =
index 47cc52915e3628e8c7fbde9f619911b3d2fb9148..67d09e0a9fa85cc6fda9eb74f0f674ff48841117 100644 (file)
@@ -96,7 +96,7 @@ namespace GridTools
 
       # C(measure, optimized);
 
-      additional optimizaton: divide by 2 only one time
+      additional optimization: divide by 2 only one time
     */
 
     const double x[4] = {all_vertices[vertex_indices[0]](0),
index eaa30ee9eb0608b2c644b12897517ca9aa5f0883..7c94de04ef036cad3aa05c8c4de742a7ff508735 100644 (file)
@@ -13288,7 +13288,7 @@ Triangulation<dim, spacedim>::end(const unsigned int level) const
 {
   // This function may be called on parallel triangulations on levels
   // that exist globally, but not on the local portion of the
-  // triangulation. In that case, just retrn the end iterator.
+  // triangulation. In that case, just return the end iterator.
   //
   // We need to use levels.size() instead of n_levels() because the
   // latter function uses the cache, but we need to be able to call
index d9f6cc4f74fece66ed430aaf989dc01f02e7ddb2..44288c755de5fc81f515fbc5495531a776397386 100644 (file)
@@ -592,7 +592,7 @@ namespace LinearAlgebra
       Assert(dynamic_cast<const Vector<Number> *>(&W) != nullptr,
              ExcVectorTypeNotCompatible());
 
-      // Downcast V and W. If it fails, throw an exceptiion.
+      // Downcast V and W. If it fails, throw an exception.
       const Vector<Number> &down_V = dynamic_cast<const Vector<Number> &>(V);
       Assert(down_V.size() == this->size(),
              ExcMessage("Vector V has the wrong size."));
index 775af7a13e2bf786e05720462a333f237caa1c80..a89e5484dc22ecefe097be8e19c7cb814a7d7e7c 100644 (file)
@@ -867,7 +867,7 @@ namespace OpenCASCADE
     Standard_Real Max_Curvature = props.MaxCurvature();
     Tensor<1, 3>  normal        = Point<3>(Normal.X(), Normal.Y(), Normal.Z());
 
-    // In the case your manifold changes from convex to concave or viceversa
+    // In the case your manifold changes from convex to concave or vice-versa
     // the normal could jump from "inner" to "outer" normal.
     // However, you should be able to change the normal sense preserving
     // the manifold orientation:
index 18447fa2575ac18062c6c265eac4f25f9a402e44..f90e93dcf309ac66ab0c0288b6d384a72f2d96cb 100644 (file)
@@ -361,7 +361,7 @@ namespace Particles
           std::llround(static_cast<double>(n_particles_to_create) *
                        local_start_weight / global_weight_integral);
 
-        // Calcualate number of local particles
+        // Calculate number of local particles
         const types::particle_index end_particle_id =
           std::llround(static_cast<double>(n_particles_to_create) *
                        ((local_start_weight + local_weight_integral) /

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.