]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Misc. typos
authorluz.paz <luzpaz@users.noreply.github.com>
Mon, 29 Apr 2019 19:49:00 +0000 (15:49 -0400)
committerluz.paz <luzpaz@users.noreply.github.com>
Mon, 29 Apr 2019 19:49:00 +0000 (15:49 -0400)
Found via `codespell -q 3 -I ../dealii-word-whitelist.txt -S ./bundled`

54 files changed:
contrib/utilities/generate_lapack_templates
contrib/utilities/indent
contrib/utilities/indent.py
doc/doxygen/headers/automatic_and_symbolic_differentiation.h
doc/doxygen/headers/manifold.h
doc/news/changes/minor/20181006LucaHeltai
examples/step-44/step-44.cc
examples/step-53/doc/intro.dox
examples/step-61/doc/intro.dox
examples/step-61/doc/results.dox
examples/step-7/step-7.cc
include/deal.II/algorithms/general_data_storage.h
include/deal.II/base/function_lib.h
include/deal.II/base/hdf5.h
include/deal.II/base/symmetric_tensor.templates.h
include/deal.II/differentiation/ad/ad_drivers.h
include/deal.II/differentiation/ad/ad_helpers.h
include/deal.II/differentiation/sd/symengine_number_types.h
include/deal.II/differentiation/sd/symengine_scalar_operations.h
include/deal.II/differentiation/sd/symengine_tensor_operations.h
include/deal.II/differentiation/sd/symengine_utilities.h
include/deal.II/dofs/dof_objects.h
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/fe_tools.templates.h
include/deal.II/grid/manifold_lib.h
include/deal.II/hp/fe_collection.h
include/deal.II/integrators/advection.h
include/deal.II/lac/affine_constraints.h
include/deal.II/lac/cuda_solver_direct.h
include/deal.II/lac/trilinos_tpetra_vector.h
include/deal.II/lac/trilinos_tpetra_vector.templates.h
include/deal.II/matrix_free/cuda_hanging_nodes_internal.h
include/deal.II/meshworker/scratch_data.h
source/differentiation/ad/ad_drivers.cc
source/fe/fe_enriched.cc
source/grid/grid_tools.cc
source/lac/cuda_sparse_matrix.cu
source/non_matching/coupling.cc
tests/base/assign_subscriptor.cc
tests/base/assign_subscriptor.debug.output
tests/base/hdf5_03.cc
tests/base/hdf5_04.cc
tests/base/hdf5_05.cc
tests/base/hdf5_06.cc
tests/cuda/array_view_wrong_memory.cu
tests/grid/grid_in_ucd_01.cc
tests/lac/linear_operator_13.cc
tests/lac/linear_operator_14.cc
tests/manifold/tensor_product_manifold_03.cc
tests/mpi/hp_refinement_02.cc
tests/mpi/p4est_3d_refine_01.cc
tests/optimization/step-44.h
tests/petsc/full_matrix_00.cc
tests/tests.h

index af3e009e7e99835e736c06ca5e13c1ab05a74c2c..d86e466800a3254bea8adf8101c146a2e5de03c4 100755 (executable)
@@ -557,7 +557,7 @@ def main():
                     routines.append(FortranRoutine(file_name, guard_fp))
                 except NotImplementedError:
                     # not a lot we can do. If its in the whitelist we will fail
-                    # again later anway
+                    # again later anyway
                     continue
             routines.sort(key=lambda u: u.general_name)
 
index ca889f7fcd367c38f07f1ac47859cd727fb8d890..9cb6892274d1d1bba7fe1bb8ce9e28bbe5668c41 100755 (executable)
@@ -17,7 +17,7 @@
 #
 # This script does the same thing as contrib/utilities/indent-all but only
 # reformats files which have changed (or have been added but neither
-# staged/commited) since the last merge commit to the master branch.
+# staged/committed) since the last merge commit to the master branch.
 #
 # The script needs to be executed as
 #   ./contrib/utilities/indent
index 0ca683d70891ba248b7ed2763c80a7e2f9ce42f1..82ba521487e7614bec88d8b809dd15806be89acb 100644 (file)
@@ -112,7 +112,7 @@ def parse_arguments():
                         "By default only \"examples\", \"include\", "
                         "\"source\" and \"tests\" "
                         "directories are chosen to work on."
