]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Misc. typos 7221/head
authorluz.paz <luzpaz@users.noreply.github.com>
Fri, 21 Sep 2018 02:04:31 +0000 (22:04 -0400)
committerluz paz <luzpaz@users.noreply.github.com>
Fri, 21 Sep 2018 23:29:26 +0000 (19:29 -0400)
Found via `codespell -q 3 -I ../dealii-word-whitelist.txt --skip="./bundled"` where whitelist consists of:
```
als
ans
buss
commend
ith
elemente
everytime
mapp
methode
nd
numer
perverse
pres
reenable
strat
substract
superceded
ue
uint
```

73 files changed:
doc/news/3.4.0-vs-4.0.0.h
doc/news/8.4.2-vs-8.5.0.h
doc/news/8.5.0-vs-9.0.0.h
examples/step-15/doc/results.dox
examples/step-29/doc/intro.dox
examples/step-29/doc/results.dox
examples/step-37/doc/intro.dox
examples/step-57/doc/gnuplot.gpl
include/deal.II/base/patterns.h
include/deal.II/base/tensor.h
include/deal.II/differentiation/ad/ad_drivers.h
include/deal.II/differentiation/ad/ad_helpers.h
include/deal.II/distributed/solution_transfer.h
include/deal.II/distributed/tria.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_enriched.h
include/deal.II/fe/mapping_manifold.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/chunk_sparsity_pattern.h
include/deal.II/lac/cuda_precondition.h
include/deal.II/lac/cuda_sparse_matrix.h
include/deal.II/lac/dynamic_sparsity_pattern.h
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/sparse_matrix.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/lac/trilinos_epetra_vector.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/matrix_free/mapping_info.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/meshworker/local_results.h
include/deal.II/meshworker/simple.h
include/deal.II/numerics/vector_tools.templates.h
include/deal.II/opencascade/manifold_lib.h
source/base/partitioner.cc
source/base/patterns.cc
source/base/table_handler.cc
source/distributed/tria.cc
source/fe/fe_bdm.cc
source/fe/fe_nedelec_sz.cc
source/grid/tria.cc
source/grid/tria_accessor.cc
source/lac/lapack_full_matrix.cc
source/lac/trilinos_epetra_vector.cc
tests/aniso/solution_transfer.cc
tests/aniso/solution_transfer.output
tests/base/quadrature_point_data_03.cc
tests/bits/solution_transfer.cc
tests/bits/solution_transfer.output
tests/fe/fe_enriched_color_02.cc
tests/fe/fe_enriched_color_03.cc
tests/fe/fe_enriched_color_04.cc
tests/fe/fe_enriched_color_05.cc
tests/fe/fe_enriched_color_06.cc
tests/fe/fe_enriched_color_07.cc
tests/fe/fe_enriched_color_08.cc
tests/fe/fe_values_view_25b_nonsymmetric.cc
tests/integrators/cells_and_faces_01.cc
tests/integrators/functional_01.cc
tests/integrators/mesh_worker_01.cc
tests/integrators/mesh_worker_matrix_01.cc
tests/lac/block_linear_operator_06.cc
tests/lac/utilities_02.cc
tests/mpi/mesh_worker_matrix_01.cc
tests/mpi/parallel_partitioner_08.cc
tests/mpi/tria_01.cc
tests/mpi/tria_01.mpirun=10.output
tests/mpi/tria_01.mpirun=2.output
tests/mpi/tria_01.mpirun=4.output
tests/numerics/history.cc
tests/petsc_complex/assemble_01.cc
tests/tensors/tensor_09.cc

index 74e1a82c376a66be886230d795843cb279def03c..ce73c93c87cd1659563479a0ae5a85574ac5eb1c 100644 (file)
@@ -538,7 +538,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
        did not have the respective POSIX functions. This restriction is lifted
        for the special case that you give one as the number of parties that
        will be waiting for the barrier: in this case, a barrier is a
-       no-operation, so we do not need assistence from the operating
+       no-operation, so we do not need assistance from the operating
        system. This change makes it slightly simpler to write programs in a way
        such that they run in both single- and multithreaded environments.
        <br>
index 9f28859de1b954acf0ebeb7427c1132d3b62e782..c76c3907a7bc5328184a1ddf27f56c45cb811f5f 100644 (file)
@@ -2039,7 +2039,7 @@ inconvenience this causes.
 
  <li>
   New: Add NURBSPatchManifold. This class is a child of ChartManifold and
-  implements a manifold descriptor for the face of a CAD imported usign
+  implements a manifold descriptor for the face of a CAD imported using
   OpenCASCADE.
   <br>
   (Mauro Bardelloni, 2016/03/09)
index e0d52102c4124ccf027c8f25e8dcdb3f15616263..4dd4c6f316497d2f8984c402f311e5e847f4504c 100644 (file)
@@ -700,7 +700,7 @@ inconvenience this causes.
 
  <li>
   New: The tutorial step-59 shows a matrix-free solver for the Poisson
-  equation discretized with the symmetric interior penalty discontinous
+  equation discretized with the symmetric interior penalty discontinuous
   Galerkin method.
   <br>
   (Katharina Kormann, Martin Kronbichler, 2018/05/04)
@@ -1194,7 +1194,7 @@ inconvenience this causes.
 
  <li>
   New: Extend GridGenerator::extrude_triangulation to using exact slicing z-axis
-  values and reimplement the exsiting GridGenerator::extrude_triangulation using
+  values and reimplement the existing GridGenerator::extrude_triangulation using
   the newly developed overload.
   <br>
   (Weixiong Zheng, 2018/04/05)
index c06996663116e765b96378a2a1b4c57d395ebe1a..3fefe249fee6fcee62b1cc8e6debeb21413a872f 100644 (file)
@@ -35,19 +35,19 @@ solution. This yields the following set of images:
 <div class="twocolumn" style="width: 80%">
   <div>
     <img src="https://www.dealii.org/images/steps/developer/step_15_solution_1.png"
-         alt="Solution after zero cycles with countour lines." width="230" height="273">
+         alt="Solution after zero cycles with contour lines." width="230" height="273">
   </div>
   <div>
     <img src="https://www.dealii.org/images/steps/developer/step_15_solution_2.png"
-         alt="Solution after one cycle with countour lines." width="230" height="273">
+         alt="Solution after one cycle with contour lines." width="230" height="273">
   </div>
   <div>
     <img src="https://www.dealii.org/images/steps/developer/step_15_solution_3.png"
-         alt="Solution after two cycles with countour lines." width="230" height="273">
+         alt="Solution after two cycles with contour lines." width="230" height="273">
   </div>
   <div>
     <img src="https://www.dealii.org/images/steps/developer/step_15_solution_4.png"
-         alt="Solution after three cycles with countour lines." width="230" height="273">
+         alt="Solution after three cycles with contour lines." width="230" height="273">
   </div>
 </div>
 
index 32c62b84e3e9f53714638587394bef7efa77bd19..452a8c20d30caad3189f3ec4ce8ba72b567344da 100644 (file)
@@ -180,7 +180,7 @@ of the circle with center at $(0.5, d)$ and a
 radius slightly greater than $d$; this shape should lead to a focusing of the sound
 wave at the center of the circle. Varying $d$ changes the "focus" of the lens
 and affects the spatial distribution of the intensity of $u$, where our main
-concern is how well $|u|=\sqrt{v^2+w^2}$ is focussed. 
+concern is how well $|u|=\sqrt{v^2+w^2}$ is focused. 
 
 In the program below, we will implement the complex-valued Helmholtz equations
 using the formulation with split real and imaginary parts. We will also
index 04a039f10e8b4ef8ccbaed9f05204f20f35700c8..f463c8e8b912a781a9a7d17f41642c870889ebc5 100644 (file)
@@ -94,7 +94,7 @@ The graphical output of the program looks as follows:
 
 The first two pictures show the real and imaginary parts of
 $u$, whereas the last shows the intensity $|u|$. One can clearly
-see that the intensity is focussed around the focal point of the
+see that the intensity is focused around the focal point of the
 lens (0.5, 0.3), and that the focus
 is rather sharp in $x$-direction but more blurred in $y$-direction, which is a
 consequence of the geometry of the focusing lens, its finite aperture,
