From 45b63462157671afbd1ada876fe423a86d6bce60 Mon Sep 17 00:00:00 2001
From: David Wells <drwells@email.unc.edu>
Date: Tue, 18 May 2021 10:49:49 -0400
Subject: [PATCH] Fix double-word typos

---
 include/deal.II/base/exceptions.h                   |  2 +-
 include/deal.II/dofs/dof_accessor.templates.h       | 12 ++++++------
 include/deal.II/fe/fe_raviart_thomas.h              |  2 +-
 include/deal.II/grid/connectivity.h                 |  2 +-
 include/deal.II/lac/dynamic_sparsity_pattern.h      |  2 +-
 include/deal.II/matrix_free/matrix_free.h           |  2 +-
 include/deal.II/matrix_free/shape_info.templates.h  |  2 +-
 include/deal.II/matrix_free/tools.h                 |  2 +-
 include/deal.II/numerics/vector_tools_interpolate.h |  2 +-
 include/deal.II/particles/partitioner.h             |  2 +-
 10 files changed, 15 insertions(+), 15 deletions(-)

diff --git a/include/deal.II/base/exceptions.h b/include/deal.II/base/exceptions.h
index ef28990b3f..fefe383ab4 100644
--- a/include/deal.II/base/exceptions.h
+++ b/include/deal.II/base/exceptions.h
@@ -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
   /**
diff --git a/include/deal.II/dofs/dof_accessor.templates.h b/include/deal.II/dofs/dof_accessor.templates.h
index 7056074fc3..b6f11ba067 100644
--- a/include/deal.II/dofs/dof_accessor.templates.h
+++ b/include/deal.II/dofs/dof_accessor.templates.h
@@ -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),
diff --git a/include/deal.II/fe/fe_raviart_thomas.h b/include/deal.II/fe/fe_raviart_thomas.h
index 29a071f82d..0679aa3429 100644
--- a/include/deal.II/fe/fe_raviart_thomas.h
+++ b/include/deal.II/fe/fe_raviart_thomas.h
@@ -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
diff --git a/include/deal.II/grid/connectivity.h b/include/deal.II/grid/connectivity.h
index 9e5b44924d..70fb2e2e03 100644
--- a/include/deal.II/grid/connectivity.h
+++ b/include/deal.II/grid/connectivity.h
@@ -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
diff --git a/include/deal.II/lac/dynamic_sparsity_pattern.h b/include/deal.II/lac/dynamic_sparsity_pattern.h
index c10610e52c..f85c4904fd 100644
--- a/include/deal.II/lac/dynamic_sparsity_pattern.h
+++ b/include/deal.II/lac/dynamic_sparsity_pattern.h
@@ -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
diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h
index 9d42ac0e58..53fe0202be 100644
--- a/include/deal.II/matrix_free/matrix_free.h
+++ b/include/deal.II/matrix_free/matrix_free.h
@@ -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
diff --git a/include/deal.II/matrix_free/shape_info.templates.h b/include/deal.II/matrix_free/shape_info.templates.h
index 591010b170..28a9368426 100644
--- a/include/deal.II/matrix_free/shape_info.templates.h
+++ b/include/deal.II/matrix_free/shape_info.templates.h
@@ -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
diff --git a/include/deal.II/matrix_free/tools.h b/include/deal.II/matrix_free/tools.h
index 22f11b0ec2..7e6b25cf4c 100644
--- a/include/deal.II/matrix_free/tools.h
+++ b/include/deal.II/matrix_free/tools.h
@@ -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
diff --git a/include/deal.II/numerics/vector_tools_interpolate.h b/include/deal.II/numerics/vector_tools_interpolate.h
index db14f84b52..3e5e63754c 100644
--- a/include/deal.II/numerics/vector_tools_interpolate.h
+++ b/include/deal.II/numerics/vector_tools_interpolate.h
@@ -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).
    */
diff --git a/include/deal.II/particles/partitioner.h b/include/deal.II/particles/partitioner.h
index 44c7cf30d1..b9fc11d837 100644
--- a/include/deal.II/particles/partitioner.h
+++ b/include/deal.II/particles/partitioner.h
@@ -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;
-- 
2.39.5