-                        "Path to directories can be both abosulte or relative.")
+                        "Path to directories can be both absolute or relative.")
 
     parser.add_argument("-j", metavar="THREAD_COUNT", type=int, default=0,
                         help="Number of clang-format instances to be run "
index ae5178e2c8bcf7beb077c6a76527570b70b8a1d8..2a15a2ae0b098f00cf98642f57fbc4773f44b1fe 100644 (file)
@@ -96,7 +96,7 @@
  *    that, with the appropriate implementation, both first and second derivatives can be computed exactly.
  * -# With <em>taped</em> approaches, a specified subregion of code is selected as one for which all
  *    operations executed with active (marked) input variables are tracked and recorded in a data structure
- *    referred to as a tape. At the end of the taped region, the recorded function(s) may be revaluated
+ *    referred to as a tape. At the end of the taped region, the recorded function(s) may be reevaluated
  *    by "replaying" the tape with a different set of input variables instead of recomputing the function
  *    directly. Assuming that the taped region represents a smooth function, arbitrarily high-order
  *    derivatives of the function then can be computed by referring to the code path tracked and stored on
  * graph is required.
  *
  * In reverse-mode, the chain-rule is computed somewhat unnaturally from the "outside in". The
- * values of the dependent variables first get computed and fixed, and then the preceeding
+ * values of the dependent variables first get computed and fixed, and then the preceding
  * differential operations are evaluated and multiplied in succession with the previous results
  * from left to right. Again, if we encapsulate and fix the order of operations using parentheses,
  * this implies that the reverse calculation is performed by
index 0eb3b05b48c5caefb6f74ca2f52231a95658b143..84e04ef3795b23bf8e858ad224ff273545d51a66 100644 (file)
@@ -60,7 +60,7 @@
  *   in the Mapping class (see the @ref mapping module), which however obtains
  *   its information about the boundary of the domain from the classes
  *   described here. The same is, of course, true when integrating boundary
- *   terms (e.g., inhomogenous Neumann boundary conditions).
+ *   terms (e.g., inhomogeneous Neumann boundary conditions).
  *
  *   <li> Domains with nonzero codimension: In cases where a Triangulation is
  *   embedded into a higher dimensional space, i.e., whenever the second
index ea8e3d0ec8845717689e2c65e3105e080157a2e5..f1426feb81d828ba8a0eeeb9dc38cbfee5c762df 100644 (file)
@@ -1,4 +1,4 @@
-New: Added RTree class and pack_rtree() function to create a boost::gemoetry::index::rtree from 
+New: Added RTree class and pack_rtree() function to create a boost::geometry::index::rtree from 
 containers and/or iterators of BoundingBox, Point, or Segment objects. 
 <br>
 (Luca Heltai, 2018/10/06)
index 1cbc8c819407e20ac282d4cfb515a20320f892d3..7a60db62fefb7c02e6df61f5dad2de3538c6f8fc 100644 (file)
@@ -2440,7 +2440,7 @@ namespace Step44
     // build non-homogeneous constraints in the zeroth iteration (that is, when
     // `apply_dirichlet_bc == true`) and build only the corresponding
     // homogeneous constraints in the following step. While the current
-    // example has only homogenous constraints, previous experiences have
+    // example has only homogeneous constraints, previous experiences have
     // shown that a common error is forgetting to add the extra condition when
     // refactoring the code to specific uses. This could lead errors that are
     // hard to debug. In this spirit, we choose to make the code more verbose
index cfe64dd35fba9dac907c0cb7f85391228d207793..f5c51da6665e44150e5b7fa0e35cd11fb34a3893 100644 (file)
@@ -72,7 +72,7 @@ program the details of your geometry:
   necessary to compute integrals using curved approximations of the boundary,
   i.e., describe each edge or face of cells as curves, instead of straight
   line segments or bilinear patches. The same is, of course, true when
-  integrating boundary terms (e.g., inhomogenous Neumann boundary
+  integrating boundary terms (e.g., inhomogeneous Neumann boundary
   conditions). For the purpose of integration, the various Mapping classes
   then provide the transformation from the reference cell to the actual cell.
 
index a93d150da18790ba3a6129b1e93c0959fb7e8584..8173bdbc2352438f2e7409763b6f1b1b6e465129 100644 (file)
@@ -88,7 +88,7 @@ be important in the considerations below.
 
 In this program, we will consider a test case where the exact pressure 
 is $p = \sin \left( \pi x\right)\sin\left(\pi y \right)$ on the unit square domain,
-with homogenous Dirichelet boundary conditions and $\mathbf{K}$ the identity matrix.
+with homogeneous Dirichelet boundary conditions and $\mathbf{K}$ the identity matrix.
 Then we will calculate $L_2$ errors of pressure, velocity, and flux.
 
 
index 37eb72eccfa769eb6aae3520e859fb938199ffef..41b73af8e57123735c8112a8d7c55301b0be75ec 100644 (file)
@@ -1,6 +1,6 @@
 <h1>Results</h1>
 
-We run the test example $p = \sin(\pi x) \sin(\pi y)$ with homogenous Dirichelet 
+We run the test example $p = \sin(\pi x) \sin(\pi y)$ with homogeneous Dirichelet 
 boundary conditions in the domain $\Omega = (0,1)^2$. And  $\mathbf{K}$ is the 
 identity matrix. We test it on $\mbox{WG}(Q_0,Q_0;RT_{[0]})$, $\mbox{WG}(Q_1,Q_1;RT_{[1]})$ 
 and $\mbox{WG}(Q_2,Q_2;RT_{[2]})$. We will visualize pressure values in interiors 
index 223460cf7dcfe20bf95230d82dc7780b44a75d09..f9c8fb1c6f34cee8c00045665cc4c1efd78467b0 100644 (file)
@@ -378,7 +378,7 @@ namespace Step7
     //
     // We will show here how the library managed to find out that there are
     // still active references to an object and the object is still alive
-    // frome the point of view of a using object. Basically, the method is along
+    // from the point of view of a using object. Basically, the method is along
     // the following line: all objects that are subject to such potentially
     // dangerous pointers are derived from a class called Subscriptor. For
     // example, the Triangulation, DoFHandler, and a base class of the
index 2517b411497a0858e1e959ffb1aef9077688e501..dfbc3bd07362d689c79a2b933a21b5af20c95e58 100644 (file)
@@ -145,7 +145,7 @@ public:
    *     = *ptr_to_some_number; // Invalid call
    * @endcode
    *
-   * Similar to the first example, we must be concious of the fact that the
+   * Similar to the first example, we must be conscious of the fact that the
    * copies of any @p Type stored by @p data only remains valid while the
    * GeneralDataStorage instance in which it is stored is alive.
    *
index adca58384c393e0abf506e29ebd5e18cd5c8c714..4e8645b7df65d907c72230b22869c5068c88c8a6 100644 (file)
@@ -1022,7 +1022,7 @@ namespace Functions
     const unsigned int selected;
 
     /**
-     * Flag that controls wether we rescale the value when the radius changes.
+     * Flag that controls whether we rescale the value when the radius changes.
      */
     bool integrate_to_one;
 
@@ -1070,7 +1070,7 @@ namespace Functions
       const bool         integrate_to_one = false);
 
     /**
-     * Initialize the class with an objet of type
+     * Initialize the class with an object of type
      * @tparam CutOffFunctionBaseType<1>.
      */
     template <template <int> class CutOffFunctionBaseType>
index be38947801f522113fe98157819a011c197fa3ed..77d42802f317a4dbe7ae93ce35c7bbb635d3462b 100644 (file)
@@ -954,7 +954,7 @@ namespace HDF5
     };
     /**
      * This constructor creates or opens a group depending on the value of
-     * @p mode. The group will be placed insided the group @p parent_group. The
+     * @p mode. The group will be placed inside the group @p parent_group. The
      * parameter @p mpi defines if the the I/O operations are serial or
      * parallel. This is an internal constructor, the functions open_group() and
      * create_group() of the current class should be used to open or create a
index b5b496379b4d643741e238b05a2981893bc96448..481f4b2cf892277ca365acc28cc432d4e2f9f364 100644 (file)
@@ -601,7 +601,7 @@ namespace internal
       eig_vals_vecs[1].second /= eig_vals_vecs[1].second.norm();
 
       // If vectors are nearly linearly dependent, or if there might have
-      // been large cancelations in the calculation of A[i][i] - w[0], fall
+      // been large cancellations in the calculation of A[i][i] - w[0], fall
       // back to QL algorithm
       if (eig_vals_vecs[0].second * eig_vals_vecs[1].second > error)
         {
index cdde7694598ecf2ee626037f6f5228f817e5e5c1..b425aedcaf3e68f5bc4c04c2d11a8e7f62e6b7c1 100644 (file)
@@ -368,7 +368,7 @@ namespace Differentiation
       reset(const bool clear_registered_tapes);
 
       /**
-       * Print the status of all queriable data. Exactly what is printed and
+       * Print the status of all queryable data. Exactly what is printed and
        * its format depends on the @p ad_type, as is determined by the
        * @p ADNumberTypeCode template parameter.
        *
index 13844113c2c74dae36ff74d9afc58aae491bb8ba..5dec834e6e54d2a0906514d6ea92b4eb9d62aa8b 100644 (file)
@@ -3813,7 +3813,7 @@ namespace Differentiation
               "that the component offsets used to construct their counterpart "
               "extractors are incompatible with one another. Make sure that "
               "the first component for each extractor properly takes into "
-              "account the dimensionality of the preceeding fields."));
+              "account the dimensionality of the preceding fields."));
         }
 #    endif
       set_independent_variable(value, extractor);
index 2b4c65330874316b8f92638db440e80f439e68a2..c98b43397337c4ae46caa0d0f12e0bc7eae8abd8 100644 (file)
@@ -345,7 +345,7 @@ namespace Differentiation
        * This constructor initializes a symbolic type with a string
        * representing its symbolic value.
        * If the @p parse_as_expression flag is <tt>false</tt>, then the
-       * @p symb_expr (potentially composed of mulitple characters) will be
+       * @p symb_expr (potentially composed of multiple characters) will be
        * interpreted as a single symbol.
        * If the @p parse_as_expression flag is <tt>true</tt>, then the
        * @p symb_expr will be parsed as a symbolic expression (potentially
index 777ee737df7ec056ce2f97cb060f48fed8806a99..5a52ea7359a43d3f7ec0f370b49fa5adf1b6c682 100644 (file)
@@ -53,7 +53,7 @@ namespace Differentiation
      * For example, if the @p symbol is the string `"x"` then the scalar
      * symbolic variable that is returned represents the scalar $x$.
      *
-     * @param[in] symbol An indentifier (or name) for the returned symbolic
+     * @param[in] symbol An identifier (or name) for the returned symbolic
      *            variable.
      * @return A scalar symbolic variable with the name @p symbol.
      *
@@ -73,7 +73,7 @@ namespace Differentiation
      * symbolic variable `x` and the symbolic expression `y+z`, then the
      * generic symbolic function that is returned represents $f(x, y+z)$.
      *
-     * @param[in] symbol An indentifier (or name) for the returned symbolic
+     * @param[in] symbol An identifier (or name) for the returned symbolic
      *            function.
      * @param[in] arguments A vector of input arguments to the returned
      *            symbolic function.
@@ -98,7 +98,7 @@ namespace Differentiation
      * symbolic variable `x` and the symbolic expression `y+z`, then the
      * generic symbolic function that is returned represents $f(x, y+z)$.
      *
-     * @param[in] symbol An indentifier (or name) for the returned symbolic
+     * @param[in] symbol An identifier (or name) for the returned symbolic
      *            function.
      * @param[in] arguments A map of input arguments to the returned
      *            symbolic function.
index b14f120eafe558ebc007636a65b8110caf7bdad7..bedbe76937baedb8627acd7fdf2b4e9087c35fe4 100644 (file)
@@ -50,7 +50,7 @@ namespace Differentiation
      * indicates its component index.
      *
      * @tparam dim The dimension of the returned tensor.
-     * @param[in] symbol An indentifier (or name) for the vector of returned
+     * @param[in] symbol An identifier (or name) for the vector of returned
      *            symbolic variables.
      * @return A vector (a rank-1 tensor) of symbolic variables with the name of
      *         each individual component prefixed by @p symbol.
@@ -73,7 +73,7 @@ namespace Differentiation
      *
      * @tparam rank The rank of the returned tensor.
      * @tparam dim The dimension of the returned tensor.
-     * @param[in] symbol An indentifier (or name) for the tensor of returned
+     * @param[in] symbol An identifier (or name) for the tensor of returned
      *            symbolic variables.
      * @return A tensor of symbolic variables with the name of each individual
      *         component prefixed by @p symbol.
@@ -96,7 +96,7 @@ namespace Differentiation
      *
      * @tparam rank The rank of the returned tensor.
      * @tparam dim The dimension of the returned tensor.
-     * @param[in] symbol An indentifier (or name) for the tensor of returned
+     * @param[in] symbol An identifier (or name) for the tensor of returned
      *            symbolic variables.
      * @return A tensor of symbolic variables with the name of each individual
      *         component prefixed by @p symbol.
@@ -115,7 +115,7 @@ namespace Differentiation
      * @p arguments map; the values stored in the map are ignored.
      *
      * @tparam dim The dimension of the returned tensor.
-     * @param[in] symbol An indentifier (or name) for the vector of returned
+     * @param[in] symbol An identifier (or name) for the vector of returned
      *            symbolic functions.
      * @param[in] arguments A map of input arguments to the returned
      *            symbolic functions.
@@ -140,7 +140,7 @@ namespace Differentiation
      *
      * @tparam rank The rank of the returned tensor.
      * @tparam dim The dimension of the returned tensor.
-     * @param[in] symbol An indentifier (or name) for the tensor of returned
+     * @param[in] symbol An identifier (or name) for the tensor of returned
      *            symbolic functions.
      * @param[in] arguments A map of input arguments to the returned
      *            symbolic functions.
@@ -165,7 +165,7 @@ namespace Differentiation
      *
      * @tparam rank The rank of the returned tensor.
      * @tparam dim The dimension of the returned tensor.
-     * @param[in] symbol An indentifier (or name) for the tensor of returned
+     * @param[in] symbol An identifier (or name) for the tensor of returned
      *            symbolic functions.
      * @param[in] arguments A map of input arguments to the returned
      *            symbolic functions.
index 08785c2d611ee33a2559c838451dce6a6079a2fd..47e367c2d0a36f8f68c424c0753879d3039bf494 100644 (file)
@@ -53,7 +53,7 @@ namespace Differentiation
       /**
        * Extract the symbols (key entries) from a substitution map.
        *
-       * @note It is guarenteed that the order of extraction of data into the
+       * @note It is guaranteed that the order of extraction of data into the
        * output vector is the same as that for extract_values().
        * That is to say that the unzipped key and value pairs as given by
        * extract_symbols() and extract_values() always have a 1:1
@@ -67,7 +67,7 @@ namespace Differentiation
        * The value entries will be converted into the @p NumberType given
        * as a template parameter to this function via the @p ExpressionType.
        *
-       * @note It is guarenteed that the order of extraction of data into the
+       * @note It is guaranteed that the order of extraction of data into the
        * output vector is the same as that for extract_symbols().
        * That is to say that the unzipped key and value pairs as given by
        * extract_symbols() and extract_values() always have a 1:1
index 6990b56bf09f534dd3942f4efe2ec215c9709125..108d37bb79ea3d6c8854b5e55eea3e1c7c420769 100644 (file)
@@ -56,7 +56,7 @@ namespace internal
      * associated with vertices are not stored in the DoFObjects classes but
      * rather in the DoFHandler::vertex_dofs array.
      *
-     * The DoFObjects classes are not used directly, but objects of theses
+     * The DoFObjects classes are not used directly, but objects of these
      * classes are included in the DoFLevel and DoFFaces classes.
      *
      * @ingroup dofs
index 2dd019639dd29b80d9ba795cf4c22bd9df2f625b..bc29ce44acab4f6ba77de550fdd39cdf9888dc96 100644 (file)
@@ -160,7 +160,7 @@ namespace GridTools
  *
  * In some cases, one wants to only work with DoFs that sit on the boundary.
  * One application is, for example, if rather than interpolating non-
- * homogenous boundary values, one would like to project them. For this, we
+ * homogeneous boundary values, one would like to project them. For this, we
  * need two things: a way to identify nodes that are located on (parts of) the
  * boundary, and a way to build matrices out of only degrees of freedom that
  * are on the boundary (i.e. much smaller matrices, in which we do not even
@@ -899,7 +899,7 @@ namespace DoFTools
    * in ${\cal V}_1$ since by construction ${\cal V}_0 \subset {\cal V}_1$.
    * However, not every function in ${\cal V}_1$ can be expressed as a linear
    * combination of the shape functions of ${\cal V}_0$. The functions that
-   * can be represented lie in a homogenous subspace of ${\cal V}_1$ (namely,
+   * can be represented lie in a homogeneous subspace of ${\cal V}_1$ (namely,
    * ${\cal V}_0$, of course) and this subspace can be represented by a linear
    * constraint of the form $CV=0$ where $V$ is the vector of nodal values of
    * functions $v\in {\cal V}_1$. In other words, every function $v_h=\sum_j
index be0bc3ff29b1a66c5a2011f1f21564fee84f8c93..16df88d217543efc8828bbf07583e9698dfdcb91 100644 (file)
@@ -3173,7 +3173,7 @@ namespace FETools
 
     const unsigned int dofs_per_cell = Utilities::fixed_power<dim>(n);
 
-    // Assert size maches degree
+    // Assert size matches degree
     AssertDimension(h2l.size(), dofs_per_cell);
 
     // polynomial degree
index a550c26613faf4cb25d50ea08cacea042236c888..75507540ab09451c1cdabd3c5180750668388189 100644 (file)
@@ -465,7 +465,7 @@ private:
 
 /**
  * Elliptical manifold description derived from ChartManifold.
- * More informations on the elliptical coordinate system can be found
+ * More information on the elliptical coordinate system can be found
  * at <a
  * href="https://en.wikipedia.org/wiki/Elliptic_coordinate_system">Wikipedia
  * </a>.
index 4368627dff7d244c9aff6694ae2e17856937e40d..c8ab5fb90890769425ba51a7589acecb61165965 100644 (file)
@@ -60,7 +60,7 @@ namespace hp
      * succeeding finite elements for refinement and preceding ones for
      * coarsening.
      *
-     * In this struct, we supply a hierachy that is imposed on all FECollection
+     * In this struct, we supply a hierarchy that is imposed on all FECollection
      * objects by default.
      */
     struct DefaultHierarchy