index ad5fb814547e63c2868aa13b7a583c55f9457bb7..929d817da5a3f9435f78b2618f41eefa56c35396 100644 (file)
@@ -428,7 +428,7 @@ their implementation requires knowledge of the elements of the system matrix.
 One solution is to use geometric multigrid methods as shown in step-16. They
 are known to be very fast, and they are suitable for our purpose since all
 ingredients, including the transfer between different grid levels, can be
-expressed in terms of matrix-vector products related to a colletion of
+expressed in terms of matrix-vector products related to a collection of
 cells. All one needs to do is to find a smoother that is based on
 matrix-vector products rather than all the matrix entries. One such candidate
 would be a damped Jacobi iteration that requires access to the matrix
@@ -544,7 +544,7 @@ MPI metadata for DoFs that are owned locally but needed by other
 processors. A benefit of the design of this vector class is the way ghosted
 entries are accessed. In the storage scheme of the vector, the data array
 extends beyond the processor-local part of the solution with further vector
-entries available for the ghosted degrees of freedom. This gives a continguous
+entries available for the ghosted degrees of freedom. This gives a contiguous
 index range for all locally active degrees of freedom. (Note that the index
 range depends on the exact configuration of the mesh.) Since matrix-free
 operations can be thought of doing linear algebra that is performance
index f41fd83c04bfe4b06ddae9b6b24ebdf8003140c6..ded394cc71ca41e08380e487ca092ed1e7322ec4 100644 (file)
@@ -25,7 +25,7 @@ set style line  11 lt 1 lc rgb '#d00000' # dark red
 
 
 set output "step-57.compare-Re400.svg"
-set xlabel "horizonal velocity"
+set xlabel "horizontal velocity"
 set ylabel "y coordinate"
 set xrange [-0.5: 1.0]
 set title "horizontal velocity at x=0.5, Re=400"
@@ -37,7 +37,7 @@ plot "400-line-4.txt" using 2:1 w l title "Numerical Solution", \
 
 
 set output "step-57.compare-Re7500.svg"
-set xlabel "horizonal velocity"
+set xlabel "horizontal velocity"
 set ylabel "y coordinate"
 set xrange [-0.5: 1.0]
 set title "horizontal velocity at x=0.5, Re=7500"
@@ -49,7 +49,7 @@ plot "7500-line-4.txt" using 2:1 w l title "Numerical Solution", \
 
 
 set output "step-57.converge-Re7500.svg"
-set xlabel "horizonal velocity"
+set xlabel "horizontal velocity"
 set ylabel "y coordinate"
 set xrange [-0.5: 1.0]
 set title "horizontal velocity at x=0.5, Re=7500"
index 3b30fcfa3bb3662be9967a1c7b1749aee60d5537..f5b300a8b0a08603730ed68751752e1ed6a93242 100644 (file)
@@ -1388,7 +1388,7 @@ namespace Patterns
      * container type.
      *
      * Notice that the current content of variable @p t is ignored. Its type is
-     * used to infer how to interpret the string. If the string is succesfully
+     * used to infer how to interpret the string. If the string is successfully
      * parsed, then @p t will be set to the parsed content of @p s.
      *
      * @author Luca Heltai, 2018
@@ -1853,7 +1853,7 @@ namespace Patterns
         auto p = dynamic_cast<const Patterns::Map *>(pattern.get());
         AssertThrow(p,
                     ExcMessage("I need a Map pattern to convert a string to "
-                               "a Map compatbile type."));
+                               "a Map compatible type."));
         auto                     key_p = p->get_key_pattern().clone();
         auto                     val_p = p->get_value_pattern().clone();
         std::vector<std::string> vec(t.size());
@@ -1932,7 +1932,7 @@ namespace Patterns
         auto p = dynamic_cast<const Patterns::List *>(pattern.get());
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
-                               "to a List compatbile type."));
+                               "to a List compatible type."));
         auto                     base_p = p->get_base_pattern().clone();
         std::vector<std::string> vec(dim);
 
@@ -1959,7 +1959,7 @@ namespace Patterns
         auto p = dynamic_cast<const Patterns::List *>(pattern.get());
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
-                               "to a List compatbile type."));
+                               "to a List compatible type."));
 
         auto base_p = p->get_base_pattern().clone();
         T    t;
@@ -2031,7 +2031,7 @@ namespace Patterns
         auto p = dynamic_cast<const Patterns::List *>(pattern.get());
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
-                               "to a List compatbile type."));
+                               "to a List compatible type."));
 
         const auto &expressions = t->get_expressions();
         if (expressions.size() == 0)
@@ -2055,7 +2055,7 @@ namespace Patterns
         auto p = dynamic_cast<const Patterns::List *>(pattern.get());
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
-                               "to a List compatbile type."));
+                               "to a List compatible type."));
 
         const auto expressions =
           Utilities::split_string_list(s, p->get_separator());
@@ -2130,7 +2130,7 @@ namespace Patterns
         auto p = dynamic_cast<const Patterns::List *>(pattern.get());
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
-                               "to a List compatbile type."));
+                               "to a List compatible type."));
 
         auto        base_p = p->get_base_pattern().clone();
         std::string s =
@@ -2155,7 +2155,7 @@ namespace Patterns
         auto p = dynamic_cast<const Patterns::List *>(pattern.get());
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
-                               "to a List compatbile type."));
+                               "to a List compatible type."));
 
         auto base_p = p->get_base_pattern().clone();
 
index 90f3f20b8d3dd13bd5b1bb7cfc4e49a2122f7489..2aabb6402e9c59af8d40dd709a9e9428b2df0848 100644 (file)
@@ -1909,7 +1909,7 @@ inline
     reord_2 = TensorAccessors::reordered_index_view<index_2, rank_2>(src2);
 
   // Now, reorder index_3 to the end of src1. We have to make sure to
-  // preserve the orginial ordering: index_1 has been removed. If
+  // preserve the original ordering: index_1 has been removed. If
   // index_3 > index_1, we have to use (index_3 - 1) instead:
   ReorderedIndexView<
     (index_3 < index_1 ? index_3 : index_3 - 1),
@@ -1921,7 +1921,7 @@ inline
     rank_1 > (reord_1);
 
   // Now, reorder index_4 to the end of src2. We have to make sure to
-  // preserve the orginial ordering: index_2 has been removed. If
+  // preserve the original ordering: index_2 has been removed. If
   // index_4 > index_2, we have to use (index_4 - 1) instead:
   ReorderedIndexView<
     (index_4 < index_2 ? index_4 : index_4 - 1),
