]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix double-word typos
authorDavid Wells <drwells@email.unc.edu>
Tue, 18 May 2021 14:49:49 +0000 (10:49 -0400)
committerDavid Wells <drwells@email.unc.edu>
Tue, 18 May 2021 14:49:49 +0000 (10:49 -0400)
include/deal.II/base/exceptions.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/fe/fe_raviart_thomas.h
include/deal.II/grid/connectivity.h
include/deal.II/lac/dynamic_sparsity_pattern.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/shape_info.templates.h
include/deal.II/matrix_free/tools.h
include/deal.II/numerics/vector_tools_interpolate.h
include/deal.II/particles/partitioner.h

index ef28990b3fee4d3e189fd03c1ef080e89c065f98..fefe383ab410059f893fed9731130f6c61281365 100644 (file)
@@ -1154,7 +1154,7 @@ namespace StandardExceptions
     ExcNeedsExodusII,
     "You are attempting to use functionality that is only available if deal.II "
     "was configured to use Trilinos' SEACAS library (which provides ExodusII), "
-    "but cmake did not find find a valid SEACAS library.");
+    "but cmake did not find a valid SEACAS library.");
 
 #ifdef DEAL_II_WITH_MPI
   /**
index 7056074fc3d1ab31e1229d7d7273f7908388d44e..b6f11ba067ca1c04deab5096a5d2ccf7dd768ce0 100644 (file)
@@ -794,9 +794,9 @@ namespace internal
         const unsigned int fe_index_,
         const bool         count_level_dofs)
       {
-        // note: we cannot rely on the the template parameter level_dof_access
-        // here, since the function get_mg_dof_indices()/set_mg_dof_indices()
-        // can be called even if level_dof_access==false.
+        // note: we cannot rely on the template parameter level_dof_access here,
+        // since the function get_mg_dof_indices()/set_mg_dof_indices() can be
+        // called even if level_dof_access==false.
         if (count_level_dofs)
           {
             const auto &fe = accessor.get_fe(fe_index_);
@@ -891,9 +891,9 @@ namespace internal
         const DoFOperation &dof_operation,
         const bool          count_level_dofs)
       {
-        // we cannot rely on the the template parameter level_dof_access
-        // here, since the function get_mg_dof_indices()/set_mg_dof_indices()
-        // can be called even if level_dof_access==false.
+        // we cannot rely on the template parameter level_dof_access here, since
+        // the function get_mg_dof_indices()/set_mg_dof_indices() can be called
+        // even if level_dof_access==false.
         (void)count_level_dofs;
 
         AssertIndexRange(n_dof_indices(accessor, fe_index, count_level_dofs),
index 29a071f82dcd98622fe35b9790827b81e4e2371f..0679aa3429bdf6bd74ba716f1803610d34923447 100644 (file)
@@ -252,7 +252,7 @@ private:
    * dof_index / n</code> (integer division). The indices <code>i</code> and
    * <code>j</code> can then be used to compute the offset.
    *
-   * For our example of Raviart-Thomas elements this means if if the
+   * For our example of Raviart-Thomas elements this means if the
    * switches are <code>(true | true | true)</code> that means we rotate the
    * face first by + 90 degree(counterclockwise) then by another +180
    * degrees but we do not flip it since the face has standard
index 9e5b44924ddcbc5e5ff05905cf5067e0e817db9a..70fb2e2e034cd1b9ab8afdfccba1d99711f1f89f 100644 (file)
@@ -939,7 +939,7 @@ namespace internal
      *
      * @p con_cf connectivity cell-face
      * @p con_cc connectivity cell-cell (for each cell-face it contains the
-     *   the index of the neighboring cell or -1 for boundary face)
+     *   index of the neighboring cell or -1 for boundary face)
      */
     template <typename T>
     void
index c10610e52ca9f946a44a2c83761958a7881c7a35..f85c4904fd6098bbcd7518742748044ffbe4e019 100644 (file)
@@ -472,7 +472,7 @@ public:
 
   /**
    * Construct and store in this object the sparsity pattern corresponding to
-   * the product of transposed @p left and and non-transpose @p right sparsity pattern.
+   * the product of transposed @p left and non-transpose @p right sparsity pattern.
    */
   template <typename SparsityPatternTypeLeft, typename SparsityPatternTypeRight>
   void
index 9d42ac0e58a09741e74c4b9506b2c87a148ca78f..53fe0202befc1c1d777588206f28156964906f44 100644 (file)
@@ -977,7 +977,7 @@ public:
    * (including the MPI data exchange), allowing to execute some vector update
    * that the `src` vector depends upon. The `operation_after_loop` is similar
    * - it starts to execute on a range of DoFs once all DoFs in that range
-   * have been touched for the last time time by the `cell_operation`
+   * have been touched for the last time by the `cell_operation`
    * (including the MPI data exchange), allowing e.g. to compute some vector
    * operations that depend on the result of the current cell loop in `dst` or
    * want to modify `src`. The efficiency of caching depends on the numbering
index 591010b170ebd4925a58f0da38989dc48f6325c2..28a9368426137caf87b6cbac802e944aa41cb694 100644 (file)
@@ -321,7 +321,7 @@ namespace internal
             if (reference_cell != temp.first)
               {
                 // TODO: this might happen if the quadrature rule and the
-                // the FE do not match
+                // FE do not match
                 this->n_q_points_face = 0;
               }
             else
index 22f11b0ec227e2195b5121d769d2b7ef9fa5b296..7e6b25cf4c2d196a5e75ac5c671783dd8622c939 100644 (file)
@@ -481,7 +481,7 @@ namespace MatrixFreeTools
         //          (C_e^T(j,:) * A_e(:,i)) * C_e(i,j)
         //       or
         //          (C_e^T(j,:) * A_e(:,i)) * C_e^T(j,i)
-        //       This gives a contribution the the j-th entry of the
+        //       This gives a contribution the j-th entry of the
         //       locally-relevant diagonal and comprises the multiplication
         //       by the locally-relevant constraint matrix from the left and
         //       the right. There is no contribution to the j-th vector
index db14f84b52d8fce0b47d9c1e0994258e10285582..3e5e63754cac0fcb4d73644cd72f17e38f8155ac 100644 (file)
@@ -289,7 +289,7 @@ namespace VectorTools
    * Like the above function but also taking @p mapping as argument.
    * This will introduce an additional approximation between the true geometry
    * specified by the manifold if the degree of the mapping is lower than the
-   * degree of the finite finite element in the DoFHandler @p dh, but more
+   * degree of the finite element in the DoFHandler @p dh, but more
    * importantly it allows to fill location vectors for mappings that do not
    * preserve vertex locations (like Eulerian mappings).
    */
index 44c7cf30d1925244cced032c8a331fdd1e822bb6..b9fc11d837690aa4a609247e12d8fc5144a29317 100644 (file)
@@ -109,7 +109,7 @@ namespace Particles
       /**
        * Temporary storage that holds the data of the particles to receive
        * the ghost particles information from other processors in
-       * in update_ghost_particles()
+       * update_ghost_particles()
        * send_recv_particles_properties_and_location()
        */
       std::vector<char> recv_data;

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.