index 513489521e7a514093c62f6d00d0892b30d4c830..722c0bba9d6a37cd9b1236468b9665b38538225a 100644 (file)
@@ -373,7 +373,7 @@ namespace LocalIntegrators
      * Here, the numerical flux $\widehat u$ is the upwind value at the face,
      * namely the finite element function whose values are given in the
      * argument `input` on the outflow boundary. On the inflow boundary, it is
-     * the inhomogenous boundary value in the argument `data`.
+     * the inhomogeneous boundary value in the argument `data`.
      *
      * The <tt>velocity</tt> is provided as an ArrayView, having <tt>dim</tt>
      * vectors, one for each velocity component. Each of the vectors must
@@ -440,7 +440,7 @@ namespace LocalIntegrators
      * Here, the numerical flux $\widehat u$ is the upwind value at the face,
      * namely the finite element function whose values are given in the
      * argument `input` on the outflow boundary. On the inflow boundary, it is
-     * the inhomogenous boundary value in the argument `data`.
+     * the inhomogeneous boundary value in the argument `data`.
      *
      * The <tt>velocity</tt> is provided as an ArrayView, having <tt>dim</tt>
      * vectors, one for each velocity component. Each of the vectors must
index 68ee38e0f495e34f1b7517cff944e7fe6eeaf58e..992a993038dd4277787f791818562f0980009fb4 100644 (file)
@@ -1187,7 +1187,7 @@ public:
   {
     /**
      * A data type in which we store the list of entries that make up the
-     * homogenous part of a constraint.
+     * homogeneous part of a constraint.
      */
     using Entries = std::vector<std::pair<size_type, number>>;
 
index e53eef8accfc9a5b10cb23515284c5d6d4d0570e..463c87b42588b3227da6b3b20a21d334fae2c44f 100644 (file)
@@ -101,7 +101,7 @@ namespace CUDAWrappers
     /**
      * Reference to the object that controls convergence of the iterative
      * solver. In fact, for these CUDA wrappers, cuSOLVER and cuSPARSE do so
-     * themselve, but we copy the data from this object before starting the
+     * themselves, but we copy the data from this object before starting the
      * solution process, and copy the data back into it afterwards.
      */
     SolverControl &solver_control;
index 69303e228403f8e882a1ca7b72f2ff317644de37..c255ae72acf753d5d83a3476d78305046ae961b2 100644 (file)
@@ -327,7 +327,7 @@ namespace LinearAlgebra
       trilinos_vector() const;
 
       /**
-       * Return a (modifyable) reference to the underlying Trilinos
+       * Return a (modifiable) reference to the underlying Trilinos
        * Tpetra::Vector class.
        */
       Tpetra::Vector<Number, int, types::global_dof_index> &
index 0a9ba5114115db5cbc83c900982bfaa1495f1099..bca5fcef33d07cda77ee7e1db6a83955f0b1e85f 100644 (file)
@@ -169,7 +169,7 @@ namespace LinearAlgebra
       VectorOperation::values                         operation,
       std::shared_ptr<const CommunicationPatternBase> communication_pattern)
     {
-      // If no communication pattern is given, create one. Otherwsie, use the
+      // If no communication pattern is given, create one. Otherwise, use the
       // one given.
       if (communication_pattern == nullptr)
         {
index 8fcab1a6d219fdd493a9e365cec35c81dd5012fa..3190c8e14ff1fa04db39820205db021a5e087faf 100644 (file)
@@ -122,7 +122,7 @@ namespace CUDAWrappers
 
       // The element is placed in the 'first position' along *-axis. These also
       // determine which face is constrained. For example, in 2D, if
-      // constr_face_x and constr_type are set, then x = 0 is contrained.
+      // constr_face_x and constr_type are set, then x = 0 is constrained.
       constexpr unsigned int constr_type_x = 1 << 0;
       constexpr unsigned int constr_type_y = 1 << 1;
       constexpr unsigned int constr_type_z = 1 << 2;
index 5c4088d5baaa7ac6c0a713c2ddddecf1326c350c..5201f11ede1e2adc6797421854068b95a5233838 100644 (file)
@@ -76,7 +76,7 @@ namespace MeshWorker
    *
    * Similarly, the methods in @ref NeighborCellMethods initialize on demand
    * (different) internal FEValues, FEFaceValues, and FESubfaceValues, on
-   * neighbor cells, allowing the use of this class aslo as a single substitute
+   * neighbor cells, allowing the use of this class also as a single substitute
    * for the additional three objects you would typically need to integrate on
    * the neighbor cell, and on its faces and subfaces (for example, in
    * discontinuous Galerkin methods).
index ff0a9637cf402f9688e9f4fa073e7fac1ad42f5c..a7882568d3d084ddd105afe1fd8f62dc65a95baf 100644 (file)
@@ -362,7 +362,7 @@ namespace Differentiation
       // the terminal, of the form
       // ADOL-C error: reading integer tape number 4!
       //               >>> File or directory not found! <<<
-      // , every time a query is made about a non-existant tape.
+      // , every time a query is made about a non-existent tape.
       // So either way we have to guard that check with something more
       // conervative so that we don't output useless messages for our users.
       const std::vector<typename Types<ADNumberType>::tape_index>
@@ -517,7 +517,7 @@ namespace Differentiation
       const auto it_status_tape = status.find(tape_index);
 
       // This tape's status has not been found in the map. This could be
-      // because a non-existant tape_index has been used as an argument, or
+      // because a non-existent tape_index has been used as an argument, or
       // because the tape exists but has not been used (in a way that
       // initiated a status update). For example, on can create a tape in one
       // section of code and then query the status of all existing tapes in a
index 8dd92350b1b6334b0bb6ade95b8f8d547bb87406..ec5368122ca344bb1e2c2715414e61dc968e7c1e 100644 (file)
@@ -1297,7 +1297,7 @@ namespace ColorEnriched
                ++face)
             {
               // cell shouldn't be at the boundary and
-              // neigboring cell is not already visited (to avoid visiting
+              // neighboring cell is not already visited (to avoid visiting
               // same face twice). Note that the cells' material ids are
               // labeled according to their order in dof_handler previously.
               if (!cell->at_boundary(face) &&
index 10f5dd627244fabd73387eb19d11a0088de7e7ad..228c4badb0a5bd2bb9984dd37079351aa0e68ae0 100644 (file)
@@ -1119,7 +1119,7 @@ namespace GridTools
                                                   0,
                                   false);
     // for parallel::shared::Triangulation we need to work on all vertices,
-    // not just the ones related to loacally owned cells;
+    // not just the ones related to locally owned cells;
     const bool is_parallel_shared =
       (dynamic_cast<parallel::shared::Triangulation<dim, spacedim> *>(
          &triangulation) != nullptr);
index 687e565d26ecb1fe1ed4e7a80695b4835860beab..f6c8d3740750916a08dab8d0ea43963f33cc21fc 100644 (file)
@@ -545,7 +545,7 @@ namespace CUDAWrappers
                                  row_ptr_dev.get(),
                                  row_sums.get_values());
 
-#  ifdef DEUG
+#  ifdef DEBUG
     // Check that the kernel was launched correctly
     AssertCuda(cudaGetLastError());
     // Check that there was no problem during the execution of the kernel
index d8d31cf2d3c987f532e4bfadef94a3f81b5a771a..4df28b9fa2199050543af16b026fe87680100745 100644 (file)
@@ -92,9 +92,9 @@ namespace NonMatching
                   boost::geometry::index::intersects(bbox),
                   std::back_inserter(out_vals));
                 // Each bounding box corresponds to an active cell