index fa32e3eb68d503d1dc29e9ccd1f6f66a78e2b334..cef0c87d6515fbfaa4b1cfacddb8c127b4f20613 100644 (file)
@@ -312,7 +312,7 @@ namespace Differentiation
       /**
        * Computes the Jacobian of the vector field.
        *
-       * The Jacobian of a vector field is in essense the gradient of each
+       * The Jacobian of a vector field is in essence the gradient of each
        * dependent variable with respect to all independent variables.
        * This operation is therefore analogous to the gradient() operation
        * performed on a collection of scalar valued fields.
@@ -464,7 +464,7 @@ namespace Differentiation
       /**
        * Computes the Jacobian of the vector field.
        *
-       * The Jacobian of a vector field is in essense the gradient of each
+       * The Jacobian of a vector field is in essence the gradient of each
        * dependent variable with respect to all independent variables.
        * This operation is therefore analogous to the gradient() operation
        * performed on a collection of scalar valued fields.
@@ -687,7 +687,7 @@ namespace Differentiation
           << counts[15] << "\n"
           << "Number of 'abs' calls that can switch branch: " << counts[16]
           << "\n"
-          << "Number of parameters (doubles) interchangable without retaping: "
+          << "Number of parameters (doubles) interchangeable without retaping: "
           << counts[17] << "\n"
           << std::flush;
       }
@@ -1262,7 +1262,7 @@ namespace Differentiation
           }
 #    else
         // If ADOL-C is not configured with tapeless number reference counting
-        // then there is no way that we can guarentee that the following call
+        // then there is no way that we can guarantee that the following call
         // is safe. No comment... :-/
         adtl::setNumDir(n_directional_derivatives);
 #    endif
index b6fa81fd4207f3f111fee7e843762fa8f94f16d6..ae923e2113e3ad98d0ab6c629af4c2349ce94af9 100644 (file)
@@ -231,7 +231,7 @@ namespace Differentiation
       n_dependent_variables() const;
 
       /**
-       * Prints the status of all queriable data. Exactly what is printed and
+       * Prints 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 925769dcaee15df57b19478e8d9d2dd43f6a6f86..9df10505ebb945007f1fbae9a21c6f092fb5fdfa 100644 (file)
@@ -156,7 +156,7 @@ namespace parallel
      * class, the following requirements have to be met:
      * <ul>
      *   <li>
-     *     The hp::DoFHandler needs to be explicitely mentioned
+     *     The hp::DoFHandler needs to be explicitly mentioned
      *     in the parallel::distributed::SolutionTransfer type, i.e.:
      *     @code
      *     parallel::distributed::SolutionsTransfer<dim, VectorType,
index 1f09092bf257e4966d41c0e4694a09f2fee98b0e..2c0888764fd7203e428d723109ae8c37503afc61 100644 (file)
@@ -692,7 +692,7 @@ namespace parallel
        * first child is marked with `CELL_REFINE`, whereas the others will be
        * marked with `CELL_INVALID`, which indicates that these cells will be
        * ignored by default during the packing or unpacking process. This
-       * ensures that data is only transfered once onto or from the parent
+       * ensures that data is only transferred once onto or from the parent
        * cell. If the callback is called with `CELL_REFINE`, the callback
        * will want to pack up the data on this cell into an array and store
        * it at the provided address for later unpacking in a way so that
index 1e3296806bf46e0fc86dba94d37d610081eab531..bcb5fda482a2ec3c881ded96d6d88e0ded180db3 100644 (file)
@@ -1387,7 +1387,7 @@ public:
    *  This is because these member variables may be initialized only
    *  on demand by derived classes, rather than being available immediately.
    *  Consequently, comparing these members would not only be costly because
-   *  these are generall big arrays, but also because their computation may
+   *  these are generally big arrays, but also because their computation may
    *  be expensive. On the other hand, derived classes for which these
    *  arrays may differ for two objects even though the above list compares
    *  as equal, will probably want to implement their own operator==()
index 012a35b8ebadfaadc95e839ef24867dd6e1b37c3..b123f9772df8fbc9742b82ece59674d52dec3454 100644 (file)
@@ -1025,7 +1025,7 @@ namespace ColorEnriched
    * img[src="3source_fe_indices.png"]{width:25%;}</style> \endhtmlonly
    * @image html 3source_fe_indices.png "Active FE indices"
    *
-   * As discussed before, the colors of predicates are alloted using
+   * As discussed before, the colors of predicates are allotted using
    * the graph coloring algorithm. Each predicate is a node in the graph and if
    * two sub-domains share an interface, the corresponding predicates
    * should be given different colors.
index abb93d25246a039dd7b209198fa45ad237c69eed..0ceee849bace52592e0c2c6eecaad39452b19f9b 100644 (file)
@@ -46,7 +46,7 @@ class MappingQ;
  * Quadrature points computed using this mapping lie on the exact
  * geometrical objects, and tangent and normal vectors computed using
  * this class are tangent and normal to the underlying geometry. This
- * is in constrast with the MappingQ class, which approximates the
+ * is in contrast with the MappingQ class, which approximates the
  * geometry using a polynomial of some order, and then computes the
  * normals and tangents using the approximated surface.
  *
index 0121c4cfd93ded81ce6729ba1d4bfe503c01ddf5..ad5c3c08f9f88896434ceb70efdf0414e85a6ed5 100644 (file)
@@ -1185,7 +1185,7 @@ public:
    *
    * Note that if the given row is empty, i.e. does not contain any nonzero
    * entries, then the iterator returned by this function equals
-   * <tt>end(r)</tt>. Note also that the iterator may not be dereferencable in
+   * <tt>end(r)</tt>. Note also that the iterator may not be dereferenceable in
    * that case.
    *
    * Note that due to the layout in ChunkSparseMatrix, iterating over matrix
@@ -1201,7 +1201,7 @@ public:
    * end of line @p r, or past the end of the entire sparsity pattern. This is
    * the version for constant matrices.
    *
-   * Note that the end iterator is not necessarily dereferencable. This is in
+   * Note that the end iterator is not necessarily dereferenceable. This is in
    * particular the case if it is the end iterator for the last row of a
    * matrix.
    *
@@ -1219,7 +1219,7 @@ public:
    *
    * Note that if the given row is empty, i.e. does not contain any nonzero
    * entries, then the iterator returned by this function equals
-   * <tt>end(r)</tt>. Note also that the iterator may not be dereferencable in
+   * <tt>end(r)</tt>. Note also that the iterator may not be dereferenceable in
    * that case.
    *
    * Note that due to the layout in ChunkSparseMatrix, iterating over matrix
@@ -1235,7 +1235,7 @@ public:
    * end of line @p r, or past the end of the entire sparsity pattern. This is
    * the version for non-constant matrices.
    *
-   * Note that the end iterator is not necessarily dereferencable. This is in
+   * Note that the end iterator is not necessarily dereferenceable. This is in
    * particular the case if it is the end iterator for the last row of a
    * matrix.
    *
index a10034c8dac8e8ea3edc3c0f8edb9a295d145125..381ade01f39e05ef808e6eb66dd727ed8d7d907c 100644 (file)
@@ -669,7 +669,7 @@ public:
    *
    * Note that if the given row is empty, i.e. does not contain any nonzero
    * entries, then the iterator returned by this function equals
-   * <tt>end(r)</tt>. Note also that the iterator may not be dereferencable in
+   * <tt>end(r)</tt>. Note also that the iterator may not be dereferenceable in
    * that case.
    */
   iterator
@@ -679,7 +679,7 @@ public:
    * Final iterator of row <tt>r</tt>. It points to the first element past the
    * end of line @p r, or past the end of the entire sparsity pattern.
    *
-   * Note that the end iterator is not necessarily dereferencable. This is in
+   * Note that the end iterator is not necessarily dereferenceable. This is in
    * particular the case if it is the end iterator for the last row of a
    * matrix.
    */
index ea3fc7c88f02926470a29e8d78be98435428d73c..3854535270df145b9e71d3755821a47e3ddef4f3 100644 (file)
@@ -81,7 +81,7 @@ namespace CUDAWrappers
       AdditionalData(bool use_level_analysis = true);
 
       /**
-       * Flag that determines if level informations are used when creating and
+       * Flag that determines if level information is used when creating and
        * applying the preconditioner. See the documentation for
        * cusparseSolvePolicy_t at
        * https://docs.nvidia.com/cuda/cusparse/index.html#cusparsesolvepolicy_t
@@ -296,7 +296,7 @@ namespace CUDAWrappers
       AdditionalData(bool use_level_analysis = true);
 
       /**
-       * Flag that determines if level informations are used when creating and
+       * Flag that determines if level information is used when creating and
        * applying the preconditioner. See the documentation for
        * cusparseSolvePolicy_t at
        * https://docs.nvidia.com/cuda/cusparse/index.html#cusparsesolvepolicy_t
index d80210ec81068fbfd0534a17550c93f836330910..da24c0f31b65b66bfe823a0576d735dce9039a25 100644 (file)
@@ -207,7 +207,7 @@ namespace CUDAWrappers
     operator*=(const Number factor);
 
     /**
-     * Divide the entrie matrix by a fixed factor.
+     * Divide the entire matrix by a fixed factor.
      */
     SparseMatrix &
     operator/=(const Number factor);
index b7496bfb0fb14625659b5303aedb257ad3083979..e188579eac3a35cf0323bc56b3601959f5549e6a 100644 (file)
@@ -529,7 +529,7 @@ public:
    *
    * Note that if the given row is empty, i.e. does not contain any nonzero
    * entries, then the iterator returned by this function equals
-   * <tt>end(r)</tt>. Note also that the iterator may not be dereferencable in
+   * <tt>end(r)</tt>. Note also that the iterator may not be dereferenceable in
    * that case.
    *
    * Note also the discussion in the general documentation of this class about
@@ -547,7 +547,7 @@ public:
    * Final iterator of row <tt>r</tt>. It points to the first element past the
    * end of line @p r, or past the end of the entire sparsity pattern.
    *
-   * Note that the end iterator is not necessarily dereferencable. This is in
+   * Note that the end iterator is not necessarily dereferenceable. This is in
    * particular the case if it is the end iterator for the last row of a
    * matrix.
    */
index 91b3f8a77def76c61ea1b6cc375e8feeb309c319..33df20f368cb9947f0b39590dc05a0b993b51d88 100644 (file)
@@ -855,7 +855,7 @@ namespace PETScWrappers
      *
      * Note that if the given row is empty, i.e. does not contain any nonzero
      * entries, then the iterator returned by this function equals
