From 90963e85f586bbb2e23c69f248ccf5027ae48b2a Mon Sep 17 00:00:00 2001 From: "luz.paz" Date: Mon, 29 Apr 2019 15:49:00 -0400 Subject: [PATCH] Misc. typos Found via `codespell -q 3 -I ../dealii-word-whitelist.txt -S ./bundled` --- contrib/utilities/generate_lapack_templates | 2 +- contrib/utilities/indent | 2 +- contrib/utilities/indent.py | 2 +- .../headers/automatic_and_symbolic_differentiation.h | 4 ++-- doc/doxygen/headers/manifold.h | 2 +- doc/news/changes/minor/20181006LucaHeltai | 2 +- examples/step-44/step-44.cc | 2 +- examples/step-53/doc/intro.dox | 2 +- examples/step-61/doc/intro.dox | 2 +- examples/step-61/doc/results.dox | 2 +- examples/step-7/step-7.cc | 2 +- include/deal.II/algorithms/general_data_storage.h | 2 +- include/deal.II/base/function_lib.h | 4 ++-- include/deal.II/base/hdf5.h | 2 +- include/deal.II/base/symmetric_tensor.templates.h | 2 +- include/deal.II/differentiation/ad/ad_drivers.h | 2 +- include/deal.II/differentiation/ad/ad_helpers.h | 2 +- .../differentiation/sd/symengine_number_types.h | 2 +- .../differentiation/sd/symengine_scalar_operations.h | 6 +++--- .../differentiation/sd/symengine_tensor_operations.h | 12 ++++++------ .../deal.II/differentiation/sd/symengine_utilities.h | 4 ++-- include/deal.II/dofs/dof_objects.h | 2 +- include/deal.II/dofs/dof_tools.h | 4 ++-- include/deal.II/fe/fe_tools.templates.h | 2 +- include/deal.II/grid/manifold_lib.h | 2 +- include/deal.II/hp/fe_collection.h | 2 +- include/deal.II/integrators/advection.h | 4 ++-- include/deal.II/lac/affine_constraints.h | 2 +- include/deal.II/lac/cuda_solver_direct.h | 2 +- include/deal.II/lac/trilinos_tpetra_vector.h | 2 +- .../deal.II/lac/trilinos_tpetra_vector.templates.h | 2 +- .../matrix_free/cuda_hanging_nodes_internal.h | 2 +- include/deal.II/meshworker/scratch_data.h | 2 +- source/differentiation/ad/ad_drivers.cc | 4 ++-- source/fe/fe_enriched.cc | 2 +- source/grid/grid_tools.cc | 2 +- source/lac/cuda_sparse_matrix.cu | 2 +- source/non_matching/coupling.cc | 6 +++--- tests/base/assign_subscriptor.cc | 2 +- tests/base/assign_subscriptor.debug.output | 2 +- tests/base/hdf5_03.cc | 2 +- tests/base/hdf5_04.cc | 2 +- tests/base/hdf5_05.cc | 2 +- tests/base/hdf5_06.cc | 2 +- tests/cuda/array_view_wrong_memory.cu | 2 +- tests/grid/grid_in_ucd_01.cc | 2 +- tests/lac/linear_operator_13.cc | 2 +- tests/lac/linear_operator_14.cc | 2 +- tests/manifold/tensor_product_manifold_03.cc | 2 +- tests/mpi/hp_refinement_02.cc | 2 +- tests/mpi/p4est_3d_refine_01.cc | 2 +- tests/optimization/step-44.h | 2 +- tests/petsc/full_matrix_00.cc | 2 +- tests/tests.h | 2 +- 54 files changed, 69 insertions(+), 69 deletions(-) diff --git a/contrib/utilities/generate_lapack_templates b/contrib/utilities/generate_lapack_templates index af3e009e7e..d86e466800 100755 --- a/contrib/utilities/generate_lapack_templates +++ b/contrib/utilities/generate_lapack_templates @@ -557,7 +557,7 @@ def main(): routines.append(FortranRoutine(file_name, guard_fp)) except NotImplementedError: # not a lot we can do. If its in the whitelist we will fail - # again later anway + # again later anyway continue routines.sort(key=lambda u: u.general_name) diff --git a/contrib/utilities/indent b/contrib/utilities/indent index ca889f7fcd..9cb6892274 100755 --- a/contrib/utilities/indent +++ b/contrib/utilities/indent @@ -17,7 +17,7 @@ # # This script does the same thing as contrib/utilities/indent-all but only # reformats files which have changed (or have been added but neither -# staged/commited) since the last merge commit to the master branch. +# staged/committed) since the last merge commit to the master branch. # # The script needs to be executed as # ./contrib/utilities/indent diff --git a/contrib/utilities/indent.py b/contrib/utilities/indent.py index 0ca683d708..82ba521487 100644 --- a/contrib/utilities/indent.py +++ b/contrib/utilities/indent.py @@ -112,7 +112,7 @@ def parse_arguments(): "By default only \"examples\", \"include\", " "\"source\" and \"tests\" " "directories are chosen to work on." - "Path to directories can be both abosulte or relative.") + "Path to directories can be both absolute or relative.") parser.add_argument("-j", metavar="THREAD_COUNT", type=int, default=0, help="Number of clang-format instances to be run " diff --git a/doc/doxygen/headers/automatic_and_symbolic_differentiation.h b/doc/doxygen/headers/automatic_and_symbolic_differentiation.h index ae5178e2c8..2a15a2ae0b 100644 --- a/doc/doxygen/headers/automatic_and_symbolic_differentiation.h +++ b/doc/doxygen/headers/automatic_and_symbolic_differentiation.h @@ -96,7 +96,7 @@ * that, with the appropriate implementation, both first and second derivatives can be computed exactly. * -# With taped approaches, a specified subregion of code is selected as one for which all * operations executed with active (marked) input variables are tracked and recorded in a data structure - * referred to as a tape. At the end of the taped region, the recorded function(s) may be revaluated + * referred to as a tape. At the end of the taped region, the recorded function(s) may be reevaluated * by "replaying" the tape with a different set of input variables instead of recomputing the function * directly. Assuming that the taped region represents a smooth function, arbitrarily high-order * derivatives of the function then can be computed by referring to the code path tracked and stored on @@ -232,7 +232,7 @@ * graph is required. * * In reverse-mode, the chain-rule is computed somewhat unnaturally from the "outside in". The - * values of the dependent variables first get computed and fixed, and then the preceeding + * values of the dependent variables first get computed and fixed, and then the preceding * differential operations are evaluated and multiplied in succession with the previous results * from left to right. Again, if we encapsulate and fix the order of operations using parentheses, * this implies that the reverse calculation is performed by diff --git a/doc/doxygen/headers/manifold.h b/doc/doxygen/headers/manifold.h index 0eb3b05b48..84e04ef379 100644 --- a/doc/doxygen/headers/manifold.h +++ b/doc/doxygen/headers/manifold.h @@ -60,7 +60,7 @@ * in the Mapping class (see the @ref mapping module), which however obtains * its information about the boundary of the domain from the classes * described here. The same is, of course, true when integrating boundary - * terms (e.g., inhomogenous Neumann boundary conditions). + * terms (e.g., inhomogeneous Neumann boundary conditions). * *
  • Domains with nonzero codimension: In cases where a Triangulation is * embedded into a higher dimensional space, i.e., whenever the second diff --git a/doc/news/changes/minor/20181006LucaHeltai b/doc/news/changes/minor/20181006LucaHeltai index ea8e3d0ec8..f1426feb81 100644 --- a/doc/news/changes/minor/20181006LucaHeltai +++ b/doc/news/changes/minor/20181006LucaHeltai @@ -1,4 +1,4 @@ -New: Added RTree class and pack_rtree() function to create a boost::gemoetry::index::rtree from +New: Added RTree class and pack_rtree() function to create a boost::geometry::index::rtree from containers and/or iterators of BoundingBox, Point, or Segment objects.
    (Luca Heltai, 2018/10/06) diff --git a/examples/step-44/step-44.cc b/examples/step-44/step-44.cc index 1cbc8c8194..7a60db62fe 100644 --- a/examples/step-44/step-44.cc +++ b/examples/step-44/step-44.cc @@ -2440,7 +2440,7 @@ namespace Step44 // build non-homogeneous constraints in the zeroth iteration (that is, when // `apply_dirichlet_bc == true`) and build only the corresponding // homogeneous constraints in the following step. While the current - // example has only homogenous constraints, previous experiences have + // example has only homogeneous constraints, previous experiences have // shown that a common error is forgetting to add the extra condition when // refactoring the code to specific uses. This could lead errors that are // hard to debug. In this spirit, we choose to make the code more verbose diff --git a/examples/step-53/doc/intro.dox b/examples/step-53/doc/intro.dox index cfe64dd35f..f5c51da666 100644 --- a/examples/step-53/doc/intro.dox +++ b/examples/step-53/doc/intro.dox @@ -72,7 +72,7 @@ program the details of your geometry: necessary to compute integrals using curved approximations of the boundary, i.e., describe each edge or face of cells as curves, instead of straight line segments or bilinear patches. The same is, of course, true when - integrating boundary terms (e.g., inhomogenous Neumann boundary + integrating boundary terms (e.g., inhomogeneous Neumann boundary conditions). For the purpose of integration, the various Mapping classes then provide the transformation from the reference cell to the actual cell. diff --git a/examples/step-61/doc/intro.dox b/examples/step-61/doc/intro.dox index a93d150da1..8173bdbc23 100644 --- a/examples/step-61/doc/intro.dox +++ b/examples/step-61/doc/intro.dox @@ -88,7 +88,7 @@ be important in the considerations below. In this program, we will consider a test case where the exact pressure is $p = \sin \left( \pi x\right)\sin\left(\pi y \right)$ on the unit square domain, -with homogenous Dirichelet boundary conditions and $\mathbf{K}$ the identity matrix. +with homogeneous Dirichelet boundary conditions and $\mathbf{K}$ the identity matrix. Then we will calculate $L_2$ errors of pressure, velocity, and flux. diff --git a/examples/step-61/doc/results.dox b/examples/step-61/doc/results.dox index 37eb72eccf..41b73af8e5 100644 --- a/examples/step-61/doc/results.dox +++ b/examples/step-61/doc/results.dox @@ -1,6 +1,6 @@

    Results

    -We run the test example $p = \sin(\pi x) \sin(\pi y)$ with homogenous Dirichelet +We run the test example $p = \sin(\pi x) \sin(\pi y)$ with homogeneous Dirichelet boundary conditions in the domain $\Omega = (0,1)^2$. And $\mathbf{K}$ is the identity matrix. We test it on $\mbox{WG}(Q_0,Q_0;RT_{[0]})$, $\mbox{WG}(Q_1,Q_1;RT_{[1]})$ and $\mbox{WG}(Q_2,Q_2;RT_{[2]})$. We will visualize pressure values in interiors diff --git a/examples/step-7/step-7.cc b/examples/step-7/step-7.cc index 223460cf7d..f9c8fb1c6f 100644 --- a/examples/step-7/step-7.cc +++ b/examples/step-7/step-7.cc @@ -378,7 +378,7 @@ namespace Step7 // // We will show here how the library managed to find out that there are // still active references to an object and the object is still alive - // frome the point of view of a using object. Basically, the method is along + // from the point of view of a using object. Basically, the method is along // the following line: all objects that are subject to such potentially // dangerous pointers are derived from a class called Subscriptor. For // example, the Triangulation, DoFHandler, and a base class of the diff --git a/include/deal.II/algorithms/general_data_storage.h b/include/deal.II/algorithms/general_data_storage.h index 2517b41149..dfbc3bd073 100644 --- a/include/deal.II/algorithms/general_data_storage.h +++ b/include/deal.II/algorithms/general_data_storage.h @@ -145,7 +145,7 @@ public: * = *ptr_to_some_number; // Invalid call * @endcode * - * Similar to the first example, we must be concious of the fact that the + * Similar to the first example, we must be conscious of the fact that the * copies of any @p Type stored by @p data only remains valid while the * GeneralDataStorage instance in which it is stored is alive. * diff --git a/include/deal.II/base/function_lib.h b/include/deal.II/base/function_lib.h index adca58384c..4e8645b7df 100644 --- a/include/deal.II/base/function_lib.h +++ b/include/deal.II/base/function_lib.h @@ -1022,7 +1022,7 @@ namespace Functions const unsigned int selected; /** - * Flag that controls wether we rescale the value when the radius changes. + * Flag that controls whether we rescale the value when the radius changes. */ bool integrate_to_one; @@ -1070,7 +1070,7 @@ namespace Functions const bool integrate_to_one = false); /** - * Initialize the class with an objet of type + * Initialize the class with an object of type * @tparam CutOffFunctionBaseType<1>. */ template