-                // of the imbedding triangulation: we now check if
-                // the current cell, of the imbedded triangulation,
-                // overlaps a locally owned cell of the imbedding one
+                // of the embedding triangulation: we now check if
+                // the current cell, of the embedded triangulation,
+                // overlaps a locally owned cell of the embedding one
                 for (const auto &bbox_it : out_vals)
                   if (bbox_it.second->is_locally_owned())
                     {
index c38e3be2b7320ff097e1b4bd8957cd9f5c93fdaf..1ede4f860e2b5f75e5f37eef5234dba1d91cbcf6 100644 (file)
@@ -93,7 +93,7 @@ main()
   }
 
   {
-    deallog << "Checking move assignement" << std::endl;
+    deallog << "Checking move assignment" << std::endl;
 
     Subscriptor               subscriptor_1;
     Subscriptor               subscriptor_2;
index 4d3bb27e557c22ba359016cdb78adb1713aaa579..fdb70c3ff21698b1dcdafc716c25aedec32525ab 100644 (file)
@@ -6,7 +6,7 @@ DEAL::
 DEAL::Checking copy construction
 DEAL::Checking smart_pointer_1
 DEAL::
-DEAL::Checking move assignement
+DEAL::Checking move assignment
 DEAL::Checking smart_pointer_1
 DEAL::ExcMessage("The object pointed to is not valid anymore.")
 DEAL::Checking smart_pointer_2
index 190f48da7fd2dd4e1a8a852ff94e0488223c22a5..ef496fc72baf44ee0f3ea91dd7d735671a9fe0ef 100644 (file)
@@ -109,7 +109,7 @@ get_factor()
   return static_cast<Number>(std::complex<float>(1, 1));
 }
 