-     * <tt>end(r)</tt>. Note also that the iterator may not be dereferencable
+     * <tt>end(r)</tt>. Note also that the iterator may not be dereferenceable
      * in that case.
      */
     const_iterator
@@ -865,7 +865,7 @@ namespace PETScWrappers
      * Final iterator of row <tt>r</tt>. It points to the first element past
      * the end of line @p r, or past the end of the entire sparsity pattern.
      *
-     * Note that the end iterator is not necessarily dereferencable. This is
+     * Note that the end iterator is not necessarily dereferenceable. This is
      * in particular the case if it is the end iterator for the last row of a
      * matrix.
      */
index 325886ece5b275f56f3e5d5758441e5b29dd8602..ec2731eee38457a89e342ed5702182e808b86d54 100644 (file)
@@ -1488,7 +1488,7 @@ public:
    *
    * Note that if the given row is empty, i.e. does not contain any nonzero
    * entries, then the iterator returned by this function equals
-   * <tt>end(r)</tt>. The returned iterator may not be dereferencable in that
+   * <tt>end(r)</tt>. The returned iterator may not be dereferenceable in that
    * case if neither row @p r nor any of the following rows contain any
    * nonzero entries.
    */
@@ -1506,7 +1506,7 @@ public:
    * or past the end of the entire sparsity pattern if none of the rows after
    * @p r contain any entries at all.
    *
-   * Note that the end iterator is not necessarily dereferencable. This is in
+   * Note that the end iterator is not necessarily dereferenceable. This is in
    * particular the case if it is the end iterator for the last row of a
    * matrix.
    */
index 16a9661182416533c183752b5c7b618d0f2a352a..37a1be647bb282d413b2526b126b3d07219c64bd 100644 (file)
@@ -704,7 +704,7 @@ public:
    *
    * Note that if the given row is empty, i.e. does not contain any nonzero
    * entries, then the iterator returned by this function equals
-   * <tt>end(r)</tt>. Note also that the iterator may not be dereferencable in
+   * <tt>end(r)</tt>. Note also that the iterator may not be dereferenceable in
    * that case.
    *
    * Note also the discussion in the general documentation of this class about
@@ -717,7 +717,7 @@ public:
    * Final iterator of row <tt>r</tt>. It points to the first element past the
    * end of line @p r, or past the end of the entire sparsity pattern.
    *
-   * Note that the end iterator is not necessarily dereferencable. This is in
+   * Note that the end iterator is not necessarily dereferenceable. This is in
    * particular the case if it is the end iterator for the last row of a
    * matrix.
    */
index 6b27b21354df6d4e94a7010df5b96f0051881f55..b11b63ca616d595826db868c152bf0134f20f14a 100644 (file)
@@ -313,7 +313,7 @@ namespace LinearAlgebra
       trilinos_vector() const;
 
       /**
-       * Return a (modifyable) reference to the underlying Trilinos
+       * Return a (modifiable) reference to the underlying Trilinos
        * Epetra_FEVector class.
        */
       Epetra_FEVector &
index 28a642977215a77d14c9b3cd2322689e8d2d965b..ed9f193523f50efb1c6abe60e9d2eea6c4c1f4dc 100644 (file)
@@ -1905,7 +1905,7 @@ namespace TrilinosWrappers
      *
      * Note that if the given row is empty, i.e. does not contain any nonzero
      * entries, then the iterator returned by this function equals
-     * <tt>end(r)</tt>. The returned iterator may not be dereferencable in
+     * <tt>end(r)</tt>. The returned iterator may not be dereferenceable in
      * that case if neither row @p r nor any of the following rows contain any
      * nonzero entries.
      *
@@ -1942,7 +1942,7 @@ namespace TrilinosWrappers
      * or past the end of the entire sparsity pattern if none of the rows
      * after @p r contain any entries at all.
      *
-     * Note that the end iterator is not necessarily dereferencable. This is
+     * Note that the end iterator is not necessarily dereferenceable. This is
      * in particular the case if it is the end iterator for the last row of a
      * matrix.
      */
index b93709d4e33196782873f29b7cf184e5a9654a41..76bf07e5589f202964cc6f18a6bd2234d96bd7c5 100644 (file)
@@ -702,7 +702,7 @@ namespace TrilinosWrappers
      * not safe whenever MPI is used. For these settings, the current method
      * is the one to choose: It will store the off-processor data as an
      * additional sparsity pattern (that is then passed to the Trilinos matrix
-     * via the reinit mehtod) which can be organized in such a way that
+     * via the reinit method) which can be organized in such a way that
      * thread-safety can be ensured (as long as the user makes sure to never
      * write into the same matrix row simultaneously, of course).
      */
@@ -1100,7 +1100,7 @@ namespace TrilinosWrappers
      *
      * Note that if the given row is empty, i.e. does not contain any nonzero
      * entries, then the iterator returned by this function equals
-     * <tt>end(r)</tt>. Note also that the iterator may not be dereferencable
+     * <tt>end(r)</tt>. Note also that the iterator may not be dereferenceable
      * in that case.
      */
     const_iterator
@@ -1110,7 +1110,7 @@ namespace TrilinosWrappers
      * Final iterator of row <tt>r</tt>. It points to the first element past
      * the end of line @p r, or past the end of the entire sparsity pattern.
      *
-     * Note that the end iterator is not necessarily dereferencable. This is
+     * Note that the end iterator is not necessarily dereferenceable. This is
      * in particular the case if it is the end iterator for the last row of a
      * matrix.
      */
index 29a95558294d46335d518102c0d5c71b7232f61f..5443954e0a14d4eeebb0926042cedf4bb2b9e249 100644 (file)
@@ -1192,7 +1192,7 @@ namespace TrilinosWrappers
       trilinos_vector() const;
 
       /**
-       * Return a (modifyable) reference to the underlying Trilinos
+       * Return a (modifiable) reference to the underlying Trilinos
        * Epetra_FEVector class.
        */
       Epetra_FEVector &
index d9eb4ce39eddef0a4df0cb85ad2491dcdee2b3eb..f7fda0ce3d43ad54f147fd6a9390605c77d1dcaa 100644 (file)
@@ -176,7 +176,7 @@ namespace internal
        * Stores the index offset into the arrays @p jxw_values, @p jacobians,
        * @p normal_vectors and the second derivatives. Note that affine cells
        * have shorter fields of length 1, where the others have lengths equal
-       * to the numer of quadrature points of the given cell.
+       * to the number of quadrature points of the given cell.
        */
       AlignedVector<unsigned int> data_index_offsets;
 
index 0821cb4d22c3044563eeb05fd9cec983f526ad3d..d38ed5055f0072f64f0c2510d42b1def66bfb2d0 100644 (file)
@@ -3202,8 +3202,8 @@ namespace internal
 
 
   // A helper function to identify block vectors with many components where we
-  // should not try to overlap computations and communcation because there
-  // would be too many outstanding communcation requests. This is the base case
+  // should not try to overlap computations and communication because there
+  // would be too many outstanding communication requests. This is the base case
   // for generic vectors
   template <typename VectorStruct>
   constexpr unsigned int
index fc07001e7f423295c5d9cfd397895e597bc11088..0a0a74562ab87f6a7b19bef0816e4a667b263fca 100644 (file)
@@ -182,9 +182,9 @@ namespace MeshWorker
    * integration. Depending on the task the mesh worker loop is performing,
    * local results can be of different types. They have in common that they
    * are the result of local integration over a cell or face. Their actual
-   * type is determined by the Assember using them. It is also the assembler
+   * type is determined by the Assembler using them. It is also the assembler
    * setting the arrays of local results to the sizes needed. Here is a list
-   * of the provided data types and the assembers using them:
+   * of the provided data types and the assemblers using them:
    *
    * <ol>
    * <li> n_values() numbers accessed with value(), and stored in the data
@@ -214,7 +214,7 @@ namespace MeshWorker
     /**
      * The number of scalar values.
      *
-     * This number is set to a nonzero value by Assember::CellsAndFaces
+     * This number is set to a nonzero value by Assembler::CellsAndFaces
      *
      */
     unsigned int
