]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Run codespell. 10075/head
authorDavid Wells <drwells@email.unc.edu>
Fri, 8 May 2020 02:05:29 +0000 (22:05 -0400)
committerDavid Wells <drwells@email.unc.edu>
Fri, 8 May 2020 02:06:51 +0000 (22:06 -0400)
39 files changed:
doc/doxygen/headers/multithreading.h
examples/step-3/doc/results.dox
examples/step-58/doc/results.dox
examples/step-62/step-62.cc
examples/step-63/step-63.cc
examples/step-64/step-64.cu
examples/step-65/doc/intro.dox
examples/step-67/doc/intro.dox
examples/step-67/doc/results.dox
examples/step-67/step-67.cc
include/deal.II/base/data_out_base.h
include/deal.II/base/mpi.h
include/deal.II/base/mutable_bind.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/parsed_convergence_table.h
include/deal.II/base/polynomials_piecewise.h
include/deal.II/base/symbolic_function.h
include/deal.II/base/tensor.h
include/deal.II/base/vectorization.h
include/deal.II/differentiation/sd/symengine_optimizer.h
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/fe/mapping_q_cache.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/tria_description.h
include/deal.II/hp/fe_collection.h
include/deal.II/hp/refinement.h
include/deal.II/matrix_free/task_info.h
include/deal.II/meshworker/local_results.h
source/base/parameter_handler.cc
source/differentiation/ad/ad_drivers.cc
source/differentiation/sd/symengine_optimizer.cc
source/fe/mapping_q_generic.cc
source/grid/grid_generator.cc
source/grid/grid_generator_from_name.cc
source/grid/grid_tools.cc
source/grid/grid_tools_dof_handlers.cc
source/multigrid/mg_transfer_component.cc
source/particles/particle_handler.cc

index 41c2913338cee89f93a43f8f717dc3c6819da755..76267beb09518ef2a94aee35b5c6d0eeab01d698 100644 (file)
  * (a mutex) rather than task scheduler resources. The result is a
  * deadlock.
  *
- * The bottom line is that tasks can not use mutices or condition variables to
+ * The bottom line is that tasks can not use mutexes or condition variables to
  * synchronize with other tasks. If communication between tasks is necessary,
  * you need to use threads because the operating system makes sure that all
  * threads eventually get to run, independent of the total number of threads.
  * Note however that the same is not true if you only use a Thread::Mutex on
  * each task separately to protect access to a variable that the tasks may
- * write to: this use of mutices is ok; tasks may simply not want to wait for
+ * write to: this use of mutexes is ok; tasks may simply not want to wait for
  * another task to do something.
  *
  *
index 25c51055fc30bafd6456bdb3127b39e0ae9c38b1..ae8b6c9862a615a267a2e67a63ee97681c5fb2aa 100644 (file)
@@ -272,7 +272,7 @@ languages for other purposes.
 
 <h4> Adding the point value and the mean (see extension above) into the .h5 file</h4>
 
-After outputing the solution, the file can be opened again to include
+After outputting the solution, the file can be opened again to include
 more datasets.  This allows us to keep all the necessary information
 of our experiment in a single result file, which can then be read and
 processed by some postprocessing script.
index 3558ae2877fa4508baac056eda6f2c88401cce20..c4f515b3606ec4d3ac0f2f245c5ef6252339b338 100644 (file)
@@ -105,7 +105,7 @@ that is also cyclic -- though this color map lacks all of the skill employed by
 the people who wrote the posts mentioned in the links above. It
 does, however, show the character of the solution as a wave equation
 if you look at the shaded part of the domain outside the circle of
-radius 0.7 in which the potential is zero -- you can see how everytime
+radius 0.7 in which the potential is zero -- you can see how every time
 one of the bumps (showing the amplitude $|\psi_h(\mathbf x,t)|^2$)
 bumps into the area where the potential is large: a wave travels
 outbound from there. Take a look at the video:
index db4d17a25c6f4853618bcc115e2866d77ad265ad..64c202321509c935d3d454f4d008cf0b9cb58fdb 100644 (file)
@@ -346,7 +346,7 @@ namespace step62
     HDF5::DataSet frequency_dataset;
     HDF5::DataSet probe_positions_dataset;
 
-    // HDF5 dataset that stores the values of the energy measured by the proble.
+    // HDF5 dataset that stores the values of the energy measured by the probe.
     HDF5::DataSet displacement;
 
 
index 3cfcea97021fcd8b9371e0c9af8d6fe44ff2a84a..7d13f0efddb785b3e31e4f191bf656bab6558bf0 100644 (file)
@@ -888,7 +888,7 @@ namespace Step63
   // relaxation parameter.
 
   // Since multiplicative methods tend to be more powerful than additive method,