-// This function assignes data to the elements of the container
+// This function assigns data to the elements of the container
 template <template <class...> class Container, typename Number>
 typename std::enable_if<
   std::is_same<Container<Number>, std::vector<Number>>::value,
index d7e2a2d3023c1ce39bb4ab63c6d961ca7ceec9a6..77df04df9faf733d2fa4b58d0a72ebd134091ca0 100644 (file)
@@ -108,7 +108,7 @@ get_factor()
   return static_cast<Number>(std::complex<float>(1, 1));
 }
 
-// This function assignes data to the elements of the container
+// This function assigns data to the elements of the container
 template <template <class...> class Container, typename Number>
 typename std::enable_if<
   std::is_same<Container<Number>, std::vector<Number>>::value,
index f49d1537fcfa515daceac5b4ebb421f89aadac1c..e42b1dde5681c50956fb7320c7d2b2f795e0828c 100644 (file)
@@ -64,7 +64,7 @@ initialize_container(std::vector<hsize_t> dimensions)
 
 
 
-// This function assignes data to the elements of the container
+// This function assigns data to the elements of the container
 template <template <class...> class Container, typename Number>
 typename std::enable_if<
   std::is_same<Container<Number>, std::vector<Number>>::value,
index a9c7223021892ff7eb0ac38c5840114ccb96600f..ffb741053aad5d230ea799c8dca9058463229eb6 100644 (file)
@@ -64,7 +64,7 @@ initialize_container(std::vector<hsize_t> dimensions)
 
 
 