@@ -223,8 +223,8 @@ namespace MeshWorker
     /**
      * The number of vectors.
      *
-     * This number is set to a nonzero value by Assember::ResidualSimple and
-     * Assember::ResidualLocalBlocksToGlobalBlocks.
+     * This number is set to a nonzero value by Assembler::ResidualSimple and
+     * Assembler::ResidualLocalBlocksToGlobalBlocks.
      */
     unsigned int
     n_vectors() const;
index c5577336597e2ade9057545576e73e66ad47cf18..3a91188ab217bbc176c1d417edfe5b9febdb9e37 100644 (file)
@@ -30,9 +30,9 @@
 #include <deal.II/multigrid/mg_constrained_dofs.h>
 
 /*
- * The header containing the classes MeshWorker::Assember::MatrixSimple,
- * MeshWorker::Assember::MGMatrixSimple, MeshWorker::Assember::ResidualSimple,
- * and MeshWorker::Assember::SystemSimple.
+ * The header containing the classes MeshWorker::Assembler::MatrixSimple,
+ * MeshWorker::Assembler::MGMatrixSimple, MeshWorker::Assembler::ResidualSimple,
+ * and MeshWorker::Assembler::SystemSimple.
  */
 
 DEAL_II_NAMESPACE_OPEN
index 2a06dd02d0b123e0b0b29e45a2b8ea185ab26289..1058b8687506b8e34002207f388d71625e310c86 100644 (file)
@@ -5483,7 +5483,7 @@ namespace VectorTools
              tol);
           tangential /= tangential.norm();
 
-          // Compute the entires of the linear system
+          // Compute the entries of the linear system
           // Note the system is symmetric so we could only compute the
           // lower/upper triangle.
           //
