]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix up 'the the ' in the documentation 4487/head
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Tue, 6 Jun 2017 11:50:56 +0000 (13:50 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Tue, 6 Jun 2017 11:51:40 +0000 (13:51 +0200)
36 files changed:
examples/step-18/doc/intro.dox
examples/step-22/doc/results.dox
examples/step-55/doc/results.dox
examples/step-8/step-8.cc
include/deal.II/base/aligned_vector.h
include/deal.II/base/data_out_base.h
include/deal.II/base/table.h
include/deal.II/base/table_handler.h
include/deal.II/base/thread_management.h
include/deal.II/dofs/dof_renumbering.h
include/deal.II/fe/mapping_q1_eulerian.h
include/deal.II/fe/mapping_q_eulerian.h
include/deal.II/grid/filtered_iterator.h
include/deal.II/grid/tria.h
include/deal.II/hp/dof_handler.h
include/deal.II/lac/block_sparsity_pattern.h
include/deal.II/lac/block_vector.h
include/deal.II/lac/constraint_matrix.h
include/deal.II/lac/la_parallel_block_vector.h
include/deal.II/lac/la_parallel_vector.h
include/deal.II/lac/petsc_matrix_free.h
include/deal.II/lac/petsc_parallel_block_vector.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/sparse_mic.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/vector.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/multigrid/mg_block_smoother.h
include/deal.II/multigrid/mg_smoother.h
include/deal.II/numerics/vector_tools.h
source/numerics/data_out_stack.cc
tests/numerics/data_out_02.cc
tests/numerics/data_out_faces_02.cc
tests/numerics/data_out_rotation_02.cc

index e02edfb46c14eff473ded459c3d92541e4adf2cd..c4e8d180b44377b1f76d10d9135bb05c57a77146 100644 (file)
@@ -300,7 +300,7 @@ simply translated along. The dilational or compressional change produces a
 corresponding stress update. However, the rotational component does not
 necessarily induce a nonzero stress update (think, in 2d, for example of the
 situation where $\Delta\mathbf{u}=(y, -x)^T$, with which $\varepsilon(\Delta
-\mathbf{u})=0$). Nevertheless, if the the material was prestressed in a certain
+\mathbf{u})=0$). Nevertheless, if the material was prestressed in a certain
 direction, then this direction will be rotated along with the material.  To
 this end, we have to define a rotation matrix $R(\Delta \mathbf{u}^n)$ that
 describes, in each point the rotation due to the displacement increments. It
index 52af0f34ed6c80ea8fe0059b12171b5f23aeceaf..52b4cfb5bb81695bb994237b5e8c3197ac1250e3 100644 (file)
@@ -793,7 +793,7 @@ $[-2,2]\times[-2,2]\times[-1,0]$
                                                bottom_left,
                                                top_right);
 @endcode
-then we get images where the the fault line is curved:
+then we get images where the fault line is curved:
 <TABLE WIDTH="60%" ALIGN="center">
   <tr>
     <td ALIGN="center">
index be6be9e4e6e924990a03dae7fae3498876bc8baa..68d5e64a48de2051f9ea80e12f6caf8d14237312 100644 (file)
@@ -230,7 +230,7 @@ Trilinos AMG to achieve an optimal preconditioner.
 This change requires changing the outer solver to GMRES or BiCGStab, because
 the system is no longer symmetric.
 
-You can prescribe the the exact flow solution as $b$ in the convective term $b
+You can prescribe the exact flow solution as $b$ in the convective term $b
 \cdot \nabla u$. This should give the same solution as the original problem,
 if you set the right hand side to zero.
 
index 3344a8b2c0dd5a21e08c2bd76a1880f83b1395c5..f67ed3718b6e5ad4399d04f78a8867d1c3637efd 100644 (file)
@@ -596,7 +596,7 @@ namespace Step8
   // will be only four quadrature points in each direction on the
   // domain. However, the right hand side function was chosen to be rather
   // localized and in that case, by pure chance, it happens that all quadrature
