]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove double word typos. 6164/head
authorDavid Wells <wellsd2@rpi.edu>
Thu, 5 Apr 2018 14:30:38 +0000 (10:30 -0400)
committerDavid Wells <wellsd2@rpi.edu>
Thu, 5 Apr 2018 14:30:38 +0000 (10:30 -0400)
This commit removes typos consisting of an accidentally repeated
word. Attached below is the python script I used to find them.

It is worth noting that there is a large false positive rate here, for
example, in tria_accessor.h we have the sentence

/**
 * [...] As a
 * consequence, it exists in the mesh to ensure that each processor has all
 * coarse mesh cells and that the 2:1 ratio of neighboring cells is
 * maintained, but it is not one of the cells we should work on on the
 * current processor. [...]
 */

Here 'on on' is correct.

script:

import sys

SKIP = ["//", "*", "}", "|", "};", ">", "\"", "|", "/", "numbers::invalid_unsigned_int,", "std::string,", "int,"]

with open(sys.argv[1], 'r') as handle:
    previous_line = ""
    for line_n, line in enumerate(handle):
        line = line.strip()
        previous_words = previous_line.split()
        words = line.split()
        # ignore comment blocks '*' and comment starts '//' at the beginning of
        # each line.
        if len(words) == 0:
            continue
        if words[0] in ["*", "//"]:
            words = words[1:]

        # See if the last word on the previous line is equal to the first word
        # on the current line.
        if len(previous_words) != 0:
            if words[0] not in SKIP and previous_words[-1] == words[0]:
                print(sys.argv[1] + ":{}: {}".format(line_n + 1, previous_line))
                print(sys.argv[1] + ":{}: {}".format(line_n + 2, line))
        previous_line = line

        for left_word, right_word in zip(words[:-1], words[1:]):
            if left_word == right_word and left_word not in SKIP:
                print(sys.argv[1] + ":{}: {}".format(line_n + 1, line))

38 files changed:
examples/step-16/step-16.cc
examples/step-22/step-22.cc
examples/step-31/doc/results.dox
examples/step-50/step-50.cc
examples/step-54/doc/intro.dox
include/deal.II/base/mpi.h
include/deal.II/base/quadrature.h
include/deal.II/base/tensor.h
include/deal.II/base/timer.h
include/deal.II/base/utilities.h
include/deal.II/dofs/dof_renumbering.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_dgp.h
include/deal.II/fe/fe_dgp_monomial.h
include/deal.II/fe/fe_dgp_nonparametric.h
include/deal.II/fe/fe_dgq.h
include/deal.II/fe/fe_enriched.h
include/deal.II/fe/fe_face.h
include/deal.II/fe/fe_nedelec.h
include/deal.II/fe/fe_nothing.h
include/deal.II/fe/fe_q_base.h
include/deal.II/fe/fe_system.h
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/fe/fe_trace.h
include/deal.II/fe/fe_values.h
include/deal.II/fe/mapping_q_generic.h
include/deal.II/grid/grid_refinement.h
include/deal.II/grid/grid_reordering.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/manifold_lib.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_accessor.h
include/deal.II/lac/cuda_sparse_matrix.h
include/deal.II/lac/scalapack.h
include/deal.II/matrix_free/cuda_fe_evaluation.h
include/deal.II/numerics/data_postprocessor.h
include/deal.II/numerics/vector_tools.h
include/deal.II/sundials/arkode.h

index f8ce6e61df078cb63c4b8410f27117fb5bc6f6fd..46a06dfbbda48e565c74e74c94940d120cd59448 100644 (file)
@@ -599,7 +599,7 @@ namespace Step16
 
   // @sect4{LaplaceProblem::run}
 
-  // Like several of the functions above, this is almost exactly a copy of of
+  // Like several of the functions above, this is almost exactly a copy of
   // the corresponding function in step-6. The only difference is the call to
   // <code>assemble_multigrid</code> that takes care of forming the matrices
   // on every level that we need in the multigrid method.
index 728724642e15264cea99575ab91c5b43675f736d..56a3dc7d9581c0adf6eb67d231c3583cf762dd5b 100644 (file)
@@ -410,7 +410,7 @@ namespace Step22
   // reduces the bandwidth of the matrix, or maybe more importantly: in such a
   // way that the ILU is as close as possible to a real LU decomposition. On
   // the other hand, we need to preserve the block structure of velocity and