@@ -5680,7 +5680,7 @@ namespace VectorTools
                    q_point < fe_face_values.n_quadrature_points;
                    ++q_point)
                 {
-                  // Compute the entires of the linear system
+                  // Compute the entries of the linear system
                   // Note the system is symmetric so we could only compute the
                   // lower/upper triangle.
                   //
index 30f63fe8367ecff7576a798ace3f1e40834622c7..0a7c3cc0d465ceb5189892600873bc2dbe07adf1 100644 (file)
@@ -348,7 +348,7 @@ namespace OpenCASCADE
   };
 
   /**
-   * Manifold description for the face of a CAD imported usign OpenCASCADE.
+   * Manifold description for the face of a CAD imported using OpenCASCADE.
    *
    * @ingroup manifold
    *
index 72dfaec531fd503ea242787f338526b145e294db..75a45a9df7f20a323674ed22292ba844733d6527 100644 (file)
@@ -313,7 +313,7 @@ namespace Utilities
         import_targets_data = import_targets_temp;
       }
 
-      // now that we know how many indices each process will recieve from
+      // now that we know how many indices each process will receive from
       // ghosts, send and receive indices for import data. non-blocking receives
       // and blocking sends
       std::vector<types::global_dof_index> expanded_import_indices(
index 4e883abea17adf7c229c3413d4628776e0a52f5c..b1f6835254f284d88ce2f6017233c5cccfd1b80b 100644 (file)
@@ -871,7 +871,7 @@ namespace Patterns
         std::vector<std::string> pair =
           Utilities::split_string_list(key_value_pair, key_value_separator);
 
-        // Check that we have in fact two mathces
+        // Check that we have in fact two matches
         if (pair.size() != 2)
           return false;
 
index 9b8110df98ed8a773afddd9a276ee2bc585bd1b4..58c37007c9bf41b777be5e72a7a08c483d457cf8 100644 (file)
@@ -812,7 +812,7 @@ TableHandler::get_selected_columns(std::vector<std::string> &sel_columns) const
 void
 TableHandler::clear_current_row()
 {
-  // Figure out what is the currect (max) length of the columns
+  // Figure out what is the correct (max) length of the columns
   // so that we "shave" one off.
   std::vector<internal::TableEntry>::size_type n = 0;
   for (std::map<std::string, Column>::iterator p = columns.begin();
index cacfb34fc4e14377625ebaa8911ed76de77eb842..f5dfbd5a691ad624a4fab236945d6fb409b40078 100644 (file)
@@ -3800,7 +3800,7 @@ namespace parallel
       // finally, after syncing the parallel_forest with the triangulation,
       // also update the quadrant_cell_relations, which will be used for
       // repartitioning, further refinement/coarsening, and unpacking
-      // of stored or transfered data.
+      // of stored or transferred data.
       update_quadrant_cell_relations();
     }
 
index b6cef0280c60f65e41195af3e38cb3a16c754141..5f06335fa2baab486f2207e760d4a79abd53d90b 100644 (file)
@@ -274,7 +274,7 @@ namespace internal
     {
       // This function sets up the values of the polynomials we want to
       // take moments with in the quadrature points. In fact, we multiply
-      // thos by the weights, such that the sum of function values and
+      // those by the weights, such that the sum of function values and
       // test_values over quadrature points yields the interpolated degree
       // of freedom.
       template <int dim>
index daae79ef21eb68715b7c9afb6e52773dfe409934..dce21dcebef911e1ae5b3e35049cc2679152cfc8 100644 (file)
@@ -213,7 +213,7 @@ FE_NedelecSZ<dim, spacedim>::get_data(
                 }
             }
 
-          // Calulate the gradient of sigma_imj_values[q][i][j] =
+          // Calculate the gradient of sigma_imj_values[q][i][j] =
           // sigma[q][i]-sigma[q][j]
           //   - this depends on the component and the direction of the
           //   corresponding edge.
index 5f98cf9d3fd7a30d2c58d61814d146df97451969..f0e6233c325a273dff20e8449cfe218dd137b08f 100644 (file)
@@ -3713,7 +3713,7 @@ namespace internal
         // lines and vertices. Now we have to
         // consider outer ones as well. here, we have
         // to check, whether there are other cells
-        // still needing these objects. oherwise we
+        // still needing these objects. otherwise we
         // can delete them. first for quads (and
         // their inner lines).
 
index 5e58dc5ac691d1fb433909bd60403dafd4e87b71..c6fb426ab2f8dbce0ab30f5fed4914dc7450878b 100644 (file)
@@ -2517,7 +2517,7 @@ CellAccessor<dim, spacedim>::has_periodic_neighbor(
    * in two iteration cycles through the map. First, existence check, then
    * returning the value.
    *
-   * 2- Using std::map::find(): This option is less readble, but theoretically
+   * 2- Using std::map::find(): This option is less readable, but theoretically
    *    faster, because it results in one iteration through std::map object.
    *
    * We decided to use the 2nd option.
index 933aef006bf796c02452068fb8610f762cb95f56..a516bddb57763b1138a29cc34d24a3d6a5713e0c 100644 (file)
@@ -991,7 +991,7 @@ LAPACKFullMatrix<number>::Tmmult(LAPACKFullMatrix<number> &      C,
   const types::blas_int nn = B.n();
   const types::blas_int kk = B.m();
 
-  // lapack does not have any tripple product routines, including the case of
+  // lapack does not have any triple product routines, including the case of
   // diagonal matrix in the middle, see
   // https://stackoverflow.com/questions/3548069/multiplying-three-matrices-in-blas-with-the-middle-one-being-diagonal
   // http://mathforum.org/kb/message.jspa?messageID=3546564
index 36d38cf164c07904d73f1928b87a849d84d6ad51..202fa08f687ffdddadfbc839a4ec66fc20bae7c2 100644 (file)
@@ -150,7 +150,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 c2b36e1847bd7459defc748604689a402c1fde69..ed5366bce9bd849251f0b6974e01d6735884085c 100644 (file)
@@ -106,7 +106,7 @@ transfer(std::ostream &out)
   data_out.clear_data_vectors();
   data_out.add_data_vector(solution, "solution");
   data_out.build_patches();
-  deallog << "Interpolated/tranferred solution after pure refinement"
+  deallog << "Interpolated/transferred solution after pure refinement"
           << std::endl
           << std::endl;
   data_out.write_gnuplot(out);
@@ -128,7 +128,7 @@ transfer(std::ostream &out)
   data_out.clear_data_vectors();
   data_out.add_data_vector(solution, "solution");
   data_out.build_patches();
-  deallog << "Interpolated/tranferred solution after coarsening" << std::endl
+  deallog << "Interpolated/transferred solution after coarsening" << std::endl
           << std::endl;
   data_out.write_gnuplot(out);
 }
index 502ed4c500e19339a7ec256d095c44568d06c452..2b774861ade9ae52973635d9bcf9261db12ad533 100644 (file)
@@ -456,7 +456,7 @@ DEAL::
 1.000 1.000 0.4947 
 
 
-DEAL::Interpolated/tranferred solution after pure refinement
+DEAL::Interpolated/transferred solution after pure refinement
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -1361,7 +1361,7 @@ DEAL::
 1.000 1.000 0.4947 
 
 
-DEAL::Interpolated/tranferred solution after coarsening
+DEAL::Interpolated/transferred solution after coarsening
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -26403,7 +26403,7 @@ DEAL::
 1.000 1.000 1.000 -0.1382
 
 
-DEAL::Interpolated/tranferred solution after pure refinement
+DEAL::Interpolated/transferred solution after pure refinement
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -75564,7 +75564,7 @@ DEAL::
 1.000 1.000 1.000 -0.1382
 
 
-DEAL::Interpolated/tranferred solution after coarsening
+DEAL::Interpolated/transferred solution after coarsening
 DEAL::
 # This file was generated by the deal.II library.
 
index 72cc74526f487d88234f25aa4286c7ebd40f46b2..308cbc935af6d89ea1cd9d5b0bd70ffb81e13f34 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// Same as quadrature_point_data_2.cc, but for different base and actuall data
+// Same as quadrature_point_data_2.cc, but for different base and actual data
 // classes.
 
 
index 77d02cdcc88f4a891fb006b73f797801acf42653..b96a25e29a200efa429a03a485345358d5eb021b 100644 (file)
@@ -136,7 +136,7 @@ transfer(std::ostream &out)
   q_data_out.clear_data_vectors();
   q_data_out.add_data_vector(q_solution, "solution");
   q_data_out.build_patches();
-  deallog << "Interpolated/tranferred solution after pure refinement, FE_Q"
+  deallog << "Interpolated/transferred solution after pure refinement, FE_Q"
           << std::endl
           << std::endl;
   q_data_out.write_gnuplot(out);
@@ -144,7 +144,7 @@ transfer(std::ostream &out)
   dgq_data_out.clear_data_vectors();
   dgq_data_out.add_data_vector(dgq_solution, "solution");
   dgq_data_out.build_patches();
-  deallog << "Interpolated/tranferred solution after pure refinement, FE_DGQ"
+  deallog << "Interpolated/transferred solution after pure refinement, FE_DGQ"
           << std::endl
           << std::endl;
   dgq_data_out.write_gnuplot(out);
@@ -175,7 +175,7 @@ transfer(std::ostream &out)
   q_data_out.add_data_vector(q_solution, "solution");
   q_data_out.build_patches();
   deallog
-    << "Interpolated/tranferred solution after coarsening and refinement, FE_Q"
+    << "Interpolated/transferred solution after coarsening and refinement, FE_Q"
     << std::endl
     << std::endl;
   q_data_out.write_gnuplot(out);
@@ -184,7 +184,7 @@ transfer(std::ostream &out)
   dgq_data_out.add_data_vector(dgq_solution, "solution");
   dgq_data_out.build_patches();
   deallog
-    << "Interpolated/tranferred solution after coarsening and refinement, FE_DGQ"
+    << "Interpolated/transferred solution after coarsening and refinement, FE_DGQ"
     << std::endl
     << std::endl;
   dgq_data_out.write_gnuplot(out);
index 4910611a1746d3f05c88fe22475ab33bb83cedb9..585c25a45138c9a875dc6ea8311225c1684207c5 100644 (file)
@@ -146,7 +146,7 @@ DEAL::
 1.00000 -0.760380 
 
 
-DEAL::Interpolated/tranferred solution after pure refinement, FE_Q
+DEAL::Interpolated/transferred solution after pure refinement, FE_Q
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -275,7 +275,7 @@ DEAL::
 1.00000 -0.756802 
 
 
-DEAL::Interpolated/tranferred solution after pure refinement, FE_DGQ
+DEAL::Interpolated/transferred solution after pure refinement, FE_DGQ
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -404,7 +404,7 @@ DEAL::
 1.00000 -0.760380 
 
 
-DEAL::Interpolated/tranferred solution after coarsening and refinement, FE_Q
+DEAL::Interpolated/transferred solution after coarsening and refinement, FE_Q
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -485,7 +485,7 @@ DEAL::
 0.156250 0.580532 
 
 
-DEAL::Interpolated/tranferred solution after coarsening and refinement, FE_DGQ
+DEAL::Interpolated/transferred solution after coarsening and refinement, FE_DGQ
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -1481,7 +1481,7 @@ DEAL::
 1.00000 1.00000 0.515586 
 
 
-DEAL::Interpolated/tranferred solution after pure refinement, FE_Q
+DEAL::Interpolated/transferred solution after pure refinement, FE_Q
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -3240,7 +3240,7 @@ DEAL::
 1.00000 1.00000 0.494679 
 
 
-DEAL::Interpolated/tranferred solution after pure refinement, FE_DGQ
+DEAL::Interpolated/transferred solution after pure refinement, FE_DGQ
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -4999,7 +4999,7 @@ DEAL::
 1.00000 1.00000 0.515586 
 
 
-DEAL::Interpolated/tranferred solution after coarsening and refinement, FE_Q
+DEAL::Interpolated/transferred solution after coarsening and refinement, FE_Q
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -5519,7 +5519,7 @@ DEAL::
 0.0625000 0.187500 0.169943 
 
 
-DEAL::Interpolated/tranferred solution after coarsening and refinement, FE_DGQ
+DEAL::Interpolated/transferred solution after coarsening and refinement, FE_DGQ
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -12202,7 +12202,7 @@ DEAL::
 1.00000 1.00000 1.00000 29.6768
 
 
-DEAL::Interpolated/tranferred solution after pure refinement, FE_Q
+DEAL::Interpolated/transferred solution after pure refinement, FE_Q
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -36115,7 +36115,7 @@ DEAL::
 1.00000 1.00000 1.00000 27.0086
 
 
-DEAL::Interpolated/tranferred solution after pure refinement, FE_DGQ
+DEAL::Interpolated/transferred solution after pure refinement, FE_DGQ
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -60028,7 +60028,7 @@ DEAL::
 1.00000 1.00000 1.00000 29.6768
 
 
-DEAL::Interpolated/tranferred solution after coarsening and refinement, FE_Q
+DEAL::Interpolated/transferred solution after coarsening and refinement, FE_Q
 DEAL::
 # This file was generated by the deal.II library.
 
@@ -64117,7 +64117,7 @@ DEAL::
 0.125000 0.375000 0.125000 0.0485576
 
 
-DEAL::Interpolated/tranferred solution after coarsening and refinement, FE_DGQ
+DEAL::Interpolated/transferred solution after coarsening and refinement, FE_DGQ
 DEAL::
 # This file was generated by the deal.II library.
 
index 3b1511685c813ea223f4c24f33a4c13a41b3d081..3051eb3cb5e22f3ae066c957250c30529d510465 100644 (file)
@@ -82,8 +82,8 @@ using predicate_function =
 int
 main(int argc, char **argv)
 {
-  // Intialize MPI as required by Zoltan library used for graph coloring by this
-  // test.
+  // Initialize MPI as required by Zoltan library used for graph coloring by
+  // this test.
   Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv);
   MPILogInitAll                    all;
 
index 737038583a9fbfd247700f798e4c1c4a11b99c39..0f6523cf8c91b52ced3b90384ba4b55d67a41b72 100644 (file)
@@ -86,8 +86,8 @@ using predicate_function =
 int
 main(int argc, char **argv)
 {
-  // Intialize MPI as required by Zoltan library used for graph coloring by this
-  // test.
+  // Initialize MPI as required by Zoltan library used for graph coloring by
+  // this test.
   Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv);
   MPILogInitAll                    all;
 
@@ -155,7 +155,7 @@ main(int argc, char **argv)
 
       // print color predicate pairs for a cell
       // Note that here material id is used to identify cells
-      // Here (1,2) indicates predicate 2 of color 1 is relavant for cell.
+      // Here (1,2) indicates predicate 2 of color 1 is relevant for cell.
       deallog << "(color, enrichment_func_id):";
       for (auto color_predicate_pair :
            cellwise_color_predicate_map[cell->material_id()])
index e572ed515ae09e8557db9e9ba93d8d1999f92fa2..fb300b2d6e6cb299a0bd430ff73d2690429f59a7 100644 (file)
@@ -84,8 +84,8 @@ using predicate_function =
 int
 main(int argc, char **argv)
 {
-  // Intialize MPI as required by Zoltan library used for graph coloring by this
-  // test.
+  // Initialize MPI as required by Zoltan library used for graph coloring by
+  // this test.
   Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv);
   MPILogInitAll                    all;
 
index 02a4d5b6d473bc8a1d4c2f56c677c706832573d1..493f97eee1209a046c3213101345e3ab14cd36dc 100644 (file)
@@ -159,8 +159,8 @@ plot_shape_function(hp::DoFHandler<dim> &dof_handler, unsigned int patches = 5)
 int
 main(int argc, char **argv)
 {
-  // Intialize MPI as required by Zoltan library used for graph coloring by this
-  // test.
+  // Initialize MPI as required by Zoltan library used for graph coloring by
+  // this test.
   Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv);
   MPILogInitAll                    all;
 
index 3488db483ad34cfb00f9c0b5fbd5ae043125c24f..f96dc4231a4c59a87a14c3b3cb95b5de98313dad 100644 (file)
@@ -91,8 +91,8 @@ using predicate_function =
 int
 main(int argc, char **argv)
 {
-  // Intialize MPI as required by Zoltan library used for graph coloring by this
-  // test.
+  // Initialize MPI as required by Zoltan library used for graph coloring by
+  // this test.
   Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv);
   MPILogInitAll                    all;
 
index 407d68b9f4575c316baf18d661e0d87aba54de9d..8170d64d976c94d1becec808c00fe5665977ef4f 100644 (file)
@@ -1803,7 +1803,7 @@ LaplaceProblem<dim>::run()
                     << norm_rel_change_new << std::endl;
             }
 
-          // moniter relative change of norm in later stages
+          // monitor relative change of norm in later stages
           if (cycle > 1)
             {
               deallog << (norm_rel_change_new < norm_rel_change_old)
@@ -1893,7 +1893,8 @@ main(int argc, char **argv)
           problem.run();
         }
       else
-        AssertThrow(false, ExcMessage("Dimension incorect. dim can be 2 or 3"));
+        AssertThrow(false,
+                    ExcMessage("Dimension incorrect. dim can be 2 or 3"));
     }
 
 
@@ -1944,7 +1945,8 @@ main(int argc, char **argv)
           problem.run();
         }
       else
-        AssertThrow(false, ExcMessage("Dimension incorect. dim can be 2 or 3"));
+        AssertThrow(false,
+                    ExcMessage("Dimension incorrect. dim can be 2 or 3"));
     }
 
 
@@ -1994,7 +1996,8 @@ main(int argc, char **argv)
           problem.run();
         }
       else
-        AssertThrow(false, ExcMessage("Dimension incorect. dim can be 2 or 3"));
+        AssertThrow(false,
+                    ExcMessage("Dimension incorrect. dim can be 2 or 3"));
     }
   }
 }
index f58cab5ab8df6a87000911396994c1e14da21174..64c86c34365fce94e492bce7c76eab74f33fde17 100644 (file)
@@ -216,8 +216,8 @@ using predicate_function =
 int
 main(int argc, char **argv)
 {
-  // Intialize MPI as required by Zoltan library used for graph coloring by this
-  // test.
+  // Initialize MPI as required by Zoltan library used for graph coloring by
+  // this test.
   Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv);
   MPILogInitAll                    all;
 
index 8e7f1e9bd423b45aa296bba4a54b2b99a3fe25ab..10e8c75d1d530dc0ebc16887ca64974aed40924b 100644 (file)
@@ -30,7 +30,7 @@
 //  d/dx1 N0 = -(1-x2)
 //  d/dx2 N0 = -(1-x1)
 // and same for other support points
-// To facilitate comparision, we use auxiliary scalar-valued FE
+// To facilitate comparison, we use auxiliary scalar-valued FE
 // and take its values and gradients. For primitive FEs we can
 // deduce which coefficient of tensor-valued shape function is
 // nonzero and compare values/gradient to the scalar-valued counterpart.
index 989b7f4495f847fd839915c471f9f924ca87312a..e2426ede39b511ccc8ba5a3db658b089ec4b14b1 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// Test whether Assember::CellsAndFaces adds up correctly.
+// Test whether Assembler::CellsAndFaces adds up correctly.
 
 #include <deal.II/dofs/dof_tools.h>
 
index 61a0b2b184aa49e1efa21cf3f25fc6b997f462b1..416204794a030649d7a04a8b5583a15ba7baae08 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// Test whether Assember::Functional adds up correctly.
+// Test whether Assembler::Functional adds up correctly.
 
 #include <deal.II/dofs/dof_tools.h>
 
index 3b088b3f6af3b5e3c299670c0c4ff877c151c342..de20efd6b00217c63485dae718053a0d93085943 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// Test whether the various assember classes put the right data in the
+// Test whether the various assembler classes put the right data in the
 // right place.
 
 #include <deal.II/dofs/dof_tools.h>
index 7af8b420b94f61796efecfe886a8dbc5abc97e00..2d5be91da966c2f342041016284e7e59102684f7 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// Test whether the various assember classes put the right data in the
+// Test whether the various assembler classes put the right data in the
 // right place.
 
 #include <deal.II/dofs/dof_tools.h>
index 8329a101f6d7f0e047ae2ed241dbdccde6c738d5..b7d329e8ee3a5456e042ef9e03f97cfdcb628c41 100644 (file)
@@ -13,7 +13,7 @@
 //
 // ---------------------------------------------------------------------
 
-// Tests for block_operator for opertaions with identical source destinations
+// Tests for block_operator for operations with identical source destinations
 
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_tools.h>
index 829df9a24b98470f066573760b53acb8dfc0071b..6234a2ff3003e64ee2aef94671866454ddbfe5d3 100644 (file)
@@ -170,7 +170,7 @@ test()
     invM *
     linear_operator<LinearAlgebra::distributed::Vector<double>>(laplace) * invM;
 
-  // Do actuall work:
+  // Do actual work:
   LinearAlgebra::distributed::Vector<double> init_vector;
   mf_data->initialize_dof_vector(init_vector);
   for (auto it = init_vector.begin(); it != init_vector.end(); ++it)
index 65b953092cf7de50b545d1dff9e4001c33144647..9dbe422fb9c531d1b87a19fb1e6bd440cf174a12 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// Test whether the various assember classes put the right data in the
+// Test whether the various assembler classes put the right data in the
 // right place.
 
 // This test is a modification of the test with the same name in ../integrators
index 754f272ce7a2924404cadadc52b9d7f318760716..2be3b9ddf3aba22d2626ea0cb31b7b8f4217bee4 100644 (file)
@@ -37,7 +37,7 @@ test()
   //                            ghost:      0  1  2  3     is3
   //                            subset:        1  2        is2
   //
-  // expected result udpate ghosts()
+  // expected result update ghosts()
   //
   //      rank 0 :  00 01 02 03 04 05 06 07 00 00 00 00
   //      rank 1 :  00 00 00 00 00 00 00 00 00 01 02 00
index df0d7cdd716cd5080e8ab0e3aa899c13f9baf7ab..f92532847b354938c89813298020ef38e3c2521f 100644 (file)
@@ -47,7 +47,7 @@ test()
     deallog << "#cells = " << tr.n_global_active_cells() << std::endl;
 
   deallog << "proc " << myid << ", n levels " << tr.n_levels() << std::endl;
-  deallog << "proc " << myid << ", n gobal levels " << tr.n_global_levels()
+  deallog << "proc " << myid << ", n global levels " << tr.n_global_levels()
           << std::endl;
 
   deallog << "begin().cell_index " << tr.begin()->index() << std::endl;
index ffc818c011ae889485c8790700b31cef9ed262aa..7322991f7d2659cb95b886005b364b90325dcf6c 100644 (file)
@@ -1,7 +1,7 @@
 
 DEAL:0:2d::#cells = 4
 DEAL:0:2d::proc 0, n levels 1
-DEAL:0:2d::proc 0, n gobal levels 2
+DEAL:0:2d::proc 0, n global levels 2
 DEAL:0:2d::begin().cell_index 0
 DEAL:0:2d::begin(0).cell_index 0
 DEAL:0:2d::begin(1)==end(1)? 1
@@ -10,7 +10,7 @@ DEAL:0:2d::Checksum: 167510149
 DEAL:0:2d::OK
 
 DEAL:1:2d::proc 1, n levels 1
-DEAL:1:2d::proc 1, n gobal levels 2
+DEAL:1:2d::proc 1, n global levels 2
 DEAL:1:2d::begin().cell_index 0
 DEAL:1:2d::begin(0).cell_index 0
 DEAL:1:2d::begin(1)==end(1)? 1
@@ -18,7 +18,7 @@ DEAL:1:2d::subdomainid = 4294967294
 
 
 DEAL:2:2d::proc 2, n levels 2
-DEAL:2:2d::proc 2, n gobal levels 2
+DEAL:2:2d::proc 2, n global levels 2
 DEAL:2:2d::begin().cell_index 0
 DEAL:2:2d::begin(0).cell_index 0
 DEAL:2:2d::begin(1)==end(1)? 0
@@ -26,7 +26,7 @@ DEAL:2:2d::subdomainid = 2
 
 
 DEAL:3:2d::proc 3, n levels 1
-DEAL:3:2d::proc 3, n gobal levels 2
+DEAL:3:2d::proc 3, n global levels 2
 DEAL:3:2d::begin().cell_index 0
 DEAL:3:2d::begin(0).cell_index 0
 DEAL:3:2d::begin(1)==end(1)? 1
@@ -34,7 +34,7 @@ DEAL:3:2d::subdomainid = 4294967294
 
 
 DEAL:4:2d::proc 4, n levels 1
-DEAL:4:2d::proc 4, n gobal levels 2
+DEAL:4:2d::proc 4, n global levels 2
 DEAL:4:2d::begin().cell_index 0
 DEAL:4:2d::begin(0).cell_index 0
 DEAL:4:2d::begin(1)==end(1)? 1
@@ -42,7 +42,7 @@ DEAL:4:2d::subdomainid = 4294967294
 
 
 DEAL:5:2d::proc 5, n levels 1
-DEAL:5:2d::proc 5, n gobal levels 2
+DEAL:5:2d::proc 5, n global levels 2
 DEAL:5:2d::begin().cell_index 0
 DEAL:5:2d::begin(0).cell_index 0
 DEAL:5:2d::begin(1)==end(1)? 1
@@ -50,7 +50,7 @@ DEAL:5:2d::subdomainid = 4294967294
 
 
 DEAL:6:2d::proc 6, n levels 1
-DEAL:6:2d::proc 6, n gobal levels 2
+DEAL:6:2d::proc 6, n global levels 2
 DEAL:6:2d::begin().cell_index 0
 DEAL:6:2d::begin(0).cell_index 0
 DEAL:6:2d::begin(1)==end(1)? 1
@@ -58,7 +58,7 @@ DEAL:6:2d::subdomainid = 4294967294
 
 
 DEAL:7:2d::proc 7, n levels 1
-DEAL:7:2d::proc 7, n gobal levels 2
+DEAL:7:2d::proc 7, n global levels 2
 DEAL:7:2d::begin().cell_index 0
 DEAL:7:2d::begin(0).cell_index 0
 DEAL:7:2d::begin(1)==end(1)? 1
@@ -66,7 +66,7 @@ DEAL:7:2d::subdomainid = 4294967294
 
 
 DEAL:8:2d::proc 8, n levels 1
-DEAL:8:2d::proc 8, n gobal levels 2
+DEAL:8:2d::proc 8, n global levels 2
 DEAL:8:2d::begin().cell_index 0
 DEAL:8:2d::begin(0).cell_index 0
 DEAL:8:2d::begin(1)==end(1)? 1
@@ -74,7 +74,7 @@ DEAL:8:2d::subdomainid = 4294967294
 
 
 DEAL:9:2d::proc 9, n levels 1
-DEAL:9:2d::proc 9, n gobal levels 2
+DEAL:9:2d::proc 9, n global levels 2
 DEAL:9:2d::begin().cell_index 0
 DEAL:9:2d::begin(0).cell_index 0
 DEAL:9:2d::begin(1)==end(1)? 1
index 377ec968f76c58f18587d05d9062bdbadc3f7ea9..32ddd68daffc7d831ac6da2bd1917151ea5b398e 100644 (file)
@@ -1,7 +1,7 @@
 
 DEAL:0:2d::#cells = 4
 DEAL:0:2d::proc 0, n levels 2
-DEAL:0:2d::proc 0, n gobal levels 2
+DEAL:0:2d::proc 0, n global levels 2
 DEAL:0:2d::begin().cell_index 0
 DEAL:0:2d::begin(0).cell_index 0
 DEAL:0:2d::begin(1)==end(1)? 0
@@ -10,7 +10,7 @@ DEAL:0:2d::Checksum: 167510149
 DEAL:0:2d::OK
 
 DEAL:1:2d::proc 1, n levels 1
-DEAL:1:2d::proc 1, n gobal levels 2
+DEAL:1:2d::proc 1, n global levels 2
 DEAL:1:2d::begin().cell_index 0
 DEAL:1:2d::begin(0).cell_index 0
 DEAL:1:2d::begin(1)==end(1)? 1
index 8f59b65bd96ff7c17a93b2547d849b6e93bdb87c..158588cbfdafd287ec61d601ca3dd05cc00530c4 100644 (file)
@@ -1,7 +1,7 @@
 
 DEAL:0:2d::#cells = 4
 DEAL:0:2d::proc 0, n levels 2
-DEAL:0:2d::proc 0, n gobal levels 2
+DEAL:0:2d::proc 0, n global levels 2
 DEAL:0:2d::begin().cell_index 0
 DEAL:0:2d::begin(0).cell_index 0
 DEAL:0:2d::begin(1)==end(1)? 0
@@ -10,7 +10,7 @@ DEAL:0:2d::Checksum: 167510149
 DEAL:0:2d::OK
 
 DEAL:1:2d::proc 1, n levels 1
-DEAL:1:2d::proc 1, n gobal levels 2
+DEAL:1:2d::proc 1, n global levels 2
 DEAL:1:2d::begin().cell_index 0
 DEAL:1:2d::begin(0).cell_index 0
 DEAL:1:2d::begin(1)==end(1)? 1
@@ -18,7 +18,7 @@ DEAL:1:2d::subdomainid = 4294967294
 
 
 DEAL:2:2d::proc 2, n levels 1
-DEAL:2:2d::proc 2, n gobal levels 2
+DEAL:2:2d::proc 2, n global levels 2
 DEAL:2:2d::begin().cell_index 0
 DEAL:2:2d::begin(0).cell_index 0
 DEAL:2:2d::begin(1)==end(1)? 1
@@ -26,7 +26,7 @@ DEAL:2:2d::subdomainid = 4294967294
 
 
 DEAL:3:2d::proc 3, n levels 1
-DEAL:3:2d::proc 3, n gobal levels 2
+DEAL:3:2d::proc 3, n global levels 2
 DEAL:3:2d::begin().cell_index 0
 DEAL:3:2d::begin(0).cell_index 0
 DEAL:3:2d::begin(1)==end(1)? 1
index 5faf394b526b07b862d234cba33e946d4df5b0c7..7dabf8eaf65efd824baf42d23bb2193c888161b6 100644 (file)
@@ -31,7 +31,7 @@ test()
   for (unsigned int i = 0; i < 2; i++)
     storage.add(0.1 * (i + 1));
 
-  // 2 elemens
+  // 2 elements
   deallog << "initial:" << std::endl;
   for (unsigned int i = 0; i < storage.size(); i++)
     deallog << storage[i] << std::endl;
index a94ca21541129ecaa2ed01ac97e7f62ecdfb0306..d675fee09913cc01cb8adfa21a2155dbccfcea93 100644 (file)
@@ -15,8 +15,8 @@
 
 
 // Check that all the functionality needed for calling
-// AffineConstraints<double>::distribute_local_to_global on mutiple combinations
-// of PETScWrappers objects is correctly instantiated and works.
+// AffineConstraints<double>::distribute_local_to_global on multiple
+// combinations of PETScWrappers objects is correctly instantiated and works.
 
 #include <deal.II/lac/affine_constraints.h>
 #include <deal.II/lac/full_matrix.h>
index 7bc3bbc664c22e550d475dbeb836b2e7c7ca946b..4376d55ac8bad0443387d66a5e5bc159ca6e3613 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// check generic contract variants tha allow to specify the indices which
+// check generic contract variants that allow to specify the indices which
 // will be contracted.
 
 #include <deal.II/base/tensor.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.