-  // fewer smoothing steps are required to see convergence indepedent of mesh
+  // fewer smoothing steps are required to see convergence independent of mesh
   // size. The same holds for block smoothers over point smoothers. This is
   // reflected in the choice for the number of smoothing steps for each type of
   // smoother below.
index 862835d8a65c6344dc5fde2e4cbb3163537cf9c0..b8621bba14e0eb4232842c2032c04a3f785526f9 100644 (file)
@@ -17,7 +17,7 @@
  * Authors: Bruno Turcksin, Daniel Arndt, Oak Ridge National Laboratory, 2019
  */
 
-// First include the necessary files from the deal.II libary known from the
+// First include the necessary files from the deal.II library known from the
 // previous tutorials.
 #include <deal.II/base/conditional_ostream.h>
 #include <deal.II/base/quadrature_lib.h>
@@ -486,7 +486,7 @@ namespace Step64
 
 
   // This solve() function finally contains the calls to the new classes
-  // previously dicussed. Here we don't use any preconditioner, i.e.
+  // previously discussed. Here we don't use any preconditioner, i.e.,
   // precondition by the identity matrix, to focus just on the peculiarities of
   // the CUDAWrappers::MatrixFree framework. Of course, in a real application
   // the choice of a suitable preconditioner is crucial but we have at least the
@@ -606,7 +606,7 @@ namespace Step64
 // the machine, there is nothing we can do about it: All MPI ranks on
 // that machine need to share it. But if there are more than one GPU,
 // then it is better to address different graphic cards for different
-// processes. The choice below is based on the MPI proccess id by
+// processes. The choice below is based on the MPI process id by
 // assigning GPUs round robin to GPU ranks. (To work correctly, this
 // scheme assumes that the MPI ranks on one machine are
 // consecutive. If that were not the case, then the rank-GPU
index 609e2c08fffb7d5d5312421bdf9d44299ebb8dd6..32f8e52de4f0c726fb640284cdc4add2fd497c40 100644 (file)
@@ -125,7 +125,7 @@ inverts in some regions
 because the new points placed along interior cells intersect with the boundary
 as they are not following the circular shape along the toroidal direction. The
 simple case of a torus can still be fixed because we know that the toroidal
-direction follows a cylindrical coordindate system, so attaching a
+direction follows a cylindrical coordinate system, so attaching a
 TorusManifold to the surface combined with CylindricalManifold with
 appropriate periodicity in toroidal direction applied to all interior entities
 would produce a high-quality mesh as follows, now shown with two top cells
index 7fc0277f541ed78dbce4b8fcd869b1af49fb83b8..9fcfb003c96e9cba0d1de7e804c9fa2c1e75c43b 100644 (file)
@@ -623,7 +623,7 @@ keep the number of quadrature points a variable to be specified just as the
 polynomial degree, and note that one would make different choices depending
 also on the flow configuration. The default choice is $p+2$ points -- a bit
 more than the minimum possible of $p+1$ points. The FEEvaluation and
-FEFaceEvaluation classes allow to seemlessly change the number of points by a
+FEFaceEvaluation classes allow to seamlessly change the number of points by a
 template parameter, such that the program does not get more complicated
 because of that.
 
index a4be76c40a6462f2d19c2e2033cce610fa184d5e..42acb5a0dc2954af37ee7fd3defb1b1dbed5f0b4 100644 (file)
@@ -373,7 +373,7 @@ If we switch to the Harten-Lax-van Leer flux, the results are as follows:
 </table>
 
 The tables show that we get optimal $\mathcal O\left(h^{p+1}\right)$
-convergence rates for both numerical fluxes. The errors are slighly smaller
+convergence rates for both numerical fluxes. The errors are slightly smaller
 for the Lax--Friedrichs flux for $p=2$, but the picture is reversed for
 $p=3$; in any case, the differences on this testcase are relatively
 small.
index b7650612cac13ea4ef23a18cd055dd8c7513d630..5bbd7e68fd328f3a9799bb9ed19b3b2d0623b27d 100644 (file)
@@ -975,7 +975,7 @@ namespace Euler_DG
   // points. Whereas we previously always set the number of quadrature points
   // to equal the polynomial degree plus one (ensuring exact integration on
   // affine element shapes), we now set the number quadrature points as a
-  // separate variable (e.g. the polynomial degree plus two or three halfs of
+  // separate variable (e.g. the polynomial degree plus two or three halves of
   // the polynomial degree) to more accurately handle nonlinear terms. Since
   // the evaluator is fed with the appropriate loop lengths via the template
   // argument and keeps the number of quadrature points in the whole cell in
@@ -1982,7 +1982,7 @@ namespace Euler_DG
   // choose a constant inflow profile, whereas we set a subsonic outflow at
   // the right. For the boundary around the cylinder (boundary id equal to 2)
   // as well as the channel walls (boundary id equal to 3) we use the wall