-// This function assignes data to the elements of the container
+// This function assigns data to the elements of the container
 template <template <class...> class Container, typename Number>
 typename std::enable_if<
   std::is_same<Container<Number>, std::vector<Number>>::value,
index 5516431222687220dc29b07a9100bd8c919f6bbb..a8a58e858c808931a7926a3bff2e091c33d869d7 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// check that we detect creating ArrayView objects wit the wrong memory space.
+// check that we detect creating ArrayView objects with the wrong memory space.
 
 #include <deal.II/base/array_view.h>
 
index 5d53a34f718c7ac6a42baa6f56d66c710c3210aa..54ac8e17c36f5af6da64ffb152550b609ee05bad 100644 (file)
@@ -16,7 +16,7 @@
 
 // read in a Triangulation<2,3> from a mesh file writtent in the UCD format
 
-// the meshe used here were generated by Andrea Mola
+// the meshes used here were generated by Andrea Mola
 
 #include <deal.II/dofs/dof_handler.h>
 
index e960a385679e2c956ffcdd35f7db6c3474f69665..48cc03f133e6e3baaff006592ba565214bcc0aec 100644 (file)
@@ -94,7 +94,7 @@ build_matrix_vector(TrilinosWrappers::BlockSparseMatrix &matrix,
   matrix.reinit(dsp);
   vector.reinit(partitioning);
 
-  // Assemble system: Mass matrix and constrant RHS vector
+  // Assemble system: Mass matrix and constraint RHS vector
   FEValues<dim>      fe_values(fe,
                           quadrature_formula,
                           update_values | update_JxW_values);
index e35c5ec3dbc71b3351423c68d8b798a2faaa19e4..16d95c1b966df3109428961a557af2589df09971 100644 (file)
@@ -137,7 +137,7 @@ build_matrix_vector(TrilinosWrappers::BlockSparseMatrix &matrix,
   matrix.reinit(dsp);
   vector.reinit(locally_owned_partitioning, mpi_communicator);
 
-  // Assemble system: Mass matrix and constrant RHS vector
+  // Assemble system: Mass matrix and constraint RHS vector
   FEValues<dim>      fe_values(fe,
                           quadrature_formula,
                           update_values | update_JxW_values);
index 6d96b0b4af73f5ce888db4998110e98571a04483..1731f8521acd7141c65dce215b2666cd5bf634ee 100644 (file)
@@ -16,7 +16,7 @@
 
 // Test the correct handling of data members within the TensorProductManifold
 // class. The test generates a general hypercube grid and, in an inner scope,
-// attempts to assign a TensorProductManifold to it. The test is succesfull if
+// attempts to assign a TensorProductManifold to it. The test is successful if
 // it terminates without subscriptor errors or memory leaks.
 
 #include <deal.II/grid/grid_generator.h>
index 9551770e3d1fd4e697667cfef7ad9531e6b14e5f..e00386c29db1a59b1c102314ee44d06a9249263c 100644 (file)
@@ -18,7 +18,7 @@
 // We check if active_fe_indices are set correctly
 // before and after coarsening and refinement.
 //
-// We use a parallel::share::Triangulation that allows artifical cells.
+// We use a parallel::share::Triangulation that allows artificial cells.
 //
 // This test is inspired by 'mpi/hp_active_fe_indices_transfer_01.cc'.
 
index 5b07816500be358bad53db4ae9e866a9edc38dc4..7a8a6baa648cd6bd990a979cfd67d22295c897b2 100644 (file)
@@ -79,7 +79,7 @@ test()
                 cell->set_refine_flag();
               }
 
-          // and atleast one cell:
+          // and at least one cell:
           if (!locals)
             {
               for (typename Triangulation<dim>::active_cell_iterator cell =
index 2af76617a163f2584e9755a190f7c2e14987350d..e5b5e22c063c6d5e2e7f2a6a3e755301a59c3528 100644 (file)
@@ -1316,7 +1316,7 @@ namespace Step44
 
         // Here (in a most inefficient way) we check the effect of
         // taking the proposed Newton step, and adjust it using
-        // the line-search algorith.
+        // the line-search algorithm.
 
         // Previous step residual
         BlockVector<double> residual_0 = this->system_rhs;
index 7b48999274d15b1d74fb8238965d5b5272acec39..9c059ee4053c0cedb82d27e9826fe92c7e1e87bf 100644 (file)
@@ -88,7 +88,7 @@ main(int argc, char **argv)
     {
       Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
       {
-        // Standard intialiser...
+        // Standard initialiser...
         PETScWrappers::FullMatrix m(3, 3);
         test(m);
       }
index ee46c716d0a7dd4f42705b4ebd53cc52ae946da0..b9059447e38a25f7e0d26e6612bb3761676d3c2e 100644 (file)
@@ -590,7 +590,7 @@ struct MPILogInitAll
 // By default, all the ranks will try to access the device 0.
 // If we are running with MPI support it is better to address different graphic
 // cards for different processes even if only one node is used. The choice below
-// is based on the MPI proccess id.
+// is based on the MPI process id.
 // MPI needs to be initialized before using this function.
 void
 init_cuda(const bool use_mpi = false)

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.