From 4a5220785023f15750aa8e1103f50b19ae4d0b65 Mon Sep 17 00:00:00 2001 From: "luz.paz" Date: Thu, 20 Sep 2018 22:04:31 -0400 Subject: [PATCH] Misc. typos 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 ``` --- doc/news/3.4.0-vs-4.0.0.h | 2 +- doc/news/8.4.2-vs-8.5.0.h | 2 +- doc/news/8.5.0-vs-9.0.0.h | 4 ++-- examples/step-15/doc/results.dox | 8 +++---- examples/step-29/doc/intro.dox | 2 +- examples/step-29/doc/results.dox | 2 +- examples/step-37/doc/intro.dox | 4 ++-- examples/step-57/doc/gnuplot.gpl | 6 ++--- include/deal.II/base/patterns.h | 16 ++++++------- include/deal.II/base/tensor.h | 4 ++-- .../deal.II/differentiation/ad/ad_drivers.h | 8 +++---- .../deal.II/differentiation/ad/ad_helpers.h | 2 +- .../deal.II/distributed/solution_transfer.h | 2 +- include/deal.II/distributed/tria.h | 2 +- include/deal.II/fe/fe.h | 2 +- include/deal.II/fe/fe_enriched.h | 2 +- include/deal.II/fe/mapping_manifold.h | 2 +- include/deal.II/lac/chunk_sparse_matrix.h | 8 +++---- include/deal.II/lac/chunk_sparsity_pattern.h | 4 ++-- include/deal.II/lac/cuda_precondition.h | 4 ++-- include/deal.II/lac/cuda_sparse_matrix.h | 2 +- .../deal.II/lac/dynamic_sparsity_pattern.h | 4 ++-- include/deal.II/lac/petsc_matrix_base.h | 4 ++-- include/deal.II/lac/sparse_matrix.h | 4 ++-- include/deal.II/lac/sparsity_pattern.h | 4 ++-- include/deal.II/lac/trilinos_epetra_vector.h | 2 +- include/deal.II/lac/trilinos_sparse_matrix.h | 4 ++-- .../deal.II/lac/trilinos_sparsity_pattern.h | 6 ++--- include/deal.II/lac/trilinos_vector.h | 2 +- include/deal.II/matrix_free/mapping_info.h | 2 +- include/deal.II/matrix_free/matrix_free.h | 4 ++-- include/deal.II/meshworker/local_results.h | 10 ++++---- include/deal.II/meshworker/simple.h | 6 ++--- .../deal.II/numerics/vector_tools.templates.h | 4 ++-- include/deal.II/opencascade/manifold_lib.h | 2 +- source/base/partitioner.cc | 2 +- source/base/patterns.cc | 2 +- source/base/table_handler.cc | 2 +- source/distributed/tria.cc | 2 +- source/fe/fe_bdm.cc | 2 +- source/fe/fe_nedelec_sz.cc | 2 +- source/grid/tria.cc | 2 +- source/grid/tria_accessor.cc | 2 +- source/lac/lapack_full_matrix.cc | 2 +- source/lac/trilinos_epetra_vector.cc | 2 +- tests/aniso/solution_transfer.cc | 4 ++-- tests/aniso/solution_transfer.output | 8 +++---- tests/base/quadrature_point_data_03.cc | 2 +- tests/bits/solution_transfer.cc | 8 +++---- tests/bits/solution_transfer.output | 24 +++++++++---------- tests/fe/fe_enriched_color_02.cc | 4 ++-- tests/fe/fe_enriched_color_03.cc | 6 ++--- tests/fe/fe_enriched_color_04.cc | 4 ++-- tests/fe/fe_enriched_color_05.cc | 4 ++-- tests/fe/fe_enriched_color_06.cc | 4 ++-- tests/fe/fe_enriched_color_07.cc | 11 +++++---- tests/fe/fe_enriched_color_08.cc | 4 ++-- tests/fe/fe_values_view_25b_nonsymmetric.cc | 2 +- tests/integrators/cells_and_faces_01.cc | 2 +- tests/integrators/functional_01.cc | 2 +- tests/integrators/mesh_worker_01.cc | 2 +- tests/integrators/mesh_worker_matrix_01.cc | 2 +- tests/lac/block_linear_operator_06.cc | 2 +- tests/lac/utilities_02.cc | 2 +- tests/mpi/mesh_worker_matrix_01.cc | 2 +- tests/mpi/parallel_partitioner_08.cc | 2 +- tests/mpi/tria_01.cc | 2 +- tests/mpi/tria_01.mpirun=10.output | 20 ++++++++-------- tests/mpi/tria_01.mpirun=2.output | 4 ++-- tests/mpi/tria_01.mpirun=4.output | 8 +++---- tests/numerics/history.cc | 2 +- tests/petsc_complex/assemble_01.cc | 4 ++-- tests/tensors/tensor_09.cc | 2 +- 73 files changed, 156 insertions(+), 153 deletions(-) diff --git a/doc/news/3.4.0-vs-4.0.0.h b/doc/news/3.4.0-vs-4.0.0.h index 74e1a82c37..ce73c93c87 100644 --- a/doc/news/3.4.0-vs-4.0.0.h +++ b/doc/news/3.4.0-vs-4.0.0.h @@ -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.
diff --git a/doc/news/8.4.2-vs-8.5.0.h b/doc/news/8.4.2-vs-8.5.0.h index 9f28859de1..c76c3907a7 100644 --- a/doc/news/8.4.2-vs-8.5.0.h +++ b/doc/news/8.4.2-vs-8.5.0.h @@ -2039,7 +2039,7 @@ inconvenience this causes.
  • 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.
    (Mauro Bardelloni, 2016/03/09) diff --git a/doc/news/8.5.0-vs-9.0.0.h b/doc/news/8.5.0-vs-9.0.0.h index e0d52102c4..4dd4c6f316 100644 --- a/doc/news/8.5.0-vs-9.0.0.h +++ b/doc/news/8.5.0-vs-9.0.0.h @@ -700,7 +700,7 @@ inconvenience this causes.
  • 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.
    (Katharina Kormann, Martin Kronbichler, 2018/05/04) @@ -1194,7 +1194,7 @@ inconvenience this causes.
  • 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.
    (Weixiong Zheng, 2018/04/05) diff --git a/examples/step-15/doc/results.dox b/examples/step-15/doc/results.dox index c069966631..3fefe249fe 100644 --- a/examples/step-15/doc/results.dox +++ b/examples/step-15/doc/results.dox @@ -35,19 +35,19 @@ solution. This yields the following set of images:
    Solution after zero cycles with countour lines. + alt="Solution after zero cycles with contour lines." width="230" height="273">
    Solution after one cycle with countour lines. + alt="Solution after one cycle with contour lines." width="230" height="273">
    Solution after two cycles with countour lines. + alt="Solution after two cycles with contour lines." width="230" height="273">
    Solution after three cycles with countour lines. + alt="Solution after three cycles with contour lines." width="230" height="273">
    diff --git a/examples/step-29/doc/intro.dox b/examples/step-29/doc/intro.dox index 32c62b84e3..452a8c20d3 100644 --- a/examples/step-29/doc/intro.dox +++ b/examples/step-29/doc/intro.dox @@ -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 diff --git a/examples/step-29/doc/results.dox b/examples/step-29/doc/results.dox index 04a039f10e..f463c8e8b9 100644 --- a/examples/step-29/doc/results.dox +++ b/examples/step-29/doc/results.dox @@ -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, diff --git a/examples/step-37/doc/intro.dox b/examples/step-37/doc/intro.dox index ad5fb81454..929d817da5 100644 --- a/examples/step-37/doc/intro.dox +++ b/examples/step-37/doc/intro.dox @@ -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 diff --git a/examples/step-57/doc/gnuplot.gpl b/examples/step-57/doc/gnuplot.gpl index f41fd83c04..ded394cc71 100644 --- a/examples/step-57/doc/gnuplot.gpl +++ b/examples/step-57/doc/gnuplot.gpl @@ -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" diff --git a/include/deal.II/base/patterns.h b/include/deal.II/base/patterns.h index 3b30fcfa3b..f5b300a8b0 100644 --- a/include/deal.II/base/patterns.h +++ b/include/deal.II/base/patterns.h @@ -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(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 vec(t.size()); @@ -1932,7 +1932,7 @@ namespace Patterns auto p = dynamic_cast(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 vec(dim); @@ -1959,7 +1959,7 @@ namespace Patterns auto p = dynamic_cast(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(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(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(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(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(); diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index 90f3f20b8d..2aabb6402e 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -1909,7 +1909,7 @@ inline reord_2 = TensorAccessors::reordered_index_view(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), diff --git a/include/deal.II/differentiation/ad/ad_drivers.h b/include/deal.II/differentiation/ad/ad_drivers.h index fa32e3eb68..cef0c87d65 100644 --- a/include/deal.II/differentiation/ad/ad_drivers.h +++ b/include/deal.II/differentiation/ad/ad_drivers.h @@ -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 diff --git a/include/deal.II/differentiation/ad/ad_helpers.h b/include/deal.II/differentiation/ad/ad_helpers.h index b6fa81fd42..ae923e2113 100644 --- a/include/deal.II/differentiation/ad/ad_helpers.h +++ b/include/deal.II/differentiation/ad/ad_helpers.h @@ -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. * diff --git a/include/deal.II/distributed/solution_transfer.h b/include/deal.II/distributed/solution_transfer.h index 925769dcae..9df10505eb 100644 --- a/include/deal.II/distributed/solution_transfer.h +++ b/include/deal.II/distributed/solution_transfer.h @@ -156,7 +156,7 @@ namespace parallel * class, the following requirements have to be met: *
      *
    • - * 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 \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. diff --git a/include/deal.II/fe/mapping_manifold.h b/include/deal.II/fe/mapping_manifold.h index abb93d2524..0ceee849ba 100644 --- a/include/deal.II/fe/mapping_manifold.h +++ b/include/deal.II/fe/mapping_manifold.h @@ -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. * diff --git a/include/deal.II/lac/chunk_sparse_matrix.h b/include/deal.II/lac/chunk_sparse_matrix.h index 0121c4cfd9..ad5c3c08f9 100644 --- a/include/deal.II/lac/chunk_sparse_matrix.h +++ b/include/deal.II/lac/chunk_sparse_matrix.h @@ -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 - * end(r). Note also that the iterator may not be dereferencable in + * end(r). 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 - * end(r). Note also that the iterator may not be dereferencable in + * end(r). 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. * diff --git a/include/deal.II/lac/chunk_sparsity_pattern.h b/include/deal.II/lac/chunk_sparsity_pattern.h index a10034c8da..381ade01f3 100644 --- a/include/deal.II/lac/chunk_sparsity_pattern.h +++ b/include/deal.II/lac/chunk_sparsity_pattern.h @@ -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 - * end(r). Note also that the iterator may not be dereferencable in + * end(r). Note also that the iterator may not be dereferenceable in * that case. */ iterator @@ -679,7 +679,7 @@ public: * Final iterator of row r. 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. */ diff --git a/include/deal.II/lac/cuda_precondition.h b/include/deal.II/lac/cuda_precondition.h index ea3fc7c88f..3854535270 100644 --- a/include/deal.II/lac/cuda_precondition.h +++ b/include/deal.II/lac/cuda_precondition.h @@ -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 diff --git a/include/deal.II/lac/cuda_sparse_matrix.h b/include/deal.II/lac/cuda_sparse_matrix.h index d80210ec81..da24c0f31b 100644 --- a/include/deal.II/lac/cuda_sparse_matrix.h +++ b/include/deal.II/lac/cuda_sparse_matrix.h @@ -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); diff --git a/include/deal.II/lac/dynamic_sparsity_pattern.h b/include/deal.II/lac/dynamic_sparsity_pattern.h index b7496bfb0f..e188579eac 100644 --- a/include/deal.II/lac/dynamic_sparsity_pattern.h +++ b/include/deal.II/lac/dynamic_sparsity_pattern.h @@ -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 - * end(r). Note also that the iterator may not be dereferencable in + * end(r). 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 r. 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. */ diff --git a/include/deal.II/lac/petsc_matrix_base.h b/include/deal.II/lac/petsc_matrix_base.h index 91b3f8a77d..33df20f368 100644 --- a/include/deal.II/lac/petsc_matrix_base.h +++ b/include/deal.II/lac/petsc_matrix_base.h @@ -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 - * end(r). Note also that the iterator may not be dereferencable + * end(r). Note also that the iterator may not be dereferenceable * in that case. */ const_iterator @@ -865,7 +865,7 @@ namespace PETScWrappers * Final iterator of row r. 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. */ diff --git a/include/deal.II/lac/sparse_matrix.h b/include/deal.II/lac/sparse_matrix.h index 325886ece5..ec2731eee3 100644 --- a/include/deal.II/lac/sparse_matrix.h +++ b/include/deal.II/lac/sparse_matrix.h @@ -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 - * end(r). The returned iterator may not be dereferencable in that + * end(r). 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. */ diff --git a/include/deal.II/lac/sparsity_pattern.h b/include/deal.II/lac/sparsity_pattern.h index 16a9661182..37a1be647b 100644 --- a/include/deal.II/lac/sparsity_pattern.h +++ b/include/deal.II/lac/sparsity_pattern.h @@ -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 - * end(r). Note also that the iterator may not be dereferencable in + * end(r). 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 r. 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. */ diff --git a/include/deal.II/lac/trilinos_epetra_vector.h b/include/deal.II/lac/trilinos_epetra_vector.h index 6b27b21354..b11b63ca61 100644 --- a/include/deal.II/lac/trilinos_epetra_vector.h +++ b/include/deal.II/lac/trilinos_epetra_vector.h @@ -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 & diff --git a/include/deal.II/lac/trilinos_sparse_matrix.h b/include/deal.II/lac/trilinos_sparse_matrix.h index 28a6429772..ed9f193523 100644 --- a/include/deal.II/lac/trilinos_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_sparse_matrix.h @@ -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 - * end(r). The returned iterator may not be dereferencable in + * end(r). 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. */ diff --git a/include/deal.II/lac/trilinos_sparsity_pattern.h b/include/deal.II/lac/trilinos_sparsity_pattern.h index b93709d4e3..76bf07e558 100644 --- a/include/deal.II/lac/trilinos_sparsity_pattern.h +++ b/include/deal.II/lac/trilinos_sparsity_pattern.h @@ -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 - * end(r). Note also that the iterator may not be dereferencable + * end(r). Note also that the iterator may not be dereferenceable * in that case. */ const_iterator @@ -1110,7 +1110,7 @@ namespace TrilinosWrappers * Final iterator of row r. 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. */ diff --git a/include/deal.II/lac/trilinos_vector.h b/include/deal.II/lac/trilinos_vector.h index 29a9555829..5443954e0a 100644 --- a/include/deal.II/lac/trilinos_vector.h +++ b/include/deal.II/lac/trilinos_vector.h @@ -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 & diff --git a/include/deal.II/matrix_free/mapping_info.h b/include/deal.II/matrix_free/mapping_info.h index d9eb4ce39e..f7fda0ce3d 100644 --- a/include/deal.II/matrix_free/mapping_info.h +++ b/include/deal.II/matrix_free/mapping_info.h @@ -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 data_index_offsets; diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index 0821cb4d22..d38ed5055f 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -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 constexpr unsigned int diff --git a/include/deal.II/meshworker/local_results.h b/include/deal.II/meshworker/local_results.h index fc07001e7f..0a0a74562a 100644 --- a/include/deal.II/meshworker/local_results.h +++ b/include/deal.II/meshworker/local_results.h @@ -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: * *
        *
      1. 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; diff --git a/include/deal.II/meshworker/simple.h b/include/deal.II/meshworker/simple.h index c557733659..3a91188ab2 100644 --- a/include/deal.II/meshworker/simple.h +++ b/include/deal.II/meshworker/simple.h @@ -30,9 +30,9 @@ #include /* - * 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 diff --git a/include/deal.II/numerics/vector_tools.templates.h b/include/deal.II/numerics/vector_tools.templates.h index 2a06dd02d0..1058b86875 100644 --- a/include/deal.II/numerics/vector_tools.templates.h +++ b/include/deal.II/numerics/vector_tools.templates.h @@ -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. // diff --git a/include/deal.II/opencascade/manifold_lib.h b/include/deal.II/opencascade/manifold_lib.h index 30f63fe836..0a7c3cc0d4 100644 --- a/include/deal.II/opencascade/manifold_lib.h +++ b/include/deal.II/opencascade/manifold_lib.h @@ -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 * diff --git a/source/base/partitioner.cc b/source/base/partitioner.cc index 72dfaec531..75a45a9df7 100644 --- a/source/base/partitioner.cc +++ b/source/base/partitioner.cc @@ -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 expanded_import_indices( diff --git a/source/base/patterns.cc b/source/base/patterns.cc index 4e883abea1..b1f6835254 100644 --- a/source/base/patterns.cc +++ b/source/base/patterns.cc @@ -871,7 +871,7 @@ namespace Patterns std::vector 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; diff --git a/source/base/table_handler.cc b/source/base/table_handler.cc index 9b8110df98..58c37007c9 100644 --- a/source/base/table_handler.cc +++ b/source/base/table_handler.cc @@ -812,7 +812,7 @@ TableHandler::get_selected_columns(std::vector &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::size_type n = 0; for (std::map::iterator p = columns.begin(); diff --git a/source/distributed/tria.cc b/source/distributed/tria.cc index cacfb34fc4..f5dfbd5a69 100644 --- a/source/distributed/tria.cc +++ b/source/distributed/tria.cc @@ -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(); } diff --git a/source/fe/fe_bdm.cc b/source/fe/fe_bdm.cc index b6cef0280c..5f06335fa2 100644 --- a/source/fe/fe_bdm.cc +++ b/source/fe/fe_bdm.cc @@ -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 diff --git a/source/fe/fe_nedelec_sz.cc b/source/fe/fe_nedelec_sz.cc index daae79ef21..dce21dcebe 100644 --- a/source/fe/fe_nedelec_sz.cc +++ b/source/fe/fe_nedelec_sz.cc @@ -213,7 +213,7 @@ FE_NedelecSZ::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. diff --git a/source/grid/tria.cc b/source/grid/tria.cc index 5f98cf9d3f..f0e6233c32 100644 --- a/source/grid/tria.cc +++ b/source/grid/tria.cc @@ -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). diff --git a/source/grid/tria_accessor.cc b/source/grid/tria_accessor.cc index 5e58dc5ac6..c6fb426ab2 100644 --- a/source/grid/tria_accessor.cc +++ b/source/grid/tria_accessor.cc @@ -2517,7 +2517,7 @@ CellAccessor::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. diff --git a/source/lac/lapack_full_matrix.cc b/source/lac/lapack_full_matrix.cc index 933aef006b..a516bddb57 100644 --- a/source/lac/lapack_full_matrix.cc +++ b/source/lac/lapack_full_matrix.cc @@ -991,7 +991,7 @@ LAPACKFullMatrix::Tmmult(LAPACKFullMatrix & 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 diff --git a/source/lac/trilinos_epetra_vector.cc b/source/lac/trilinos_epetra_vector.cc index 36d38cf164..202fa08f68 100644 --- a/source/lac/trilinos_epetra_vector.cc +++ b/source/lac/trilinos_epetra_vector.cc @@ -150,7 +150,7 @@ namespace LinearAlgebra VectorOperation::values operation, std::shared_ptr 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) { diff --git a/tests/aniso/solution_transfer.cc b/tests/aniso/solution_transfer.cc index c2b36e1847..ed5366bce9 100644 --- a/tests/aniso/solution_transfer.cc +++ b/tests/aniso/solution_transfer.cc @@ -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); } diff --git a/tests/aniso/solution_transfer.output b/tests/aniso/solution_transfer.output index 502ed4c500..2b774861ad 100644 --- a/tests/aniso/solution_transfer.output +++ b/tests/aniso/solution_transfer.output @@ -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. diff --git a/tests/base/quadrature_point_data_03.cc b/tests/base/quadrature_point_data_03.cc index 72cc74526f..308cbc935a 100644 --- a/tests/base/quadrature_point_data_03.cc +++ b/tests/base/quadrature_point_data_03.cc @@ -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. diff --git a/tests/bits/solution_transfer.cc b/tests/bits/solution_transfer.cc index 77d02cdcc8..b96a25e29a 100644 --- a/tests/bits/solution_transfer.cc +++ b/tests/bits/solution_transfer.cc @@ -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); diff --git a/tests/bits/solution_transfer.output b/tests/bits/solution_transfer.output index 4910611a17..585c25a451 100644 --- a/tests/bits/solution_transfer.output +++ b/tests/bits/solution_transfer.output @@ -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. diff --git a/tests/fe/fe_enriched_color_02.cc b/tests/fe/fe_enriched_color_02.cc index 3b1511685c..3051eb3cb5 100644 --- a/tests/fe/fe_enriched_color_02.cc +++ b/tests/fe/fe_enriched_color_02.cc @@ -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; diff --git a/tests/fe/fe_enriched_color_03.cc b/tests/fe/fe_enriched_color_03.cc index 737038583a..0f6523cf8c 100644 --- a/tests/fe/fe_enriched_color_03.cc +++ b/tests/fe/fe_enriched_color_03.cc @@ -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()]) diff --git a/tests/fe/fe_enriched_color_04.cc b/tests/fe/fe_enriched_color_04.cc index e572ed515a..fb300b2d6e 100644 --- a/tests/fe/fe_enriched_color_04.cc +++ b/tests/fe/fe_enriched_color_04.cc @@ -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; diff --git a/tests/fe/fe_enriched_color_05.cc b/tests/fe/fe_enriched_color_05.cc index 02a4d5b6d4..493f97eee1 100644 --- a/tests/fe/fe_enriched_color_05.cc +++ b/tests/fe/fe_enriched_color_05.cc @@ -159,8 +159,8 @@ plot_shape_function(hp::DoFHandler &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; diff --git a/tests/fe/fe_enriched_color_06.cc b/tests/fe/fe_enriched_color_06.cc index 3488db483a..f96dc4231a 100644 --- a/tests/fe/fe_enriched_color_06.cc +++ b/tests/fe/fe_enriched_color_06.cc @@ -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; diff --git a/tests/fe/fe_enriched_color_07.cc b/tests/fe/fe_enriched_color_07.cc index 407d68b9f4..8170d64d97 100644 --- a/tests/fe/fe_enriched_color_07.cc +++ b/tests/fe/fe_enriched_color_07.cc @@ -1803,7 +1803,7 @@ LaplaceProblem::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")); } } } diff --git a/tests/fe/fe_enriched_color_08.cc b/tests/fe/fe_enriched_color_08.cc index f58cab5ab8..64c86c3436 100644 --- a/tests/fe/fe_enriched_color_08.cc +++ b/tests/fe/fe_enriched_color_08.cc @@ -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; diff --git a/tests/fe/fe_values_view_25b_nonsymmetric.cc b/tests/fe/fe_values_view_25b_nonsymmetric.cc index 8e7f1e9bd4..10e8c75d1d 100644 --- a/tests/fe/fe_values_view_25b_nonsymmetric.cc +++ b/tests/fe/fe_values_view_25b_nonsymmetric.cc @@ -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. diff --git a/tests/integrators/cells_and_faces_01.cc b/tests/integrators/cells_and_faces_01.cc index 989b7f4495..e2426ede39 100644 --- a/tests/integrators/cells_and_faces_01.cc +++ b/tests/integrators/cells_and_faces_01.cc @@ -14,7 +14,7 @@ // --------------------------------------------------------------------- -// Test whether Assember::CellsAndFaces adds up correctly. +// Test whether Assembler::CellsAndFaces adds up correctly. #include diff --git a/tests/integrators/functional_01.cc b/tests/integrators/functional_01.cc index 61a0b2b184..416204794a 100644 --- a/tests/integrators/functional_01.cc +++ b/tests/integrators/functional_01.cc @@ -14,7 +14,7 @@ // --------------------------------------------------------------------- -// Test whether Assember::Functional adds up correctly. +// Test whether Assembler::Functional adds up correctly. #include diff --git a/tests/integrators/mesh_worker_01.cc b/tests/integrators/mesh_worker_01.cc index 3b088b3f6a..de20efd6b0 100644 --- a/tests/integrators/mesh_worker_01.cc +++ b/tests/integrators/mesh_worker_01.cc @@ -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 diff --git a/tests/integrators/mesh_worker_matrix_01.cc b/tests/integrators/mesh_worker_matrix_01.cc index 7af8b420b9..2d5be91da9 100644 --- a/tests/integrators/mesh_worker_matrix_01.cc +++ b/tests/integrators/mesh_worker_matrix_01.cc @@ -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 diff --git a/tests/lac/block_linear_operator_06.cc b/tests/lac/block_linear_operator_06.cc index 8329a101f6..b7d329e8ee 100644 --- a/tests/lac/block_linear_operator_06.cc +++ b/tests/lac/block_linear_operator_06.cc @@ -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 #include diff --git a/tests/lac/utilities_02.cc b/tests/lac/utilities_02.cc index 829df9a24b..6234a2ff30 100644 --- a/tests/lac/utilities_02.cc +++ b/tests/lac/utilities_02.cc @@ -170,7 +170,7 @@ test() invM * linear_operator>(laplace) * invM; - // Do actuall work: + // Do actual work: LinearAlgebra::distributed::Vector init_vector; mf_data->initialize_dof_vector(init_vector); for (auto it = init_vector.begin(); it != init_vector.end(); ++it) diff --git a/tests/mpi/mesh_worker_matrix_01.cc b/tests/mpi/mesh_worker_matrix_01.cc index 65b953092c..9dbe422fb9 100644 --- a/tests/mpi/mesh_worker_matrix_01.cc +++ b/tests/mpi/mesh_worker_matrix_01.cc @@ -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 diff --git a/tests/mpi/parallel_partitioner_08.cc b/tests/mpi/parallel_partitioner_08.cc index 754f272ce7..2be3b9ddf3 100644 --- a/tests/mpi/parallel_partitioner_08.cc +++ b/tests/mpi/parallel_partitioner_08.cc @@ -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 diff --git a/tests/mpi/tria_01.cc b/tests/mpi/tria_01.cc index df0d7cdd71..f92532847b 100644 --- a/tests/mpi/tria_01.cc +++ b/tests/mpi/tria_01.cc @@ -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; diff --git a/tests/mpi/tria_01.mpirun=10.output b/tests/mpi/tria_01.mpirun=10.output index ffc818c011..7322991f7d 100644 --- a/tests/mpi/tria_01.mpirun=10.output +++ b/tests/mpi/tria_01.mpirun=10.output @@ -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 diff --git a/tests/mpi/tria_01.mpirun=2.output b/tests/mpi/tria_01.mpirun=2.output index 377ec968f7..32ddd68daf 100644 --- a/tests/mpi/tria_01.mpirun=2.output +++ b/tests/mpi/tria_01.mpirun=2.output @@ -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 diff --git a/tests/mpi/tria_01.mpirun=4.output b/tests/mpi/tria_01.mpirun=4.output index 8f59b65bd9..158588cbfd 100644 --- a/tests/mpi/tria_01.mpirun=4.output +++ b/tests/mpi/tria_01.mpirun=4.output @@ -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 diff --git a/tests/numerics/history.cc b/tests/numerics/history.cc index 5faf394b52..7dabf8eaf6 100644 --- a/tests/numerics/history.cc +++ b/tests/numerics/history.cc @@ -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; diff --git a/tests/petsc_complex/assemble_01.cc b/tests/petsc_complex/assemble_01.cc index a94ca21541..d675fee099 100644 --- a/tests/petsc_complex/assemble_01.cc +++ b/tests/petsc_complex/assemble_01.cc @@ -15,8 +15,8 @@ // Check that all the functionality needed for calling -// AffineConstraints::distribute_local_to_global on mutiple combinations -// of PETScWrappers objects is correctly instantiated and works. +// AffineConstraints::distribute_local_to_global on multiple +// combinations of PETScWrappers objects is correctly instantiated and works. #include #include diff --git a/tests/tensors/tensor_09.cc b/tests/tensors/tensor_09.cc index 7bc3bbc664..4376d55ac8 100644 --- a/tests/tensors/tensor_09.cc +++ b/tests/tensors/tensor_09.cc @@ -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 -- 2.39.5