-  // pressure already seen in in step-20 and step-21. This is done in two
+  // pressure already seen in step-20 and step-21. This is done in two
   // steps: First, all dofs are renumbered to improve the ILU and then we
   // renumber once again by components. Since
   // <code>DoFRenumbering::component_wise</code> does not touch the
index fd201549be50d39460579b0d030b5d3c704aafca..030fe4634c0abd308f5f889ea8c186e1c7b1410c 100644 (file)
@@ -393,7 +393,7 @@ $
   =
   \beta
   \|\mathbf{u}\|_{L^\infty(K)} h_K
-$ to eliminate the effect of of the constant $c_R$ (we know that
+$ to eliminate the effect of the constant $c_R$ (we know that
 solutions are stable by using this version of $\nu(T)$ as an artificial
 viscosity, but that we can improve things -- i.e. make the solution
 sharper -- by using the more complicated formula for this artificial
index f55424db21f1bc0f7617ce9cabd208be47eb1fc6..da778c6d50a2f9d92d6ed4b74daeb406741d55e4 100644 (file)
@@ -913,7 +913,7 @@ namespace Step50
   // @sect4{LaplaceProblem::run}
 
   // Like several of the functions above, this
-  // is almost exactly a copy of of the
+  // is almost exactly a copy of the
   // corresponding function in step-6. The only
   // difference is the call to
   // <code>assemble_multigrid</code> that takes
index b25388c7f39db2f9d809a6c56d179235efb79e43..353b4ff0da809e1235f4e0c71a7e41c07bf53774 100644 (file)
@@ -109,7 +109,7 @@ does. In a second step, all the new nodes will be projected onto the
 normal projection is available, the point which is closest to the
 shape---typically lying on the shape boundary---is selected.  If the shape is
 composed of several sub-shapes, the projection is carried out onto every
-single sub-shape, and the closest projection point point is selected.
+single sub-shape, and the closest projection point is selected.
 
 <img src="https://www.dealii.org/images/steps/developer/step-54.NormalProjectionEdge.png" alt="" width="500">
 <img src="https://www.dealii.org/images/steps/developer/step-54.NormalProjection.png" alt="" width="500">
index 5e27a4b03aa167338b11eb217bcb41c0769f5aa7..48e9ce520743333921ff1873d68ebfc835e4d348 100644 (file)
@@ -703,7 +703,7 @@ namespace Utilities
                     &(size_all_data[0]), 1, MPI_INT,
                     comm);
 
-      // Now computing the the displacement, relative to recvbuf,
+      // Now computing the displacement, relative to recvbuf,
       // at which to store the incoming buffer
       std::vector<int> rdispls(n_procs);
       rdispls[0] = 0;
index a8f0b125a1d620ca913e34ddd2c4c0ddfaa62525..e002f2def310742e6d919700ebc43d450e3f70da 100644 (file)
@@ -35,7 +35,7 @@ DEAL_II_NAMESPACE_OPEN
  * [0,1]x[0,1], etc.
  *
  * There are a number of derived classes, denoting concrete integration
- * formulae. Their names names prefixed by <tt>Q</tt>. Refer to the list of
+ * formulae. Their names are prefixed by <tt>Q</tt>. Refer to the list of
  * derived classes for more details.
  *
  * The schemes for higher dimensions are typically tensor products of the one-
index 173c691ec7c540fb8176fb44ac377ba0464c614a..237c0763126316e54b9952458be5bfb1a8c87acf 100644 (file)
@@ -125,7 +125,7 @@ public:
 
   /**
    * Declare an array type which can be used to initialize an object of this
-   * type statically. In case of a tensor of rank 0 this is just the scalar
+   * type statically. In case of a tensor of rank 0 this is just the scalar
    * number type Number.
    */
   typedef Number array_type;
index 75d64f2cbf12ab95169902cea0744db1186e7833..0d0d60728534b87332e4d06c414f88a7a719c775 100644 (file)
@@ -38,8 +38,8 @@ struct CPUClock
 {
   /**
    * Duration type. Windows measures CPU times, by default, in multiples of
-   * 1/64th of a second and and POSIX uses microseconds, so go with
-   * microseconds for uniformity.
+   * 1/64th of a second and POSIX uses microseconds, so go with microseconds
+   * for uniformity.
    */
   typedef std::chrono::microseconds duration;
 
index 3f4dc6dad43962341275d44978a60c45cef20bfe..69272ecac96fe4058454bac8cfc3c972592968de 100644 (file)
@@ -358,8 +358,8 @@ namespace Utilities
   /**
    * Optimized replacement for <tt>std::lower_bound</tt> for searching within
    * the range of column indices. Slashes execution time by approximately one
-   * half for the present application, partly because because the binary
-   * search is replaced by a linear search for small loop lengths.
+   * half for the present application, partly because the binary search is
+   * replaced by a linear search for small loop lengths.
    *
    * Another reason for this function is rather obscure: when using the GCC
    * libstdc++ function std::lower_bound, complexity is O(log(N)) as required.
index 969188081520cc456989ead447b46a28e7c1e4cb..458ebde1c740eeab393dfb26dfbdfb337c500180 100644 (file)
@@ -931,7 +931,7 @@ namespace DoFRenumbering
    *
    * The cells are sorted such that the centers of cells numbered higher are further
    * downstream with respect to the constant vector @p direction than the
-   * centers of of cells numbered lower. Even if this yields a downstream numbering with
+   * centers of cells numbered lower. Even if this yields a downstream numbering with
    * respect to the flux on the edges for fairly general grids, this might not
    * be guaranteed for all meshes.
    *
index e2af9b2ef217b7cef95c9c368b124bbbf633e091..8ac63e35d69832fd73d294101c6fb3fd640047c6 100644 (file)
@@ -1053,7 +1053,7 @@ public:
    * here.
    *
    * The matrix @p P is the concatenation, not the sum of the cell matrices @p
-   * P_i. That is, if the same non-zero entry <tt>j,k</tt> exists in in two
+   * P_i. That is, if the same non-zero entry <tt>j,k</tt> exists in two
    * different child matrices @p P_i, the value should be the same in both
    * matrices and it is copied into the matrix @p P only once.
    *
@@ -1244,7 +1244,7 @@ public:
 
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.#dofs_per_face</tt> times <tt>this->#dofs_per_face</tt>.
    *
@@ -1962,7 +1962,7 @@ public:
    * points associated with the other shape functions.
    *
    * In composed elements (i.e. for the FESystem class), the result will be
-   * true if all all the base elements have defined support points. FE_Nothing
+   * true if all the base elements have defined support points. FE_Nothing
    * is a special case in FESystems, because it has 0 support points and
    * has_support_points() is false, but an FESystem containing an FE_Nothing
    * among other elements will return true.
index 9c3239db731996c687df327b56f567889ed353af..0426711ce1caa39d5aea86fbbcdce77e43c0e3bf 100644 (file)
@@ -398,7 +398,7 @@ public:
    */
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element. The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>.
    *
@@ -413,7 +413,7 @@ public:
                                  FullMatrix<double>       &matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element. The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>.
    *
index 3c4abbe86890329b1f03af7554529b116742484c..2f004620f3ddd4d383051598c199bbebd392e323 100644 (file)
@@ -386,7 +386,7 @@ public:
                             FullMatrix<double>           &matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element. The size of the matrix is then @p
    * dofs_per_face times <tt>source.dofs_per_face</tt>.
    *
@@ -401,7 +401,7 @@ public:
                                  FullMatrix<double>       &matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element. The size of the matrix is then @p
    * dofs_per_face times <tt>source.dofs_per_face</tt>.
    *
index 205a1c0942e15b4e66fb55da444dc455cadc1fb3..16e9e81018db663c14c430a4f2191a00c7413441 100644 (file)
@@ -378,7 +378,7 @@ public:
   unsigned int get_degree () const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element. The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>.
    *
@@ -393,7 +393,7 @@ public:
                                  FullMatrix<double>       &matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element. The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>.
    *
index 3fb2441995a51f771b7b26556ac44a12c03e3306..7e02b5b0797b301f7e0e5e5c0e464ec06d770ecf 100644 (file)
@@ -134,7 +134,7 @@ public:
                             FullMatrix<double>           &matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element. The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>.
    *
@@ -149,7 +149,7 @@ public:
                                  FullMatrix<double>       &matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element. The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>.
    *
@@ -194,7 +194,7 @@ public:
    * single child cell is returned here.
    *
    * The matrix @p P is the concatenation, not the sum of the cell matrices @p
-   * P_i. That is, if the same non-zero entry <tt>j,k</tt> exists in in two
+   * P_i. That is, if the same non-zero entry <tt>j,k</tt> exists in two
    * different child matrices @p P_i, the value should be the same in both
    * matrices and it is copied into the matrix @p P only once.
    *
index 1d223508aab44a4d9a296edf1ecbf1ea9b5f4726..8e6bc535ecc5c6931b29a193d8df860bd68e63c0 100644 (file)
@@ -353,7 +353,7 @@ public:
   virtual bool hp_constraints_are_implemented () const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>.
    *
@@ -369,7 +369,7 @@ public:
                                  FullMatrix<double>       &matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the
+   * Return the matrix interpolating from a face of one element to the
    * subface of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>.
    *
index 88f8989e9950adb6bc0ec783185e1a46e9eaab88..58b737015dbe53c886f6f69283ec17d2da57e2b7 100644 (file)
@@ -83,7 +83,7 @@ public:
                                                           std::vector<double>                &nodal_values) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>. This
    * element only provides interpolation matrices for elements of the same
@@ -95,7 +95,7 @@ public:
                                  FullMatrix<double>       &matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>. This
    * element only provides interpolation matrices for elements of the same
@@ -233,7 +233,7 @@ public:
   requires_update_flags (const UpdateFlags update_flags) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>. This
    * element only provides interpolation matrices for elements of the same
@@ -245,7 +245,7 @@ public:
                                  FullMatrix<double>       &matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>. This
    * element only provides interpolation matrices for elements of the same
@@ -469,7 +469,7 @@ public:
   virtual std::string get_name () const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>. This
    * element only provides interpolation matrices for elements of the same
@@ -481,7 +481,7 @@ public:
                                  FullMatrix<double>       &matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>. This
    * element only provides interpolation matrices for elements of the same
index 9c4398e4fd84d98aeed7ad018669995051133ce4..e0c76d0cfcb14c8ae25f7d9533b1f91854018bb5 100644 (file)
@@ -239,7 +239,7 @@ public:
    * single child cell is returned here.
    *
    * The matrix @p P is the concatenation, not the sum of the cell matrices @p
-   * P_i. That is, if the same non-zero entry <tt>j,k</tt> exists in in two
+   * P_i. That is, if the same non-zero entry <tt>j,k</tt> exists in two
    * different child matrices @p P_i, the value should be the same in both
    * matrices and it is copied into the matrix @p P only once.
    *
index dffd1991629bf699ab03aa7d513e6e6c9a37f1a8..88a0ad6f47287106976ad075e3f5063b208d7b63 100644 (file)
@@ -220,7 +220,7 @@ public:
                             FullMatrix<double>       &interpolation_matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element. The size of the matrix is then
    * <tt>source.#dofs_per_face</tt> times <tt>this->#dofs_per_face</tt>.
    *
@@ -235,7 +235,7 @@ public:
 
 
   /**
-   * Return the matrix interpolating from a face of of one element to the
+   * Return the matrix interpolating from a face of one element to the
    * subface of the neighboring element. The size of the matrix is then
    * <tt>source.#dofs_per_face</tt> times <tt>this->#dofs_per_face</tt>.
    *
@@ -269,4 +269,3 @@ private:
 DEAL_II_NAMESPACE_CLOSE
 
 #endif
-
index afb7747b7c8f681daf0e0f53fcb6e880127169a4..d7d0deab033373c71e75a378c2b9b1157f14694d 100644 (file)
@@ -62,7 +62,7 @@ public:
 
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>. The
    * FE_Q element family only provides interpolation matrices for elements of
@@ -75,7 +75,7 @@ public:
                                  FullMatrix<double>       &matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>. The
    * FE_Q element family only provides interpolation matrices for elements of
@@ -130,7 +130,7 @@ public:
    * single child cell is returned here.
    *
    * The matrix @p P is the concatenation, not the sum of the cell matrices @p
-   * P_i. That is, if the same non-zero entry <tt>j,k</tt> exists in in two
+   * P_i. That is, if the same non-zero entry <tt>j,k</tt> exists in two
    * different child matrices @p P_i, the value should be the same in both
    * matrices and it is copied into the matrix @p P only once.
    *
index 7ac364896baf984a9ed95d2f84166e07d828c31a..836e7680163c76d18220db8f4d2fe86bde0cc0f9 100644 (file)
@@ -740,7 +740,7 @@ public:
    * single child cell is returned here.
    *
    * The matrix @p P is the concatenation, not the sum of the cell matrices @p
-   * P_i. That is, if the same non-zero entry <tt>j,k</tt> exists in in two
+   * P_i. That is, if the same non-zero entry <tt>j,k</tt> exists in two
    * different child matrices @p P_i, the value should be the same in both
    * matrices and it is copied into the matrix @p P only once.
    *
@@ -846,7 +846,7 @@ public:
   virtual bool hp_constraints_are_implemented () const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>.
    *
@@ -863,7 +863,7 @@ public:
 
 
   /**
-   * Return the matrix interpolating from a face of of one element to the
+   * Return the matrix interpolating from a face of one element to the
    * subface of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>.
    *
index 2775b66759e707b63acea3f84ddc5790261f98a6..2a295a2bedea5629eb83d2cd6b3864b0ecaf7999 100644 (file)
@@ -985,7 +985,7 @@ namespace FETools
                                  &p4est_cell,
                                  dealii::internal::p4est::functions<dim>::quadrant_compare);
 
-      // if neither this cell nor one one of it's children belongs to us, don't do anything
+      // if neither this cell nor one of it's children belongs to us, don't do anything
       if (idx == -1 && (dealii::internal::p4est::functions<dim>::
                         quadrant_overlaps_tree (const_cast<typename dealii::internal::p4est::types<dim>::tree *>(&tree),
                                                 &p4est_cell)
index 9d78c6a6cdd59a323c22726c73bc9a841bd4d734..e8617b0a1d80fd10628de1af7085990d4a922ac7 100644 (file)
@@ -95,7 +95,7 @@ public:
   virtual bool hp_constraints_are_implemented () const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>. This
    * element only provides interpolation matrices for elements of the same
@@ -107,7 +107,7 @@ public:
                                  FullMatrix<double>       &matrix) const;
 
   /**
-   * Return the matrix interpolating from a face of of one element to the face
+   * Return the matrix interpolating from a face of one element to the face
    * of the neighboring element.  The size of the matrix is then
    * <tt>source.dofs_per_face</tt> times <tt>this->dofs_per_face</tt>. This
    * element only provides interpolation matrices for elements of the same
index c170ad4f648500b30ad194ae14c2e7a9fd4f0895..2cc22a2abb8cf6c55f7deb3063eb790df288d79b 100644 (file)
@@ -1137,7 +1137,7 @@ namespace FEValuesViews
 
     /**
      * A typedef for the type of the divergence of the view this class
-     * represents. Here, for a set of of <code>(dim*dim + dim)/2</code> unique
+     * represents. Here, for a set of <code>(dim*dim + dim)/2</code> unique
      * components of the finite element representing a symmetric second-order
      * tensor, the divergence of course is a * <code>Tensor@<1,dim@></code>.
      *
index 2465adf57c0eb33cad679e2fbb98d23bedab0600..34558a3b7cbb4a815b9b653fa4e3b119ce7a0a46 100644 (file)
@@ -444,7 +444,7 @@ public:
     /**
       * In case the quadrature rule given represents a tensor product
       * we need to store the evaluations of the 1d polynomials at the
-      * the 1d quadrature quadrature points. That is what this variable is for.
+      * the 1d quadrature points. That is what this variable is for.
       */
     internal::MatrixFreeFunctions::ShapeInfo<VectorizedArray<double>> shape_info;
 
index d84143a0c14e6a86cd02510ceb974362efd843cd..a3a7e44138f92de96c87b4108689de7557d2075a 100644 (file)
@@ -310,7 +310,7 @@ namespace GridRefinement
    * threshold for refinement, but only flag up to @p max_to_mark cells.
    *
    * The vector @p criteria contains a nonnegative value for each active cell,
-   * ordered in the canonical order of of Triangulation::active_cell_iterator.
+   * ordered in the canonical order of Triangulation::active_cell_iterator.
    *
    * The cells are only flagged for refinement, they are not actually refined.
    * To do so, you have to call
@@ -330,7 +330,7 @@ namespace GridRefinement
    * threshold for coarsening.
    *
    * The vector @p criteria contains a nonnegative value for each active cell,
-   * ordered in the canonical order of of Triangulation::active_cell_iterator.
+   * ordered in the canonical order of Triangulation::active_cell_iterator.
    *
    * The cells are only flagged for coarsening, they are not actually
    * coarsened. To do so, you have to call
index 5db849b284f3d29e01a48c4cfdab7a4b954d41d4..9dc08f2803aeb78b90e5a608f287486bdcbe312c 100644 (file)
@@ -254,7 +254,7 @@ DeclExceptionMsg (ExcMeshNotOrientable,
  * which we could order as <tt>(9 6 7 10)</tt> above). However, since opposite
  * lines have to have the same direction, this in turn would force us to
  * rotate the cell left of it, and then the one left to that, and so on until
- * we reach the left end of the grid. This is therefore an example we we have
+ * we reach the left end of the grid. This is therefore an example we have
  * to track back right until the first column of three cells to find a
  * consistent ordering, if we had initially ordered them uniformly.
  *
@@ -288,7 +288,7 @@ DeclExceptionMsg (ExcMeshNotOrientable,
  * These two examples demonstrate that if we have added a certain number of
  * cells in some orientation of faces and can't add the next one without
  * introducing faces that had already been added in another direction, then it
- * might not be sufficient to only rotate cells in the neighborhood of the the
+ * might not be sufficient to only rotate cells in the neighborhood of the
  * cell that we failed to add. It might be necessary to go back a long way and
  * rotate cells that have been entered long ago.
  *
index 38807c8455da8ae620b7e3fd8bd5e18e1793f01a..303cd218be649b4a9958da6fa15b49ae00d0297b 100644 (file)
@@ -208,7 +208,7 @@ namespace GridTools
   /**
    * Return the point on the geometrical object @object closest to the given
    * point @p trial_point. For example, if @p object is a one-dimensional line
-   * or edge, then the the returned point will be a point on the geodesic that
+   * or edge, then the returned point will be a point on the geodesic that
    * connects the vertices as the manifold associated with the object sees it
    * (i.e., the geometric line may be curved if it lives in a higher
    * dimensional space). If the iterator points to a quadrilateral in a higher
index 75e69f78df1201254700e081c062c3560d407f5d..9bfc7b3f6612d6712a89ef4be4ce2cee69a05b20 100644 (file)
@@ -147,7 +147,7 @@ private:
  * south poles.  Consider for instance the pair of points
  * $x_1=(1,\pi/3,0)$ and $x_2=(1,\pi/3,\pi)$ in polar
  * coordinates (lying on the surface of a sphere with radius one, on
- * a parallel at at height $\pi/3$). In this case connecting the points
+ * a parallel at height $\pi/3$). In this case connecting the points
  * with a straight line in polar coordinates would take the long road
  * around the globe, without passing through the north pole.
  *
index fbe3e54f591dfa5c157ae396fbb6f1d5080f44d6..6bfccb25327d9282d67f56ff8f421f202da27211 100644 (file)
@@ -751,7 +751,7 @@ namespace internal
  * cells are flagged for refinement to smooth the grid. This enlarges the
  * number of resulting cells but makes the grid more regular, thus leading to
  * better approximation properties and, above all, making the handling of data
- * structures and algorithms much much easier. To be honest, this is mostly an
+ * structures and algorithms much easier. To be honest, this is mostly an
  * algorithmic step than one needed by the finite element method.
  *
  * To coarsen a grid, the same way as above is possible by using
index 56907d57821ee158ea6b426aed34551bba3f0b1d..112a374e2c81b17b40e0f713512098bfda122058 100644 (file)
@@ -805,7 +805,7 @@ public:
 
   /**
    * Return whether the face with index @p face is rotated by 180 degrees (@p
-   * true) or or not (@p false). In 1d and 2d, this is always @p false, but in
+   * true) or not (@p false). In 1d and 2d, this is always @p false, but in
    * 3d it may be different, see the respective discussion in the
    * documentation of the GeometryInfo class.
    *
@@ -816,7 +816,7 @@ public:
 
   /**
    * Return whether the face with index @p face is rotated by 90 degrees (@p
-   * true) or or not (@p false). In 1d and 2d, this is always @p false, but in
+   * true) or not (@p false). In 1d and 2d, this is always @p false, but in
    * 3d it may be different, see the respective discussion in the
    * documentation of the GeometryInfo class.
    *
index a02d166589ee082c9e1bea11738d9aaef7203c6f..721363c82f094096e60d33c5fea05467e0106fdb 100644 (file)
@@ -180,7 +180,7 @@ namespace CUDAWrappers
                     const LinearAlgebra::CUDAWrappers::Vector<Number> &src) const;
 
     /**
-     * Return the square of the norm of the vector $v$ with respect to the the
+     * Return the square of the norm of the vector $v$ with respect to the
      * norm induced by this matrix, i.e., $\left(v,Mv\right)$. This is useful,
      * e.g., in the finite context, where the $L_2$ norm of a function equals
      * the matrix norm with respect to the mass matrix of the vector
index b0c484cd9df911e8aa00b3cfe46e24b830d29696..6feaba0f027e0566fa9620c46defc6784b0e41ab 100644 (file)
@@ -494,7 +494,7 @@ public:
                      const bool transpose=false);
 
   /**
-   * Estimate the the condition number of a SPD matrix in the $l_1$-norm.
+   * Estimate the condition number of a SPD matrix in the $l_1$-norm.
    * The matrix has to be in the Cholesky state (see compute_cholesky_factorization()).
    * The reciprocal of the
    * condition number is returned in order to avoid the possibility of
index 6016427bd4e0f2f7485cb2990f19b37940a475b8..40044b83bc7f46d3e0c3a730b04ae4adce3388cf 100644 (file)
@@ -47,7 +47,7 @@ namespace CUDAWrappers
    * quadrature points and cell integrations. In functionality, this class is
    * similar to FEValues<dim>.
    *
-   * This class class has five template arguments:
+   * This class has five template arguments:
    *
    * @ptaram dim Dimension in which this class is to be used
    *
index 8c01d6f92de7c92a9cbc2f88def6bec135d5d745..104d6e63b173a85853f5e70c016a7f875267f11b 100644 (file)
@@ -442,7 +442,7 @@ public:
    * cell, via the first argument. Not all of the member vectors of this
    * argument will be filled with data -- in fact, derivatives and other
    * quantities will only be contain valid data if the corresponding flags
-   * are returned by by an overloaded version of the get_needed_update_flags()
+   * are returned by an overridden version of the get_needed_update_flags()
    * function (implemented in a user's derived class).
    * Otherwise those vectors will be in an unspecified state.
    *
@@ -992,7 +992,7 @@ private:
  *   };
  * @endcode
  *
- * Using this class in in step-8 leads to the following visualization:
+ * Using this class in step-8 leads to the following visualization:
  *
  * @image html data_postprocessor_tensor_2.png
  *
index 74d4410112650258bac28f9044e8c160bf453779..6dee90c18e3e87d27f8af85d6e5427a8cee132d9 100644 (file)
@@ -1838,7 +1838,7 @@ namespace VectorTools
    * There are cases where one cell contributes two tangential directions and
    * another one only one; for example, this would happen if both top and
    * front faces of the left cell belong to the boundary selected whereas only
-   * the top face of the right cell belongs to it, maybe indicating the the
+   * the top face of the right cell belongs to it, maybe indicating that the
    * entire front part of the domain is a smooth manifold whereas the top
    * really forms two separate manifolds that meet in a ridge, and that
    * normal-flux boundary conditions are only desired on the front manifold
index 3a9f8cbfbc81a920f6171742ccfa1e111caa3e1b..bcbc785f65afaa78bb94c6b43f5641cc4730ec32 100644 (file)
@@ -647,7 +647,7 @@ namespace SUNDIALS
      *
      * @param[out] j_is_current: a boolean to be filled in by setup_jacobian(). The value
      * should be set to `true` if the Jacobian data is current after the call,
-     * and should be set set to `false` if its Jacobian data is not current. If
+     * and should be set to `false` if its Jacobian data is not current. If
      * setup_jacobian() calls for re-evaluation of Jacobian data (based on
      * convfail and ARKode state data), then it should set `j_is_current` to
      * `true` unconditionally, otherwise an infinite loop can result.

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.