-  // boundary type, which is no-normal flow. Furthermore, for the 3D cyclinder
+  // boundary type, which is no-normal flow. Furthermore, for the 3D cylinder
   // we also add a gravity force in vertical direction. Having the base mesh
   // in place (including the manifolds set by
   // GridGenerator::channel_with_cylinder()), we can then perform the
index 007077b17166cf547a91319e0c3de5af2562dfa3..1089e04c5756853898093f11752863f54e79a045 100644 (file)
@@ -2764,7 +2764,7 @@ public:
    * output/solution_0003.pvtu
    * @endcode
    * where the `.0.vtu` file contains the output of the first half of the
-   * proceses grouped together, and the `.1.vtu` the data from the remaining
+   * processes grouped together, and the `.1.vtu` the data from the remaining
    * half.
    *
    * A specified @p directory and a @p filename_without_extension
index 07e6fda84db7338131b8e6c23e775a3e54c89eb7..b561fc3721c25165b39193e50dc3ffd98c7354bf 100644 (file)
@@ -331,7 +331,7 @@ namespace Utilities
       {
       public:
         /**
-         * Constructor. Blocks until it can aquire the lock.
+         * Constructor. Blocks until it can acquire the lock.
          */
         explicit ScopedLock(CollectiveMutex &mutex, const MPI_Comm &comm)
           : mutex(mutex)
@@ -370,7 +370,7 @@ namespace Utilities
       ~CollectiveMutex();
 
       /**
-       * Aquire the mutex and, if necessary, wait until we can do so.
+       * Acquire the mutex and, if necessary, wait until we can do so.
        *
        * This is a collective call that needs to be executed by all processors
        * in the communicator.
index f2f888763cdc8454313cc6f38813ac2fb8f8abbb..3846c95737ee0352c93058ecd82f5cb5e1f97d80 100644 (file)
@@ -107,7 +107,7 @@ namespace Utilities
 
     /**
      * Construct a MutableBind object specifying only the function. By default,
-     * the arguments are left to their defult constructor values.
+     * the arguments are left to their default constructor values.
      */
     template <class FunctionType>
     MutableBind(FunctionType function);
index 4fdc503eceef84f2690433d55d288077b2691ff0..e33ef3c2a6710352c92014b018efcf16593ae58e 100644 (file)
@@ -1105,7 +1105,7 @@ public:
    * The parameter @p has_to_be_set can be used in order to declare this
    * parameter as a parameter whose default value has to be overwritten by
    * one of the methods provided by this class. Whether a parameter has been set
-   * succesfully can be queried by the functions get_entries_wrongly_not_set()
+   * successfully can be queried by the functions get_entries_wrongly_not_set()
    * and assert_that_entries_have_been_set().
    *
    * @note An entry can be declared more than once without generating an
@@ -1177,7 +1177,7 @@ public:
    * The parameter @p has_to_be_set can be used in order to declare this
    * parameter as a parameter whose default value has to be overwritten by
    * one of the methods provided by this class. Whether a parameter has been set
-   * succesfully can be queried by the functions get_entries_wrongly_not_set()
+   * successfully can be queried by the functions get_entries_wrongly_not_set()
    * and assert_that_entries_have_been_set().
    */
   template <class ParameterType>
index 7cbe508bc23c8eae388ffdba7e207c0676a64faf..7e09c401024ce4fa8e2600745ba4a23115f0491c 100644 (file)
@@ -200,7 +200,7 @@ public:
    * output_table() also writes in this file in the format deduced from its
    * extension;
    * @param precision How many digits to use when writing the error;
-   * @param compute_error Control wether the filling of the table is enabled
+   * @param compute_error Control whether the filling of the table is enabled
    * or not. This flag may be used to disable at run time any error computation;
    *
    * The parameters you specify with this constructor can be written to a
index cb1659254cfe10ac3dc82dda8ac242f648c635dd..c040928c57bad8bb273f4cbf1214a818a4169218 100644 (file)
@@ -87,7 +87,7 @@ namespace Polynomials
      * thus determined by the size of the vector passed.
      *
      * Note that all the derivatives evaluate to zero at the border between
-     * intervals (assuming exact arithmetics) in the interior of the unit
+     * intervals (assuming exact arithmetic) in the interior of the unit
      * interval, as there is no unique gradient value in that case for a
      * piecewise polynomial. This is not always desired (e.g., when evaluating
      * jumps of gradients on the element boundary), but it is the user's
@@ -105,7 +105,7 @@ namespace Polynomials
      * space for @p n_derivatives + 1 values.
      *
      * Note that all the derivatives evaluate to zero at the border between
-     * intervals (assuming exact arithmetics) in the interior of the unit
+     * intervals (assuming exact arithmetic) in the interior of the unit
      * interval, as there is no unique gradient value in that case for a
      * piecewise polynomial. This is not always desired (e.g., when evaluating
      * jumps of gradients on the element boundary), but it is the user's
index fe46ba8833ffd23ffce480679a9869fda44d99e6..27bd504ed62e12f670c3d936bba1fc9eab9e86a9 100644 (file)
@@ -138,7 +138,7 @@ namespace Functions
    * expression, together with its derivatives (if required). These are then
    * used in all subsequent evaluations. Calling
    * set_additional_function_arguments() will evaluate the passed
-   * subsitution map on the fly during evaluation time, *after* all
+   * substitution map on the fly during evaluation time, *after* all
    * derivatives have been computed.
    *
    * @note The difference between this class and the FunctionParser class is
index a8d6dd315766fd70b43a305adb9c1823ccc42c82..7f2a9a3f16b522ffb56743a7fea3d9ccd583e9a1 100644 (file)
@@ -2650,7 +2650,7 @@ project_onto_orthogonal_tensors(const Tensor<2, dim, Number> &tensor)
   LAPACKFullMatrix<Number> lapack_matrix(dim);
   LAPACKFullMatrix<Number> result(dim);
 
-  // todo: find or add dealii functionallity to copy in one step.
+  // todo: find or add dealii functionality to copy in one step.
   matrix.copy_from(tensor);
   lapack_matrix.copy_from(matrix);
 
@@ -2660,7 +2660,7 @@ project_onto_orthogonal_tensors(const Tensor<2, dim, Number> &tensor)
   // Use the SVD results to orthogonalize: $U V^T$
   lapack_matrix.get_svd_u().mmult(result, lapack_matrix.get_svd_vt());
 
-  // todo: find or add dealii functionallity to copy in one step.
+  // todo: find or add dealii functionality to copy in one step.
   matrix = result;
   matrix.copy_to(output_tensor);
   return output_tensor;
index 92ea471e742a602b45d21d45bec47ff62118583a..40d49b0ad8dac60fdef2f1038752eb8fb897178b 100644 (file)
@@ -1006,7 +1006,7 @@ public:
   VectorizedArray &
   operator+=(const VectorizedArray &vec)
   {
-    // if the compiler supports vector arithmetics, we can simply use +=
+    // if the compiler supports vector arithmetic, we can simply use +=
     // operator on the given data type. this allows the compiler to combine
     // additions with multiplication (fused multiply-add) if those
     // instructions are available. Otherwise, we need to use the built-in
@@ -1560,7 +1560,7 @@ public:
   VectorizedArray &
   operator+=(const VectorizedArray &vec)
   {
-    // if the compiler supports vector arithmetics, we can simply use +=
+    // if the compiler supports vector arithmetic, we can simply use +=
     // operator on the given data type. this allows the compiler to combine
     // additions with multiplication (fused multiply-add) if those
     // instructions are available. Otherwise, we need to use the built-in
@@ -2210,7 +2210,7 @@ public:
   VectorizedArray &
   operator+=(const VectorizedArray &vec)
   {
-    // if the compiler supports vector arithmetics, we can simply use +=
+    // if the compiler supports vector arithmetic, we can simply use +=
     // operator on the given data type. this allows the compiler to combine
     // additions with multiplication (fused multiply-add) if those
     // instructions are available. Otherwise, we need to use the built-in
@@ -2723,7 +2723,7 @@ public:
   VectorizedArray &
   operator+=(const VectorizedArray &vec)
   {
-    // if the compiler supports vector arithmetics, we can simply use +=
+    // if the compiler supports vector arithmetic, we can simply use +=
     // operator on the given data type. this allows the compiler to combine
     // additions with multiplication (fused multiply-add) if those
     // instructions are available. Otherwise, we need to use the built-in
index f1bf2e1c899b43fa00c92cdec46b5a9953061942..a3c029d0a2309cb1051c7502b4e1280875110d66 100644 (file)
@@ -865,7 +865,7 @@ namespace Differentiation
          * @param output_values The evaluated numerical outcome of the
          * substitution.
          * @param substitution_values The values with which to associate each
-         * individial independent symbol.
+         * individual independent symbol.
          */
         static void
         substitute(typename Optimizer::OptimizerType *optimizer,
@@ -1004,7 +1004,7 @@ namespace Differentiation
          * @param output_values The evaluated numerical outcome of the
          * substitution.
          * @param substitution_values The values with which to associate each
-         * individial independent symbol.
+         * individual independent symbol.
          */
         static void
         substitute(typename Optimizer::OptimizerType *optimizer,
@@ -1395,16 +1395,16 @@ namespace Differentiation
      * practices" that can be adopted in order to mitigate this cost as much
      * as possible:
      * 1. Reuse a single instance of the class as much as possible.
-     *    The most obvious wat that this can be achieved would be to place an
+     *    The most obvious way that this can be achieved would be to place an
      *    instance of this class in a centralized location where it can
-     *    potentially be used by mulitple calling functions and objects, if
+     *    potentially be used by multiple calling functions and objects, if
      *    contextually possible.
      * 2. Another form of reuse would entail generalizing the dependent
      *    functions/expressions to be evaluated by the optimizer as much as
-     *    possible. For example, material coeffients need not necessarily be
+     *    possible. For example, material coefficients need not necessarily be
      *    hard-coded, and one generalized statement of a constitutive law could
-     *    then be broadly used in other material subdomains goverened by the
-     *    same class of constiutive law, but with different constitutive
+     *    then be broadly used in other material subdomains governed by the
+     *    same class of constitutive law, but with different constitutive
      *    parameters. The same principle applies if using symbolic expressions
      *    to describe boundary conditions, systems of linear equations, etc.
      * 3. When possible, consider using serialization to save and load the state
@@ -1861,7 +1861,7 @@ namespace Differentiation
        *
        * @note In contrast to the other variants of this function, the order of
        * the returned entries is an internal implementation detail, and cannot
-       * be guarenteed under all conditions. The entries in the returned vector
+       * be guaranteed under all conditions. The entries in the returned vector
        * are, in general, identical to the order in which the dependent
        * expressions are originally registered. However, when registering
        * tensors and symmetric tensors of expressions, these are "unrolled"
@@ -1976,7 +1976,7 @@ namespace Differentiation
        * to store the result of a substitution sweep as some optimizers
        * work on all symbolic expressions in a single batch. In this way
        * they can employ methods such as common subexpression elimination
-       * to minimise the number of terms evaluated across all symbolic
+       * to minimize the number of terms evaluated across all symbolic
        * functions.
        *
        * This variable is marked as mutable. This facilitates the substitution
index 7a970f9747afadee3f9332e0c3460b057e368f4b..a6dd4b01297caac8ce747069fe2b371ce3dd86bd 100644 (file)
@@ -1150,7 +1150,7 @@ namespace FETools
       std::vector<MPI_Request>                 requests(cells_to_send.size());
       std::vector<unsigned int>                destinations;
 
-      // Protect the communcation below:
+      // Protect the communication below:
       static Utilities::MPI::CollectiveMutex      mutex;
       Utilities::MPI::CollectiveMutex::ScopedLock lock(mutex, communicator);
 
index 4d9bf652d50eca00607fbedb2a91f770b45b615d..c9119f0cd4485c74161397af28a55088bc45a519 100644 (file)
@@ -121,7 +121,7 @@ public:
 
 protected:
   /**
-   * This is the main function overriden from the base class MappingQGeneric.
+   * This is the main function overridden from the base class MappingQGeneric.
    */
   virtual std::vector<Point<spacedim>>
   compute_mapping_support_points(
index 3171127d8a6a1ecab0f7c50b59a39e093de5ae6e..e53e534501691595673638f8ff8087308057f2ed 100644 (file)
@@ -1914,7 +1914,7 @@ namespace GridGenerator
 
       /**
        * Vertical distance from airfoil chord to upper boundary of the mesh
-       * i.e. half of the total mesh hight.
+       * i.e. half of the total mesh height.
        */
       double height;
 
@@ -1981,7 +1981,7 @@ namespace GridGenerator
        * nonequidistand airfoil points.
        * Increasing the provided nonequidistant airfoil points leads to
        * a better approximation of the airfoil geometry. Parameter
-       * "airfoil_sampling_factor" therby defines the relation of
+       * "airfoil_sampling_factor" thereby defines the relation of
        * provided_nonequidistant_points to required_equidistant_points.
        */
       unsigned int airfoil_sampling_factor;
index 994a1bedc5d7e7ec87970f84a260d0cde8876bb3..7511195b984c24514e16b92595a7296a7bf8f664 100644 (file)
@@ -4005,7 +4005,7 @@ namespace GridTools
             }
         }
 
-    // Protect the following communcation:
+    // Protect the following communication:
     static Utilities::MPI::CollectiveMutex      mutex;
     Utilities::MPI::CollectiveMutex::ScopedLock lock(mutex,
                                                      tria->get_communicator());
index e134123586b24453bdb4c1232c641bc3b8d579f6..b0a10f137551433e77703994f788e51db1e83c99 100644 (file)
@@ -473,7 +473,7 @@ namespace TriangulationDescription
      * @return Description to be used to set up a Triangulation.
      *
      * @note If construct_multigrid_hierarchy is set in the settings, the
-     *   @p smooting parameter is extended with the
+     *   @p smoothing parameter is extended with the
      *   limit_level_difference_at_vertices flag.
      *
      * @author Peter Munch, 2019
index bf06f99033af9688aa359fb4badac9c6eefbf641..f6a5a2d1cfa866b4a071a14c84a1ea661eae427c 100644 (file)
@@ -351,7 +351,7 @@ namespace hp
      * all elements associated with the provided set of indices @p fes.
      *
      * You may find information about the domination behavior of finite elements
-     * in their respecitve class documentation or in the implementation of their
+     * in their respective class documentation or in the implementation of their
      * inherited member function FiniteElement::compare_for_domination().
      * Consider that a finite element may or may not dominate itself (e.g.
      * FE_Nothing elements).
@@ -376,7 +376,7 @@ namespace hp
      * dominated by all elements associated with the provided set of indices @p fes.
      *
      * You may find information about the domination behavior of finite elements
-     * in their respecitve class documentation or in the implementation of their
+     * in their respective class documentation or in the implementation of their
      * inherited member function FiniteElement::compare_for_domination().
      * Consider that a finite element may or may not dominate itself (e.g.
      * FE_Nothing elements).
@@ -401,7 +401,7 @@ namespace hp
      * that dominates all other elements of this very set.
      *
      * You may find information about the domination behavior of finite elements
-     * in their respecitve class documentation or in the implementation of their
+     * in their respective class documentation or in the implementation of their
      * inherited member function FiniteElement::compare_for_domination().
      * Consider that a finite element may or may not dominate itself (e.g.
      * FE_Nothing elements).
@@ -437,7 +437,7 @@ namespace hp
      * that is dominated by all other elements of this very set.
      *
      * You may find information about the domination behavior of finite elements
-     * in their respecitve class documentation or in the implementation of their
+     * in their respective class documentation or in the implementation of their
      * inherited member function FiniteElement::compare_for_domination().
      * Consider that a finite element may or may not dominate itself (e.g.
      * FE_Nothing elements).
@@ -477,7 +477,7 @@ namespace hp
      * provided set @p fes are part of.
      *
      * You may find information about the domination behavior of finite elements
-     * in their respecitve class documentation or in the implementation of their
+     * in their respective class documentation or in the implementation of their
      * inherited member function FiniteElement::compare_for_domination().
      * Consider that a finite element may or may not dominate itself (e.g.
      * FE_Nothing elements).
@@ -503,7 +503,7 @@ namespace hp
      * element space which includes all finite elements of the provided set @p fes.
      *
      * You may find information about the domination behavior of finite elements
-     * in their respecitve class documentation or in the implementation of their
+     * in their respective class documentation or in the implementation of their
      * inherited member function FiniteElement::compare_for_domination().
      * Consider that a finite element may or may not dominate itself (e.g.
      * FE_Nothing elements).
index b45eb71c3d2580aabf56fcb426a782b3f16b24f3..dbfdc705d3686320b9a7c19fe9004303df0c4c28 100644 (file)
@@ -44,7 +44,7 @@ namespace hp
 namespace hp
 {
   /**
-   * We supply adaptive methods to align computational ressources with the
+   * We supply adaptive methods to align computational resources with the
    * complexity of the numerical solution. Error estimates are an appropriate
    * means of determining where adjustments need to be made.
    *
@@ -136,7 +136,7 @@ namespace hp
      *
      * Such functions take two numbers as arguments: The first one corresponds
      * to the provided criterion, while the other one conforms to the reference.
-     * The result of the comparision will be returned as a boolean.
+     * The result of the comparison will be returned as a boolean.
      */
     template <typename Number>
     using ComparisonFunction =
@@ -403,7 +403,7 @@ namespace hp
      * different, and their parent cell will be assigned to their least
      * dominating finite element that belongs to its most general child. Thus,
      * we will always interpolate on an enclosing finite element space.
-     * Additionaly assuming that the finite elements on the cells to be
+     * Additionally assuming that the finite elements on the cells to be
      * coarsened are sufficient to represent the solution correctly (e.g. at
      * least quadratic basis functions for a quadratic solution), we are
      * confident to say that the error will not change by sole interpolation on
index cfc972ccd99d63338e504308dddad3ffed7340c0..2e64d21f6ab088efdd943528e0437976480d21a5 100644 (file)
@@ -64,7 +64,7 @@ namespace internal
     virtual void
     vector_compress_finish() = 0;
 
-    /// Zeros part of the vector accroding to a given range as stored in
+    /// Zeros part of the vector according to a given range as stored in
     /// DoFInfo
     virtual void
     zero_dst_vector_range(const unsigned int range_index) = 0;
index fede2c8d7348ce28dcf078c141529f658291a39f..af1d2fce43f1e48f4ed5a42e6c75ea2a5d07bb6a 100644 (file)
@@ -107,7 +107,7 @@ class BlockIndices;
  * DOFINFO objects are gathered in a DoFInfoBox. In those objects, we store
  * the results of local operations on each cell and its faces. Once all this
  * information has been gathered, an ASSEMBLER is used to assemble it into
- * golbal data.
+ * global data.
  *
  * <h4>INFOBOX</h4>
  *
index 022c9182102a1a7f97b67be2f71bbd55fb9fec4c..4887933456853e4483d30403f032b7d8fe463b2a 100644 (file)
@@ -1265,7 +1265,7 @@ ParameterHandler::print_parameters(std::ostream &    out,
   // done recursively in our own code. take care of the two special formats
   // first
 
-  // explicity compress the tree if requested
+  // explicitly compress the tree if requested
   if ((style & Short) && (style & (XML | JSON)))
     {
       // modify the copy of the tree
index fe937fd23e0d2bed79adc269eb30811012c58464..01ee5aed1804f249a17586f47635012b28a1ab79 100644 (file)
@@ -366,7 +366,7 @@ namespace Differentiation
       //               >>> File or directory not found! <<<
       // , 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.
+      // conservative so that we don't output useless messages for our users.
       const std::vector<typename Types<ADNumberType>::tape_index>
                  registered_tape_indices = get_registered_tape_indices();
       const auto it = std::find(registered_tape_indices.begin(),
index 474e0828a117af64dc4036a2ccf4201edfc49257..e90516e92873a87c5369545f633aca553e677ea9 100644 (file)
@@ -549,7 +549,7 @@ namespace Differentiation
           // coefficient. Upon serialization, this might be dropped, meaning
           // that when we reload the expressions they now look somewhat
           // different to as before. If all data that the user uses is
-          // guarenteed to either have been serialized or never serialized, then
+          // guaranteed to either have been serialized or never serialized, then
           // there would be no problem. However, users might rebuild their
           // dependent expression and just reload the optimizer. This is
           // completely legitimate. But in this scenario we might be out of sync
@@ -591,7 +591,7 @@ namespace Differentiation
               const Expression new_map_expr =
                 serialize_and_deserialize_expression(e.first);
 
-              // Add a new map entry and re-search. This is guarenteed to be
+              // Add a new map entry and re-search. This is guaranteed to
               // return a valid entry. Note that we must do a string comparison,
               // because the data structures that form the expressions might
               // still be different.
index 1f022351575e236f9ea60cdff7e1e8cd82934745..14c0a1f747886713e7250ed8f42be9c6b82bdb79 100644 (file)
@@ -86,7 +86,7 @@ namespace internal
       {
         Assert(spacedim == 2, ExcInternalError());
 
-        // For accuracy reasons, we do all arithmetics in extended precision
+        // For accuracy reasons, we do all arithmetic in extended precision
         // (long double). This has a noticeable effect on the hit rate for
         // borderline cases and thus makes the algorithm more robust.
         const long double x = p(0);
index f9403bbd72e530702279e9acf8af003392775fca..dd773fb5529e01f8fba3be2c3a505351f1ef1780 100644 (file)
@@ -267,16 +267,16 @@ namespace GridGenerator
         // number of global refinements
         const unsigned int refinements;
 
-        // numer of subdivisions of coarse grid in blocks 1 and 4
+        // number of subdivisions of coarse grid in blocks 1 and 4
         const unsigned int n_subdivision_x_0;
 
-        // numer of subdivisions of coarse grid in blocks 2 and 5
+        // number of subdivisions of coarse grid in blocks 2 and 5
         const unsigned int n_subdivision_x_1;
 
-        // numer of subdivisions of coarse grid in blocks 3 and 6
+        // number of subdivisions of coarse grid in blocks 3 and 6
         const unsigned int n_subdivision_x_2;
 
-        // numer of subdivisions  of coarse grid in all blocks (normal to
+        // number of subdivisions  of coarse grid in all blocks (normal to
         // airfoil or in y-direction, respectively)
         const unsigned int n_subdivision_y;
 
@@ -284,7 +284,7 @@ namespace GridGenerator
         // (C-Mesh) that arises after interpolation in blocks 1 and 4
         const double height;
 
-        // lenght block 3 and 6
+        // length block 3 and 6
         const double length_b2;
 
         // factor to move points G and I horizontal to the right, i.e. make
@@ -536,7 +536,8 @@ namespace GridGenerator
          * Joukowski transformation of circle points created by function
          * joukowski_circle().
          *
-         * @param[in] circle_points Vector containing oints of joukowski circle.
+         * @param[in] circle_points Vector containing points of joukowski
+         * circle.
          * @return joukowski_points Vector containing joukowski airfoil points.
          */
         static std::vector<Point<2>>
@@ -562,7 +563,7 @@ namespace GridGenerator
          * by interpolation among factor*number_points NACA-airfoil points to
          * obtain a better approximation of the airfoil geometry
          *
-         * @param[in] serialnumber NACA serial numer for different airfoil
+         * @param[in] serialnumber NACA serial number for different airfoil
          * shapes (so far only 4-digit-series implemented).
          * @param[in] number_points Number of required airfoil points for each
          *  side to being conform with amount of cells along the airfoil after
@@ -682,7 +683,7 @@ namespace GridGenerator
                   5 * t *
                   (0.2969 * std::pow(x, 0.5) - 0.126 * x -
                    0.3516 * std::pow(x, 2) + 0.2843 * std::pow(x, 3) -
-                   0.1036 * std::pow(x, 4)); // half thicknes at a position x
+                   0.1036 * std::pow(x, 4)); // half thickness at a position x
 
                 const double theta = std::atan(dy_c);
 
@@ -933,7 +934,7 @@ namespace GridGenerator
          * x-axis (by definition of points A-L), blocks 1&4, 2&4 and 3&6 can be
          * interpolated with the same geometric computations Consider a
          * bias_factor and incline_factor during interpolation to obtain a more
-         * dense mesh next to airfoil geometry and recieve an inclined boundary
+         * dense mesh next to airfoil geometry and receive an inclined boundary
          * between block 2&3 and 5&6, respectively
          */
         void interpolate(Triangulation<2> &tria) const
@@ -980,7 +981,7 @@ namespace GridGenerator
                     // 1 so that A(0) is on y-axis so that faces AD and BC are
                     // horizontal. This simplifies the computation of the
                     // required indices for interpolation (all x-nodes are
-                    // positiv) Move trapeze to be in first quadrant by addig
+                    // positive) Move trapeze to be in first quadrant by adding
                     // trapeze_offset
                     Point<2, double> node_;
                     if (cell.material_id() == id_block_1)
index 7cf00ec86a1572f810ec87ce8d59490689533055..bcfb2fb267a999d41188de7f2a3805dd31e81216 100644 (file)
@@ -24,7 +24,7 @@ namespace GridGenerator
   namespace
   {
     /**
-     * Given a GridGenerator function pointer, a  string containig a text
+     * Given a GridGenerator function pointer, a  string containing a text
      * version of the function arguments and an empty Triangulation, calls the
      * corresponding function, after parsing the arguments from the given
      * string.
index 32b048eb0c529666b399a5841bb82aae82ebc6d3..cda5c86b8b1998ab2aebcae9f67cced48729b612 100644 (file)
@@ -4381,7 +4381,7 @@ namespace GridTools
         // We assume the last used cell contains the point: checking it
         if (cell_candidate_idx != -1)
           if (!box_cell[cell_candidate_idx].first.point_inside(points[p]))
-            // Point ouside candidate cell: we have no candidate
+            // Point outside candidate cell: we have no candidate
             cell_candidate_idx = -1;
 
         // If there's no candidate, run a tree search
index 41f794208af63c3a4b9c1f4210fe4880b6d1fe08..812bd72e458427ed1b71823d31a6c64c031bbc34 100644 (file)
@@ -1443,7 +1443,7 @@ namespace GridTools
              "Vector containing patch cells should not be an empty vector!"));
     // In order to extract the set of cells with the coarsest common level from
     // the give vector of cells: First it finds the number associated with the
-    // minimum level of refinmenet, namely "min_level"
+    // minimum level of refinement, namely "min_level"
     int min_level = patch[0]->level();
 
     for (unsigned int i = 0; i < patch.size(); ++i)
index 5fabff84aa79441e0677d3f3496a9be0ff9d007e..588566712b2707fc753afaef0a9dc5b58166d2cc 100644 (file)
@@ -531,16 +531,16 @@ MGTransferComponentBase::build(const DoFHandler<dim, spacedim> &mg_dof)
                   for (types::global_dof_index i = 0; i < n_dofs; ++i)
                     {
                       SparseMatrix<double>::iterator
-                        anfang = prolongation_matrices[level]
-                                   ->block(iblock, jblock)
-                                   .begin(i),
-                        ende = prolongation_matrices[level]
-                                 ->block(iblock, jblock)
-                                 .end(i);
-                      for (; anfang != ende; ++anfang)
+                        begin = prolongation_matrices[level]
+                                  ->block(iblock, jblock)
+                                  .begin(i),
+                        end = prolongation_matrices[level]
+                                ->block(iblock, jblock)
+                                .end(i);
+                      for (; begin != end; ++begin)
                         {
                           const types::global_dof_index column_number =
-                            anfang->column();
+                            begin->column();
 
                           // convert global indices into local ones
                           const BlockIndices block_indices_coarse(
index 880b85b185e14332eb14a1df09a9ac4e5fbc276e..c8f98e152c7be49030f69293c355316668aae3ff 100644 (file)
@@ -140,7 +140,7 @@ namespace Particles
     // Create the memory pool that will store all particle properties
     property_pool = std_cxx14::make_unique<PropertyPool>(n_properties);
 
-    // Create the grid cache to cache the informations about the triangulation
+    // Create the grid cache to cache the information about the triangulation
     // that is used to locate the particles into subdomains and cells
     triangulation_cache =
       std_cxx14::make_unique<GridTools::Cache<dim, spacedim>>(new_triangulation,

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.