From: David Wells Date: Mon, 13 Jun 2022 16:49:22 +0000 (-0400) Subject: Run codespell X-Git-Tag: v9.4.0-rc1~24^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=70ba022804c4977c5d81b8dc34aa8ea5769d9fce;p=dealii.git Run codespell --- diff --git a/examples/doxygen/step_3_mixed.cc b/examples/doxygen/step_3_mixed.cc index 4373f6eddd..0c87661973 100644 --- a/examples/doxygen/step_3_mixed.cc +++ b/examples/doxygen/step_3_mixed.cc @@ -68,7 +68,7 @@ * quadrilaterals, we have discussed in step-3: we selected an appropriate * finite element, quadrature rule and mapping object, e.g., FE_Q, QGauss, and * MappingFE (initialized with FE_Q). For simplex meshes, we selected in - * step-3simplex FE_SimplexP, QGaussSimplex, and MappingFE (intialized with + * step-3simplex FE_SimplexP, QGaussSimplex, and MappingFE (initialized with * FE_SimplexP). * * For mixed meshes, we need multiple finite elements, quadrature rules, and diff --git a/examples/step-66/doc/results.dox b/examples/step-66/doc/results.dox index 28a7f95b28..d640fd5f15 100644 --- a/examples/step-66/doc/results.dox +++ b/examples/step-66/doc/results.dox @@ -191,7 +191,7 @@ reduces the number of CG iterations by a few steps.

Possibilities for extensions

-A couple of possible extensions are available concerning minor updates fo the +A couple of possible extensions are available concerning minor updates to the present code as well as a deeper numerical investigation of the Gelfand problem.

More sophisticated Newton iteration

diff --git a/examples/step-70/doc/results.dox b/examples/step-70/doc/results.dox index 7fdb2d5469..cfe15bf5e9 100644 --- a/examples/step-70/doc/results.dox +++ b/examples/step-70/doc/results.dox @@ -226,7 +226,7 @@ The rationale behind creating first `parameters.prm` file (the first time the program is run) and then a `output/parameters_22.prm` (every time you run the program with an existing input file), is because you may want to leave most parameters to their -default values, and only modify a handful of them, while still beeing able to +default values, and only modify a handful of them, while still being able to reproduce the results and inspect what parameters were used for a specific simulation. It is generally good scientific practice to store the parameter file you used for a simulation along with the simulation diff --git a/examples/step-71/step-71.cc b/examples/step-71/step-71.cc index cd68cdb3b5..da0f91306c 100644 --- a/examples/step-71/step-71.cc +++ b/examples/step-71/step-71.cc @@ -1797,7 +1797,7 @@ namespace Step71 // calculations. These essentially act as the input arguments to // all dependent functions that the @p optimizer must evaluate. // They are, collectively, the independent variables - // for the problem, the history variables, the time step sie and the + // for the problem, the history variables, the time step size and the // constitutive parameters (since we've not hard encoded them in the // energy density function). // diff --git a/examples/step-81/doc/intro.dox b/examples/step-81/doc/intro.dox index 886405df79..4c46d4bd7e 100644 --- a/examples/step-81/doc/intro.dox +++ b/examples/step-81/doc/intro.dox @@ -114,7 +114,7 @@ atomic thickness it is an example of a so-called 2D material: Compared to the other spatial dimensions (where graphene samples can reach up to several centimeters) the atomistic thickness of graphene typically ranges around 2.5 ångstrom ($2.5\times10^{-10}\text{m}$). We will thus model -graphene as a lower-dimensional interface $\Sigma$ imbedded into the +graphene as a lower-dimensional interface $\Sigma$ embedded into the computational domain $\Omega\subset\mathbb{R}^d$. More precisely, $\Sigma$ is a two-dimensional sheet in three spatial dimensions, or a one-dimensional line in two spatial dimensions. The special electronic diff --git a/examples/step-82/doc/intro.dox b/examples/step-82/doc/intro.dox index a2754071dd..6796fc0412 100644 --- a/examples/step-82/doc/intro.dox +++ b/examples/step-82/doc/intro.dox @@ -9,7 +9,7 @@

Introduction

-

Problem statment

+

Problem Statement

In this example, we consider the local discontinuous Galerkin (LDG) method for approximating the solution to the bi-Laplacian problem, @f{align*}{ @@ -17,7 +17,7 @@ In this example, we consider the local discontinuous Galerkin (LDG) metho \nabla u & = \mathbf{0} \quad \mbox{on } \partial\Omega, \\ u & = 0 \quad \mbox{on } \partial\Omega, @f} -where $\Omega\subset\mathbb{R}^d$ $(d=2,3)$ is an open bounded Lipschitz domain and $f\in L^2(\Omega)$. This is the same problem we have already considered in step-47, but we will take here a different approach towards solving it: Rather than using continuous finite elements and the interior penalty method, we consider discontinuous finite elements and the local discontinous Galerkin method defined using lifting operators. +where $\Omega\subset\mathbb{R}^d$ $(d=2,3)$ is an open bounded Lipschitz domain and $f\in L^2(\Omega)$. This is the same problem we have already considered in step-47, but we will take here a different approach towards solving it: Rather than using continuous finite elements and the interior penalty method, we consider discontinuous finite elements and the local discontinuous Galerkin method defined using lifting operators. The weak formulation of this problem reads as follows: find $u\in H_0^2(\Omega)$ such that @f[ @@ -243,7 +243,7 @@ where $\mathbf{n}_{K_c}$ (resp. $\mathbf{n}_{K_n}$) denotes the outward unit nor @f[ G_m=\int_e\average{{\rm div}\, \psi_m}\cdot\mathbf{n}_e\jump{\varphi^c}=\frac{1}{2}\int_e{\rm div}\, \psi_m\cdot\mathbf{n}_{K_c}\varphi^c, @f] -while if $\varphi=\varphi^n$, namely $\varphi$ has support on the neighbhoring cell $K_n$, then +while if $\varphi=\varphi^n$, namely $\varphi$ has support on the neighboring cell $K_n$, then @f[ G_m=\int_e\average{{\rm div}\, \psi_m}\cdot\mathbf{n}_e\jump{\varphi^n}=\frac{1}{2}\int_e{\rm div}\, \psi_m\cdot\mathbf{n}_{K_n}\varphi^n. @f] diff --git a/examples/step-82/step-82.cc b/examples/step-82/step-82.cc index 1f1c2b24e4..a0f0eb3cce 100644 --- a/examples/step-82/step-82.cc +++ b/examples/step-82/step-82.cc @@ -1260,7 +1260,7 @@ namespace Step82 const bool at_boundary = face->at_boundary(); - // Recall that by convention, the average of a function accross a + // Recall that by convention, the average of a function across a // boundary face $e$ reduces to the trace of the function on the // only element adjacent to $e$, namely there is no factor // $\frac{1}{2}$. We distinguish between the two cases (the current diff --git a/include/deal.II/base/mpi.h b/include/deal.II/base/mpi.h index 9dd3af6b0a..3391859bf3 100644 --- a/include/deal.II/base/mpi.h +++ b/include/deal.II/base/mpi.h @@ -531,7 +531,7 @@ namespace Utilities * process messages of sizes larger than 2 GB with MPI_Byte as the * underlying data type. This helper is required for MPI versions before 4.0 * because routines like `MPI_Send` - * use a signed interger for the @p count variable. Instead, you can use this + * use a signed integer for the @p count variable. Instead, you can use this * data type with the appropriate size set to the size of your message and * by passing * 1 as the @p count. diff --git a/include/deal.II/base/subscriptor.h b/include/deal.II/base/subscriptor.h index c018b04fae..efb009547b 100644 --- a/include/deal.II/base/subscriptor.h +++ b/include/deal.II/base/subscriptor.h @@ -36,7 +36,7 @@ DEAL_II_NAMESPACE_OPEN * This class, as a base class, allows to keep track of other objects using a * specific object. It is used to avoid that pointers that point to an object of * a class derived from Subscriptor are referenced after that object has been - * invalidated. Here, invalidation is assumend to happen when the object is + * invalidated. Here, invalidation is assumed to happen when the object is * moved from or destroyed. * The mechanism works as follows: The member function subscribe() accepts a * pointer to a boolean that is modified on invalidation. The object that owns diff --git a/include/deal.II/cgal/utilities.h b/include/deal.II/cgal/utilities.h index 44e46bc511..0bb57f6580 100644 --- a/include/deal.II/cgal/utilities.h +++ b/include/deal.II/cgal/utilities.h @@ -194,7 +194,7 @@ namespace CGALWrappers /** * Given a CGAL Triangulation describing a polyhedral region, create - * a Quadrature rule to integrate over the polygon by looping trough all the + * a Quadrature rule to integrate over the polygon by looping through all the * vertices and exploiting QGaussSimplex. * * @param[in] tria The CGAL triangulation object describing the polyhedral diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index 3d31499578..f6bbfd0850 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -1099,7 +1099,7 @@ namespace parallel * combination with the Triangulation::Signals::post_p4est_refinement * signal. At this stage, the p4est oracle already has been refined, but * the triangulation is still unchanged. After the modification, all - * refine and coarsen flags describe how the traingulation will actually + * refine and coarsen flags describe how the triangulation will actually * be refined. * * The use of this class is demonstrated in step-75. diff --git a/include/deal.II/dofs/dof_renumbering.h b/include/deal.II/dofs/dof_renumbering.h index 39136671bc..999c031044 100644 --- a/include/deal.II/dofs/dof_renumbering.h +++ b/include/deal.II/dofs/dof_renumbering.h @@ -1257,7 +1257,7 @@ namespace DoFRenumbering * distributes DoFs: i.e., for a given support point, the global dof indices * for component i should be less than the global dof indices for component i * + 1. Due to various technical complications (like DoF unification in - * hp-mode) this assumption needs to be satified for this function to work in + * hp-mode) this assumption needs to be satisfied for this function to work in * all relevant cases. */ template diff --git a/include/deal.II/fe/fe_q_iso_q1.h b/include/deal.II/fe/fe_q_iso_q1.h index f18594b3b4..314e7621a0 100644 --- a/include/deal.II/fe/fe_q_iso_q1.h +++ b/include/deal.II/fe/fe_q_iso_q1.h @@ -109,7 +109,7 @@ DEAL_II_NAMESPACE_OPEN * contrast with FE_Q(p) where QGauss(p+1) is the default choice. In * particular, care must be taken to not use a quadrature formula that * evaluates the basis functions (and their derivatives) on sub-element - * boundaries as the gradients of piecewiese functions on internal boundaries + * boundaries as the gradients of piecewise functions on internal boundaries * are set to zero. No checks are performed internally to ensure that this is * not the case - it is the user's responsibility to avoid these situations. * diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index d1bd1d115a..2611e781d0 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -946,7 +946,7 @@ namespace FEValuesViews Vector(const Vector &) = delete; /** - * Move constuctor. + * Move constructor. */ // NOLINTNEXTLINE OSX does not compile with noexcept Vector(Vector &&) = default; diff --git a/include/deal.II/lac/affine_constraints.templates.h b/include/deal.II/lac/affine_constraints.templates.h index 083c832e5f..1bcd7f2c41 100644 --- a/include/deal.II/lac/affine_constraints.templates.h +++ b/include/deal.II/lac/affine_constraints.templates.h @@ -3265,7 +3265,7 @@ namespace internal else col_val = 0; - // account for indirect contributions by constraints in row, going trough + // account for indirect contributions by constraints in row, going through // the direct and indirect references in the given column. for (size_type q = 0; q < global_rows.size(i); ++q) { diff --git a/include/deal.II/lac/solver_qmrs.h b/include/deal.II/lac/solver_qmrs.h index 9603767ca2..9d5dd4aec5 100644 --- a/include/deal.II/lac/solver_qmrs.h +++ b/include/deal.II/lac/solver_qmrs.h @@ -284,7 +284,7 @@ SolverQMRS::solve(const MatrixType & A, LogStream::Prefix prefix("SQMR"); - // temporary vectors, allocated trough the @p VectorMemory object at the + // temporary vectors, allocated through the @p VectorMemory object at the // start of the actual solution process and deallocated at the end. typename VectorMemory::Pointer Vr(this->memory); typename VectorMemory::Pointer Vu(this->memory); diff --git a/include/deal.II/matrix_free/evaluation_kernels.h b/include/deal.II/matrix_free/evaluation_kernels.h index 665b3dd419..e9774f0af5 100644 --- a/include/deal.II/matrix_free/evaluation_kernels.h +++ b/include/deal.II/matrix_free/evaluation_kernels.h @@ -1016,9 +1016,9 @@ namespace internal } } - // Helper function that applies the 1d evaluation kernals. + // Helper function that applies the 1d evaluation kernels. // std::integral_constant is the interpolation path, and - // std::integral_constant bellow is the integration path. + // std::integral_constant below is the integration path. template template inline void diff --git a/include/deal.II/matrix_free/evaluation_kernels_hanging_nodes.h b/include/deal.II/matrix_free/evaluation_kernels_hanging_nodes.h index 64f4686dbc..76e2626d97 100644 --- a/include/deal.II/matrix_free/evaluation_kernels_hanging_nodes.h +++ b/include/deal.II/matrix_free/evaluation_kernels_hanging_nodes.h @@ -47,7 +47,7 @@ namespace internal /** - * Helper enum to spefify the type of vectorization for + * Helper enum to specify the type of vectorization for * FEEvaluationImplHangingNodesRunnerTypes::scalar. */ enum class VectorizationTypes diff --git a/include/deal.II/matrix_free/tools.h b/include/deal.II/matrix_free/tools.h index 69a6815294..f6c7c13a80 100644 --- a/include/deal.II/matrix_free/tools.h +++ b/include/deal.II/matrix_free/tools.h @@ -704,7 +704,7 @@ namespace MatrixFreeTools { // if we have a block vector with components with the same DoFHandler, // we need to figure out which component and which DoF within the - // comonent are we currently considering + // component are we currently considering const unsigned int n_fe_components = phi.get_dof_info().start_components.back(); const unsigned int comp = @@ -768,7 +768,7 @@ namespace MatrixFreeTools phi.get_current_cell_index()); ++v) // if we have a block vector with components with the same - // DoFHandler, we need to loop over all components manully and + // DoFHandler, we need to loop over all components manually and // need to apply the correct shift for (unsigned int j = 0; j < c_pools[v].row.size() - 1; ++j) for (unsigned int comp = 0; diff --git a/include/deal.II/multigrid/mg_transfer_global_coarsening.h b/include/deal.II/multigrid/mg_transfer_global_coarsening.h index e05f427ba3..159a280f7b 100644 --- a/include/deal.II/multigrid/mg_transfer_global_coarsening.h +++ b/include/deal.II/multigrid/mg_transfer_global_coarsening.h @@ -495,9 +495,10 @@ public: /** * Similar function to MGTransferMatrixFree::build() with the difference that * the information for the prolongation for each level has already been built. - * So this function only tries to optimize the data structues of the two-level - * transfer operators, e.g., by enabling inplace vector operations, by - * checking if @p external_partitioners and the internal ones are compatible. + * So this function only tries to optimize the data structures of the + * two-level transfer operators, e.g., by enabling inplace vector operations, + * by checking if @p external_partitioners and the internal ones are + * compatible. */ void build(const std::vector> diff --git a/include/deal.II/multigrid/mg_transfer_matrix_free.h b/include/deal.II/multigrid/mg_transfer_matrix_free.h index 769af62672..abbe4376c8 100644 --- a/include/deal.II/multigrid/mg_transfer_matrix_free.h +++ b/include/deal.II/multigrid/mg_transfer_matrix_free.h @@ -313,7 +313,7 @@ private: /** * Base class of MGTransferBlockMatrixFree. While MGTransferBlockMatrixFree - * constains all the setup routines of the transfer operators for the blocks, + * contains all the setup routines of the transfer operators for the blocks, * this class simply applies them, e.g., for restricting and prolongating. */ template diff --git a/include/deal.II/non_matching/quadrature_generator.h b/include/deal.II/non_matching/quadrature_generator.h index d8b26e4ebc..10031a9118 100644 --- a/include/deal.II/non_matching/quadrature_generator.h +++ b/include/deal.II/non_matching/quadrature_generator.h @@ -83,8 +83,8 @@ namespace NonMatching * * $|\frac{\partial \psi}{\partial x_i}| > 0$. * - * In practice, it might happend the bound we have for the expression in - * the left-hand side is only floating-point close to zero. + * In practice, the bound we have for the expression in the left-hand side + * may be near but not equal to zero due to roundoff errors. * * This constant is a safety margin, $C$, that states that the implicit * function theorem can be used when @@ -1348,7 +1348,7 @@ namespace NonMatching * * $|\partial_k \psi_j| > L_{jk}$. * - * and then returns a coordindate direction, $i$, and a lower bound $L$, + * and then returns a coordinate direction, $i$, and a lower bound $L$, * such that * * @f[ diff --git a/source/base/polynomials_raviart_thomas.cc b/source/base/polynomials_raviart_thomas.cc index 6a6b078b73..b9244d511c 100644 --- a/source/base/polynomials_raviart_thomas.cc +++ b/source/base/polynomials_raviart_thomas.cc @@ -115,7 +115,7 @@ PolynomialsRaviartThomas::evaluate( // In the following, we will access the scratch arrays declared as 'mutable' // in the class. In order to do so from this function, we have to make sure - // that we guard this access by a mutex so that the invokation of this 'const' + // that we guard this access by a mutex so that the invocation of this 'const' // function is thread-safe. std::lock_guard lock(scratch_arrays_mutex); diff --git a/source/distributed/tria.cc b/source/distributed/tria.cc index 64fef1ee4c..9cc6aae006 100644 --- a/source/distributed/tria.cc +++ b/source/distributed/tria.cc @@ -623,7 +623,7 @@ namespace private: /** - * Simple struct to keep relavant data. Can be accessed though p4est's user + * Simple struct to keep relevant data. Can be accessed though p4est's user * pointer. */ class QuadrantData diff --git a/source/dofs/dof_handler_policy.cc b/source/dofs/dof_handler_policy.cc index 91334cf40d..c117f51279 100644 --- a/source/dofs/dof_handler_policy.cc +++ b/source/dofs/dof_handler_policy.cc @@ -3047,7 +3047,7 @@ namespace internal dof_handler.get_fe_collection().max_dofs_per_cell()); // loop over all cells and record which subdomain a DoF belongs to. - // interface goes to proccessor with smaller subdomain id + // interface goes to processor with smaller subdomain id for (const auto &cell : dof_handler.cell_iterators_on_level(level)) { // get the owner of the cell; note that we have made sure above diff --git a/source/fe/fe_simplex_p_bubbles.cc b/source/fe/fe_simplex_p_bubbles.cc index 914aa2919e..990c59cd59 100644 --- a/source/fe/fe_simplex_p_bubbles.cc +++ b/source/fe/fe_simplex_p_bubbles.cc @@ -246,7 +246,7 @@ FE_SimplexP_Bubbles::FE_SimplexP_Bubbles( FE_P_BubblesImplementation::get_fe_data(degree), FE_P_BubblesImplementation::unit_support_points(degree), {FE_P_BubblesImplementation::unit_support_points(degree)}, - // Interface contraints are not yet implemented + // Interface constraints are not yet implemented FullMatrix()) , approximation_degree(degree) {} diff --git a/source/grid/tria.cc b/source/grid/tria.cc index b1538f00e7..472f3979c5 100644 --- a/source/grid/tria.cc +++ b/source/grid/tria.cc @@ -6735,7 +6735,7 @@ namespace internal // might have to renumber/rename children...) // we need a loop in cases c) and d), as the anisotropic - // children migt have a lower index than the mother quad + // children might have a lower index than the mother quad for (unsigned int loop = 0; loop < 2; ++loop) { // usually, only active objects can be refined diff --git a/source/non_matching/quadrature_generator.cc b/source/non_matching/quadrature_generator.cc index 9a530fa7f2..f2167bcc00 100644 --- a/source/non_matching/quadrature_generator.cc +++ b/source/non_matching/quadrature_generator.cc @@ -471,7 +471,7 @@ namespace NonMatching const AdditionalQGeneratorData &additional_data, QPartitioning & q_partitioning) { - // Make this int to avoid a warning signed/unsigned comparision. + // Make this int to avoid a warning signed/unsigned comparison. const int n_roots = roots.size(); // The number of intervals are roots.size() + 1 @@ -1007,7 +1007,7 @@ namespace NonMatching if (height_direction_data) return height_direction_data->direction; - // We have to choose some direction, we might aswell take 0. + // We have to choose some direction, we might as well take 0. return 0; }