-  // points lie at points where the the right hand side function is zero (in
+  // points lie at points where the right hand side function is zero (in
   // mathematical terms, the quadrature points happen to be at points outside
   // the <i>support</i> of the right hand side function). The right hand side
   // vector computed with quadrature will then contain only zeroes (even though
index c2253221e3b53bcde641dd1f510d9e95de425ee9..b1c1d5a86d31238c04f9698109bcc598c70aad28 100644 (file)
@@ -380,7 +380,7 @@ namespace internal
   /**
    * Class that issues the set commands for AlignedVector.
    *
-   * @tparam initialize_memory Sets whether the the set command should
+   * @tparam initialize_memory Sets whether the set command should
    * initialize memory (with a call to the copy constructor) or rather use the
    * copy assignment operator. A template is necessary to select the
    * appropriate operation since some classes might define only one of those
index 4697c295fe1911a98e598d19bd35e0c8f8b29c82..6feeee47419b40595a459342ef02460264af9f8c 100644 (file)
@@ -2831,7 +2831,7 @@ private:
  * files, the rest of the nodes will have valid set to false. The XDMF file in
  * turn points to heavy data files (such as HDF5) where the actual simulation
  * data is stored. This allows flexibility in arranging the data, and also
- * allows the mesh to be separated from the the point data.
+ * allows the mesh to be separated from the point data.
  */
 class XDMFEntry
 {
index 8a33ce74056ed535131b971239587fc60aec4a02..17289b48f223a7c1c533fed8580344e0ba6dbd63 100644 (file)
@@ -592,7 +592,7 @@ public:
    * swaps the pointers to the data of the two vectors and therefore does not
    * need to allocate temporary storage and move data around.
    *
-   * This function is analogous to the the @p swap function of all C++
+   * This function is analogous to the @p swap function of all C++
    * standard containers. Also, there is a global function <tt>swap(u,v)</tt>
    * that simply calls <tt>u.swap(v)</tt>, again in analogy to standard
    * functions.
index c1ae220f4eb4e708a32aaa2eb228719da0501d5f..cc79e2c0fa12e9da4ddb9347a7094e455f02dcbf 100644 (file)
@@ -468,7 +468,7 @@ public:
   void set_tex_table_label (const std::string &table_label);
 
   /**
-   * Set the caption the the supercolumn <tt>superkey</tt> for tex output.
+   * Set the caption the supercolumn <tt>superkey</tt> for tex output.
    * You may want to chose this different from <tt>superkey</tt>, if it
    * contains formulas or similar constructs.
    */
@@ -695,7 +695,7 @@ protected:
   mutable std::map<std::string,Column> columns;
 
   /**
-   * Maps each supercolumn key to the the keys of its subcolumns in the right
+   * Maps each supercolumn key to the keys of its subcolumns in the right
    * order.  It is allowed that a supercolumn has got the same key as a
    * column.
    *
index 5ef206d7aaacccf33e7c29006130f73e4d20470e..76665e318b231ec076bea440aee184ce9f1d5ece 100644 (file)
@@ -1019,7 +1019,7 @@ namespace Threads
        * the thread.
        *
        * The return value is stored in a shared_ptr because we might abandon
-       * the the ThreadDescriptor.  This makes sure the object stays alive
+       * the ThreadDescriptor.  This makes sure the object stays alive
        * until the thread exits.
        */
       std::shared_ptr<return_value<RT> > ret_val;
index 9cd585179b8fecb65428c46cb20c236eb0ea5103..42635eba43745737fb1ef42a0caaf8af9a92f4a2 100644 (file)
@@ -633,7 +633,7 @@ namespace DoFRenumbering
   /**
    * Sort the degrees of freedom by component. It does the same thing as the
    * above function, only that it does this for one single level of a
-   * multilevel discretization. The non-multigrid part of the the DoFHandler
+   * multilevel discretization. The non-multigrid part of the DoFHandler
    * is not touched.
    */
   template <typename DoFHandlerType>
@@ -679,7 +679,7 @@ namespace DoFRenumbering
   /**
    * Sort the degrees of freedom by vector block. It does the same thing as
    * the above function, only that it does this for one single level of a
-   * multilevel discretization. The non-multigrid part of the the DoFHandler
+   * multilevel discretization. The non-multigrid part of the DoFHandler
    * is not touched.
    */
   template <int dim, int spacedim>
index 85c3ffc8d9599d00c76c7ff704c360d6b167b127..e64ad489e4af09b66a81f66c3dd14a0ef4fc9464 100644 (file)
@@ -45,7 +45,7 @@ template <typename> class Vector;
  * vector that defines the mapping from the reference configuration to the
  * current configuration and a reference to the DoFHandler. The vector should
  * then represent a (flattened out version of a) vector valued field defined
- * at nodes defined by the the DoFHandler, where the number of components of
+ * at nodes defined by the DoFHandler, where the number of components of
  * the vector field equals the number of space dimensions. Thus, the
  * DoFHandler shall operate on a finite element that has as many components as
  * space dimensions. As an additional requirement, we impose that it have as
index 96613488babf2cf80835ef20f267d85aabbab18a..b70156f4de22a91945407d6c319cda5f1eee4b5f 100644 (file)
@@ -238,7 +238,7 @@ private:
     const SupportQuadrature support_quadrature;
 
     /**
-     * FEValues object used to query the the given finite element field at the
+     * FEValues object used to query the given finite element field at the
      * support points in the reference configuration.
      *
      * The variable is marked as mutable since we have to call
index 0a9df177d3b9e471989272f1b7ce987b53ee30b9..806e21f3dfb6fdc752021bfa3f6aacfaedfd81f8 100644 (file)
@@ -528,7 +528,7 @@ public:
    * iterator with the given value.
    *
    * If the initial value @p bi does not satisfy the predicate @p p then it is
-   * advanced until we either hit the the past-the-end iterator, or the
+   * advanced until we either hit the past-the-end iterator, or the
    * predicate is satisfied. This allows, for example, to write code like
    * @code
    *   FilteredIterator<typename Triangulation<dim>::active_cell_iterator>
index 30416bdf31216165aa3427c7eae2005e59b406cc..06017e04c76a638f71d1fca8e9db05a2ad679b00 100644 (file)
@@ -107,7 +107,7 @@ namespace hp
  * to describe the manifold this object belongs to.
  *
  * This structure is also used to represent data for faces and edges when used
- * as a member of the the SubCellData class. In this case, the template argument
+ * as a member of the SubCellData class. In this case, the template argument
  * @p structdim of an object will be less than the dimension @p dim of the
  * triangulation. If this is so, then #vertices array represents the indices of
  * the vertices of one face or edge of one of the cells passed to
@@ -1682,7 +1682,7 @@ public:
   void set_boundary (const types::manifold_id number);
 
   /**
-   * Assign a manifold object to a certain part of the the triangulation. If
+   * Assign a manifold object to a certain part of the triangulation. If
    * an object with manifold number @p number is refined, this object is used
    * to find the location of new vertices (see the results section of step-49
    * for a more in-depth discussion of this, with examples).  It is also used
index cd1c5789e690f6685c4d0a47d4bc58d5cdc73f50..29ad295bac80baa539b3dcaf731bad39198bbbe0 100644 (file)
@@ -767,7 +767,7 @@ namespace hp
      * Functions that will be triggered through signals whenever the
      * triangulation is modified.
      *
-     * Here they are used to administrate the the active_fe_fields during the
+     * Here they are used to administrate the active_fe_fields during the
      * spatial refinement.
      */
     void pre_refinement_action ();
index 8c58d8c65040f71b0472a94fdc6281daee356079..ee862e0257f96600eb622ae04e10f457c0430c43 100644 (file)
@@ -457,7 +457,7 @@ public:
  *
  * @dontinclude block_dynamic_sparsity_pattern.cc
  *
- * After the the DoFHandler <tt>dof</tt> and the ConstraintMatrix
+ * After the DoFHandler <tt>dof</tt> and the ConstraintMatrix
  * <tt>constraints</tt> have been set up with a system element, we must count
  * the degrees of freedom in each matrix block:
  *
index 0b29df377fa83bbf828e0277aac63c02491409a9..1e8b6c29d9e3355bc61b6c6993cde740192a846a 100644 (file)
@@ -306,7 +306,7 @@ public:
    * only swaps the pointers to the data of the two vectors and therefore does
    * not need to allocate temporary storage and move data around.
    *
-   * This function is analogous to the the swap() function of all C++ standard
+   * This function is analogous to the swap() function of all C++ standard
    * containers. Also, there is a global function swap(u,v) that simply calls
    * <tt>u.swap(v)</tt>, again in analogy to standard functions.
    */
index bea74a52d00f91f47a7940f37c6a9072f8ef76bc..2aa28b4f3b7c8fead6554b1d1153c76f2cab8d43 100644 (file)
@@ -480,7 +480,7 @@ public:
   bool has_inhomogeneities () const;
 
   /**
-   * Return a pointer to the the vector of entries if a line is constrained,
+   * Return a pointer to the vector of entries if a line is constrained,
    * and a zero pointer in case the dof is not constrained.
    */
   const std::vector<std::pair<size_type,double> > *
index 99c959638d2a394a9253caffbe1c8a061cbe392c..a5959321882b7eb4a4fc164842c172310742c7a8 100644 (file)
@@ -392,7 +392,7 @@ namespace LinearAlgebra
        * the same number of blocks. If needed, the numbers of blocks should be
        * exchanged, too.
        *
-       * This function is analogous to the the swap() function of all C++
+       * This function is analogous to the swap() function of all C++
        * standard containers. Also, there is a global function swap(u,v) that
        * simply calls <tt>u.swap(v)</tt>, again in analogy to standard
        * functions.
index b755b4177d9ac63df65612268f3e410a11c27043..ac70181fc2b3b5e99359308a927d7caeaaa60a12 100644 (file)
@@ -308,7 +308,7 @@ namespace LinearAlgebra
        * only swaps the pointers to the data of the two vectors and therefore
        * does not need to allocate temporary storage and move data around.
        *
-       * This function is analogous to the the @p swap function of all C++
+       * This function is analogous to the @p swap function of all C++
        * standard containers. Also, there is a global function
        * <tt>swap(u,v)</tt> that simply calls <tt>u.swap(v)</tt>, again in
        * analogy to standard functions.
index b256a533fc49415f4628df5bce99786d4690af63..da6ac803ce8f51697ec570122519ea785242a8d9 100644 (file)
@@ -73,7 +73,7 @@ namespace PETScWrappers
      * For the meaning of the @p local_rows and @p local_columns parameters,
      * see the PETScWrappers::MPI::SparseMatrix class documentation.
      *
-     * As other PETSc matrices, also the the matrix-free object needs to have
+     * As other PETSc matrices, also the matrix-free object needs to have
      * a size and to perform matrix vector multiplications efficiently in
      * parallel also @p local_rows and @p local_columns. But in contrast to
      * PETSc::SparseMatrix classes a PETSc matrix-free object does not need
@@ -90,7 +90,7 @@ namespace PETScWrappers
      * Create a matrix object of dimensions @p m times @p n with communication
      * happening over the provided @p communicator.
      *
-     * As other PETSc matrices, also the the matrix-free object needs to have
+     * As other PETSc matrices, also the matrix-free object needs to have
      * a size and to perform matrix vector multiplications efficiently in
      * parallel also @p local_rows and @p local_columns. But in contrast to
      * PETSc::SparseMatrix classes a PETSc matrix-free object does not need
index fcdf70db9f0a226c93e0a4ef4290458e3d5fcb96..d15537d4e99d10dcbf4b5f7a5ccaca72a1d5eeb1 100644 (file)
@@ -252,7 +252,7 @@ namespace PETScWrappers
        * the same number of blocks. If needed, the numbers of blocks should be
        * exchanged, too.
        *
-       * This function is analogous to the the swap() function of all C++
+       * This function is analogous to the swap() function of all C++
        * standard containers. Also, there is a global function swap(u,v) that
        * simply calls <tt>u.swap(v)</tt>, again in analogy to standard
        * functions.
index f80781cec3db00b87e53cc4abfb14a7b2fa88442..0e3d4e624bbe6220c73c402b967f2202ef23df55 100644 (file)
@@ -734,7 +734,7 @@ namespace PETScWrappers
      * only swaps the pointers to the data of the two vectors and therefore
      * does not need to allocate temporary storage and move data around.
      *
-     * This function is analogous to the the @p swap function of all C++
+     * This function is analogous to the @p swap function of all C++
      * standard containers. Also, there is a global function
      * <tt>swap(u,v)</tt> that simply calls <tt>u.swap(v)</tt>, again in
      * analogy to standard functions.
index 9cb64ea562f2fc532dcda158108955eee2d4b509..80f29e242593414687471bc37c6e551ca1634287 100644 (file)
@@ -225,7 +225,7 @@ namespace LinearAlgebra
      * only swaps the pointers to the data of the two vectors and therefore
      * does not need to allocate temporary storage and move data around.
      *
-     * This function is analogous to the the @p swap function of all C++
+     * This function is analogous to the @p swap function of all C++
      * standard containers. Also, there is a global function
      * <tt>swap(u,v)</tt> that simply calls <tt>u.swap(v)</tt>, again in
      * analogy to standard functions.
index 91b4d8c1b87e08c6dae2ab17a9decde4354b156a..1c37f1865294539f1600ee2fb03a91e9affde0a7 100644 (file)
@@ -158,7 +158,7 @@ private:
   std::vector<number> diag;
 
   /**
-   * Inverses of the the diagonal: precomputed for faster vmult.
+   * Inverses of the diagonal: precomputed for faster vmult.
    */
   std::vector<number> inv_diag;
 
index 0b9e00a88123d735fca2942b284d77f645d953f5..f184567c648631b264b726574550a5bed7751c24 100644 (file)
@@ -270,7 +270,7 @@ namespace TrilinosWrappers
        * the same number of blocks. If needed, the numbers of blocks should be
        * exchanged, too.
        *
-       * This function is analogous to the the swap() function of all C++
+       * This function is analogous to the swap() function of all C++
        * standard containers. Also, there is a global function swap(u,v) that
        * simply calls <tt>u.swap(v)</tt>, again in analogy to standard
        * functions.
index 1d9ede0a6228a1234ec89eebc82334f15e062155..0b149d164296741ccde97aad694d1338ebce5117 100644 (file)
@@ -355,7 +355,7 @@ namespace TrilinosWrappers
      * a ghosted vector may not even store all of the elements a non- ghosted
      * vector would store on the current processor.  Consequently, for
      * Trilinos vectors, there is no notion of an 'owner' of vector elements
-     * in the way we have it in the the non-ghost case view.
+     * in the way we have it in the non-ghost case view.
      *
      * This explains why we do not allow writing into ghosted vectors on the
      * Trilinos side: Who would be responsible for taking care of the
@@ -1134,7 +1134,7 @@ namespace TrilinosWrappers
        * does not need to allocate temporary storage and move data around. Note
        * that the vectors need to be of the same size and base on the same map.
        *
-       * This function is analogous to the the @p swap function of all C++
+       * This function is analogous to the @p swap function of all C++
        * standard containers. Also, there is a global function
        * <tt>swap(u,v)</tt> that simply calls <tt>u.swap(v)</tt>, again in
        * analogy to standard functions.
index 99a61346ea1e183d650b0818bc8be18097d9696e..49181d00bbccaf40563b76691f86b54168d7876e 100644 (file)
@@ -308,7 +308,7 @@ public:
    * swaps the pointers to the data of the two vectors and therefore does not
    * need to allocate temporary storage and move data around.
    *
-   * This function is analogous to the the @p swap function of all C++
+   * This function is analogous to the @p swap function of all C++
    * standard containers. Also, there is a global function <tt>swap(u,v)</tt>
    * that simply calls <tt>u.swap(v)</tt>, again in analogy to standard
    * functions.
index 3d628133b83f689a084741c40925c7ec58c45f85..5487791c404b6b04b9713222769d5c583512d1bf 100644 (file)
@@ -495,7 +495,7 @@ public:
   /**
    * Return a read and write pointer to the first field of the dof values.
    * This is the data field the read_dof_values() functions write into. First
-   * come the the dof values for the first component, then all values for the
+   * come the dof values for the first component, then all values for the
    * second component, and so on. This is related to the internal data
    * structures used in this class. In general, it is safer to use the
    * get_dof_value() function instead.
index 6fa2bdf3839ba43a24c0a0f7bcb056046171551e..efaa62ae799783d163f0374b66e04b461252f637 100644 (file)
@@ -100,7 +100,7 @@ public:
   /**
    * Implementation of the interface for @p Multigrid. This function does
    * nothing, which by comparison with the definition of this function means
-   * that the the smoothing operator equals the null operator.
+   * that the smoothing operator equals the null operator.
    */
   virtual void smooth (const unsigned int         level,
                        BlockVector<number>       &u,
index b64a1bd86cc38c5bd8db27fec7b33e6008cce4a8..06bbd5632e93320721d974a56ba27af06bfda389 100644 (file)
@@ -136,7 +136,7 @@ public:
   /**
    * Implementation of the interface for @p Multigrid. This function does
    * nothing, which by comparison with the definition of this function means
-   * that the the smoothing operator equals the null operator.
+   * that the smoothing operator equals the null operator.
    */
   virtual void smooth (const unsigned int level,
                        VectorType         &u,
index bdd53a4df144d20f8fdd88069fc718e773ecb38d..61f9611a954f83d80e70f3fbab62b5af6b13f920 100644 (file)
@@ -389,7 +389,7 @@ namespace VectorTools
     L1_norm,
 
     /**
-     * The square of the function is integrated and the the square root of the
+     * The square of the function is integrated and the square root of the
      * result is computed on each cell:
      * @f[
      *   E_K = \sqrt{ \int_K \sum_c e_c^2 \, w_c }
index 01bcd69a0761d21a95721d6d905c61478297a037..9a786137e582d7fb637f097c5e03263611ba7a8f 100644 (file)
@@ -291,7 +291,7 @@ void DataOutStack<dim,spacedim,DoFHandlerType>::build_patches (const unsigned in
 
   // add the required number of
   // patches. first initialize a template
-  // patch with n_q_points (in the the plane
+  // patch with n_q_points (in the plane
   // of the cells) times n_subdivisions+1 (in
   // the time direction) points
   dealii::DataOutBase::Patch<dim+1,dim+1>  default_patch;
@@ -366,7 +366,7 @@ void DataOutStack<dim,spacedim,DoFHandlerType>::build_patches (const unsigned in
         };
 
 
-      // now fill in the the data values.
+      // now fill in the data values.
       // note that the required order is
       // with highest coordinate running
       // fastest, we need to enter each
index 6358b271d951f893b51d6703ce34c79e24b45024..145ca0e3b8760cc3d1b5c7e16344c6b521b8fd6b 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// same as the the test with number _01, but check for block vectors
+// same as the test with number _01, but check for block vectors
 
 
 #include "../tests.h"
index 26635ccd70bbc6556759c0c401a90e9ccb8d870f..2eedc698e28169414a2f57d1aa0642757fbeee98 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// same as the the test with number _01, but check for block vectors
+// same as the test with number _01, but check for block vectors
 
 #include "../tests.h"
 #include "data_out_common.h"
index 77fadceaf073255ff20026f7df6b0e3b183c4e6f..a018cea97a0d1ab44079819490a34442b5d4d1f8 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// same as the the test with number _01, but check for block vectors
+// same as the test with number _01, but check for block vectors
 
 
 #include "../tests.h"

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.