From: David Wells Date: Tue, 20 Jun 2023 13:38:17 +0000 (-0400) Subject: 9.5: run codespell. X-Git-Tag: v9.5.0-rc1~80^2~3 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=6e553fd9961340f0286c346434503aa4f6db60c9;p=dealii.git 9.5: run codespell. --- diff --git a/include/deal.II/base/mpi_remote_point_evaluation.h b/include/deal.II/base/mpi_remote_point_evaluation.h index 0a48238afc..2f88977d85 100644 --- a/include/deal.II/base/mpi_remote_point_evaluation.h +++ b/include/deal.II/base/mpi_remote_point_evaluation.h @@ -100,7 +100,7 @@ namespace Utilities * GridTools::internal::DistributedComputePointLocationsInternal. * * This function is called internally by the reinit() function above. - * Having it as a seperate function makes it possible to setup the class + * Having it as a separate function makes it possible to setup the class * if it is known in which cells corresponding reference points are * located (e.g. if intersections of cells are known). */ diff --git a/include/deal.II/base/parameter_handler.h b/include/deal.II/base/parameter_handler.h index 7a86cc2d37..3fd37b9211 100644 --- a/include/deal.II/base/parameter_handler.h +++ b/include/deal.II/base/parameter_handler.h @@ -212,7 +212,7 @@ class MultipleParameterLoop; * } * @endcode * The advantage of using json-files is that this format is natively supported - * by Python, simplifying the running of paramter studies tremendously. + * by Python, simplifying the running of parameter studies tremendously. * *

Including other input files

* diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index 159882376c..b7a69bdfd2 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -579,7 +579,6 @@ public: * * This constructor obviously requires that the @p ElementType type is * either equal to @p Number, or is convertible to @p Number. - * Number. * * @note This function can also be used in @ref GlossDevice "device" code. */ diff --git a/include/deal.II/lac/generic_linear_algebra.h b/include/deal.II/lac/generic_linear_algebra.h index 05679059c9..cdeb2238c2 100644 --- a/include/deal.II/lac/generic_linear_algebra.h +++ b/include/deal.II/lac/generic_linear_algebra.h @@ -183,7 +183,7 @@ namespace LinearAlgebraTrilinos using SolverCG = TrilinosWrappers::SolverCG; /** - * Typdef for the GMRES solver type used. + * Typedef for the GMRES solver type used. */ using SolverGMRES = TrilinosWrappers::SolverGMRES; diff --git a/include/deal.II/lac/la_parallel_vector.h b/include/deal.II/lac/la_parallel_vector.h index 37a1f961b6..0cbc03648d 100644 --- a/include/deal.II/lac/la_parallel_vector.h +++ b/include/deal.II/lac/la_parallel_vector.h @@ -221,7 +221,7 @@ namespace LinearAlgebra * * @note By default, the GPU @ref GlossDevice "device" id is chosen in a round-robin fashion * according to the local MPI rank id. To choose a different @ref GlossDevice "device", Kokkos - * has to be initialized explicitly providing the respective devide id + * has to be initialized explicitly providing the respective device id * explicitly. * *

MPI-3 shared-memory support

diff --git a/include/deal.II/lac/petsc_communication_pattern.h b/include/deal.II/lac/petsc_communication_pattern.h index 532e89b136..415b2752b1 100644 --- a/include/deal.II/lac/petsc_communication_pattern.h +++ b/include/deal.II/lac/petsc_communication_pattern.h @@ -75,7 +75,7 @@ namespace PETScWrappers * associated to the @p indices_want only. * * This emulates the corresponding constructor in - * Utilies::MPI::NoncontiguousPartitioner. + * Utilities::MPI::NoncontiguousPartitioner. */ void reinit(const std::vector &indices_locally_owned, diff --git a/include/deal.II/lac/petsc_snes.h b/include/deal.II/lac/petsc_snes.h index cf00504272..82513b2691 100644 --- a/include/deal.II/lac/petsc_snes.h +++ b/include/deal.II/lac/petsc_snes.h @@ -66,7 +66,7 @@ namespace PETScWrappers * @param maximum_non_linear_iterations Maximum number of iterations allowed. * @param max_n_function_evaluations Maximum number of function evaluations allowed. * - * @note All parameters values specified here can be overriden by + * @note All parameters values specified here can be overridden by * command line choices. * * @ingroup PETScWrappers diff --git a/include/deal.II/lac/petsc_snes.templates.h b/include/deal.II/lac/petsc_snes.templates.h index f9dbfb674e..bd5516e410 100644 --- a/include/deal.II/lac/petsc_snes.templates.h +++ b/include/deal.II/lac/petsc_snes.templates.h @@ -571,7 +571,7 @@ namespace PETScWrappers // case is to use FD and thus assemble a dense operator by finite // differencing the residual callbacks. Here instead we decide to // use a full matrix-free approach by default. This choice can always - // be overriden from command line. + // be overridden from command line. { set_use_matrix_free(snes, false, true); } @@ -580,7 +580,7 @@ namespace PETScWrappers // In case solve_with_jacobian is provided, create a shell // preconditioner wrapping the user call. The internal Krylov // solver will apply the preconditioner only once. This choice - // can be overriden by command line and users can use any other + // can be overridden by command line and users can use any other // Krylov method if their solve is not accurate enough. // Using solve_with_jacobian as a preconditioner allows users // to provide approximate solvers and possibly iterate on a matrix-free diff --git a/include/deal.II/lac/petsc_sparse_matrix.h b/include/deal.II/lac/petsc_sparse_matrix.h index dc301454ef..8859a7e02b 100644 --- a/include/deal.II/lac/petsc_sparse_matrix.h +++ b/include/deal.II/lac/petsc_sparse_matrix.h @@ -79,7 +79,7 @@ namespace PETScWrappers * Initialize a Matrix from a PETSc Mat object. Note that we do not copy * the matrix. The Mat object is referenced by the newly created instance * of the class using PetscObjectReference. This is in line with the PETSc - * approach to object ownership, which mimicks std::shared_ptr. + * approach to object ownership, which mimics std::shared_ptr. */ explicit SparseMatrix(const Mat &); @@ -400,7 +400,7 @@ namespace PETScWrappers * Initialize a SparseMatrix from a PETSc Mat object. Note that we do not * copy the matrix. The Mat object is referenced by the newly created * instance of the class using PetscObjectReference. This is in line with - * the PETSc approach to object ownership, which mimicks std::shared_ptr. + * the PETSc approach to object ownership, which mimics std::shared_ptr. */ explicit SparseMatrix(const Mat &); diff --git a/include/deal.II/lac/petsc_ts.h b/include/deal.II/lac/petsc_ts.h index ea745c28f5..92a088b309 100644 --- a/include/deal.II/lac/petsc_ts.h +++ b/include/deal.II/lac/petsc_ts.h @@ -80,7 +80,7 @@ namespace PETScWrappers * Adaptive time stepping is disabled by default. * Negative values indicate using PETSc's default. * - * @note All parameters values specified here can be overriden by + * @note All parameters values specified here can be overridden by * command line choices. * * @ingroup PETScWrappers diff --git a/include/deal.II/lac/petsc_ts.templates.h b/include/deal.II/lac/petsc_ts.templates.h index f071222ad9..412d594ea3 100644 --- a/include/deal.II/lac/petsc_ts.templates.h +++ b/include/deal.II/lac/petsc_ts.templates.h @@ -795,7 +795,7 @@ namespace PETScWrappers // case is to use FD and thus assemble a dense operator by finite // differencing the residual callbacks. Here instead we decide to // use a full matrix-free approach by default. This choice can always - // be overriden from command line. + // be overridden from command line. if (!explicit_jacobian && !implicit_jacobian) { set_use_matrix_free(ts, false, true); @@ -805,7 +805,7 @@ namespace PETScWrappers // In case solve_with_jacobian is provided, create a shell // preconditioner wrapping the user call. The default internal Krylov // solver only applies the preconditioner. This choice - // can be overriden by command line and users can use any other + // can be overridden by command line and users can use any other // Krylov method if their solve is not accurate enough. // Using solve_with_jacobian as a preconditioner allow users // to provide approximate solvers and possibly iterate on a matrix-free diff --git a/include/deal.II/lac/tensor_product_matrix.h b/include/deal.II/lac/tensor_product_matrix.h index 1180fcd6a0..0311a9229f 100644 --- a/include/deal.II/lac/tensor_product_matrix.h +++ b/include/deal.II/lac/tensor_product_matrix.h @@ -364,7 +364,7 @@ public: }; /** - * Consturctor. + * Constructor. */ TensorProductMatrixSymmetricSumCollection( const AdditionalData &additional_data = AdditionalData()); diff --git a/include/deal.II/matrix_free/fe_evaluation.h b/include/deal.II/matrix_free/fe_evaluation.h index fdd8a8a7b9..a47e64c23d 100644 --- a/include/deal.II/matrix_free/fe_evaluation.h +++ b/include/deal.II/matrix_free/fe_evaluation.h @@ -1714,7 +1714,7 @@ protected: * want to compile all degrees up to eight; recommended setting) or by * compiling `evaluation_template_factory.templates.h` and * `evaluation_template_face_factory.templates.h` with the - * `FE_EVAL_FACTORY_DEGREE_MAX` overriden to the desired value. In the second + * `FE_EVAL_FACTORY_DEGREE_MAX` overridden to the desired value. In the second * option, symbols will be available twice, and it depends on your linker and * dynamic library loader whether the user-specified setting takes precedence; * use `LD_PRELOAD` to select the desired library. You can check if fast diff --git a/include/deal.II/matrix_free/fe_point_evaluation.h b/include/deal.II/matrix_free/fe_point_evaluation.h index 0d7bfaf2ce..4f71313c46 100644 --- a/include/deal.II/matrix_free/fe_point_evaluation.h +++ b/include/deal.II/matrix_free/fe_point_evaluation.h @@ -1308,7 +1308,7 @@ private: bool fast_path; /** - * Connection to NonMatching::MappingInfo to check wheter mapping data + * Connection to NonMatching::MappingInfo to check whether mapping data * has been invalidated. */ boost::signals2::connection connection_is_reinitialized; diff --git a/include/deal.II/matrix_free/tools.h b/include/deal.II/matrix_free/tools.h index 5d61790fa2..f83790bb16 100644 --- a/include/deal.II/matrix_free/tools.h +++ b/include/deal.II/matrix_free/tools.h @@ -334,7 +334,7 @@ namespace MatrixFreeTools matrix_free; /** - * Index of the valid FE. Currently, ony a single one is supported. + * Index of the valid FE. Currently, only a single one is supported. */ unsigned int fe_index_valid; }; diff --git a/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h b/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h index 0248882e9c..70ad11a2b2 100644 --- a/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h +++ b/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h @@ -3572,7 +3572,7 @@ namespace internal dof_handler.get_fe().n_dofs_per_cell() == dof_handler_support_points.get_fe().n_dofs_per_cell(), ExcMessage( - "For now multple components are not considered and therefore DoFHandlers need the same degree.")); + "For now multiple components are not considered and therefore DoFHandlers need the same degree.")); const auto degree = dof_handler.get_fe().degree; const auto dofs_per_cell = dof_handler.get_fe().n_dofs_per_cell(); diff --git a/include/deal.II/multigrid/multigrid.h b/include/deal.II/multigrid/multigrid.h index f2a62418a1..27ef91def7 100644 --- a/include/deal.II/multigrid/multigrid.h +++ b/include/deal.II/multigrid/multigrid.h @@ -80,7 +80,7 @@ namespace mg * is * false) the call to the coarse solver on @p level. * - * The coarse solve will be done with ``defect[leve]`` and returned in + * The coarse solve will be done with ``defect[level]`` and returned in * ``solution[level]``, which can be inspected by the user using this * signal. */ diff --git a/include/deal.II/opencascade/utilities.h b/include/deal.II/opencascade/utilities.h index 2ec66fd181..f1e9272811 100644 --- a/include/deal.II/opencascade/utilities.h +++ b/include/deal.II/opencascade/utilities.h @@ -114,7 +114,7 @@ namespace OpenCASCADE * Read IGES files and translate their content into openCascade topological * entities. The option scale_factor is used to compensate for different * units being used in the IGES files and in the target application. The - * standard unit for IGES files is millimiters. The return object is a + * standard unit for IGES files is millimeters. The return object is a * TopoDS_Shape which contains all objects from the file. */ TopoDS_Shape @@ -165,7 +165,7 @@ namespace OpenCASCADE * Read STEP files and translate their content into openCascade topological * entities. The option scale_factor is used to compensate for different * units being used in the STEP files and in the target application. The - * standard unit for STEP files is millimiters. The return object is a + * standard unit for STEP files is millimeters. The return object is a * TopoDS_Shape which contains all objects from the file. */ TopoDS_Shape diff --git a/include/deal.II/trilinos/nox.h b/include/deal.II/trilinos/nox.h index ff01bd7700..4004580d92 100644 --- a/include/deal.II/trilinos/nox.h +++ b/include/deal.II/trilinos/nox.h @@ -288,8 +288,8 @@ namespace TrilinosWrappers * $[\nabla_u F(u)]^{-1}$ to * @p y, writes the result in @p x and returns the number of * linear iterations the linear solver needed. - * The parameter @p tolerance species the error reduction if a - * interative solver is used. The Jacobian to be used + * The parameter @p tolerance species the error reduction if an + * iterative solver is used. The Jacobian to be used * (i.e., more precisely: the linearization point $u$ above) is * the one computed when the `setup_jacobian` function was last called. * diff --git a/include/deal.II/trilinos/nox.templates.h b/include/deal.II/trilinos/nox.templates.h index 33c3ee3650..f91a9784b8 100644 --- a/include/deal.II/trilinos/nox.templates.h +++ b/include/deal.II/trilinos/nox.templates.h @@ -354,7 +354,7 @@ namespace TrilinosWrappers { public: /** - * Constructor. The class is intialized by the solution vector and + * Constructor. The class is initialized by the solution vector and * functions to compute the residual, to setup the jacobian, and * to solve the Jacobian. */ @@ -956,7 +956,7 @@ namespace TrilinosWrappers void NOXSolver::clear() { - // clear interal counters + // clear internal counters n_residual_evaluations = 0; n_jacobian_applications = 0; n_nonlinear_iterations = 0; @@ -987,7 +987,7 @@ namespace TrilinosWrappers n_residual_evaluations++; - // evalute residual + // evaluate residual return internal::NOXWrappers::call_and_possibly_capture_exception( residual, pending_exception, x, f); }, diff --git a/source/base/mpi.cc b/source/base/mpi.cc index 0e72443c5d..87307b1074 100644 --- a/source/base/mpi.cc +++ b/source/base/mpi.cc @@ -794,7 +794,7 @@ namespace Utilities argv_new[argc] = const_cast(threads_flag_string.c_str()); argv_new[argc + 1] = nullptr; // The first argument in Kokkos::initialize is of type int&. Hence, we - // need to define a new variable to pass to it (insted of using argc+1 + // need to define a new variable to pass to it (instead of using argc+1 // inline). int argc_new = argc + 1; Kokkos::initialize(argc_new, argv_new.data()); diff --git a/source/base/path_search.cc b/source/base/path_search.cc index 3d89cea803..d64f65bb80 100644 --- a/source/base/path_search.cc +++ b/source/base/path_search.cc @@ -37,7 +37,7 @@ PathSearch::initialize_classes() path_lists.insert(map_type(std::string("PARAMETER"), v)); /* - * TODO: reenable some sensible default paths. Maier, 2012 + * TODO: re-enable some sensible default paths. Maier, 2012 */ path_lists.insert(map_type(std::string("MESH"), v)); diff --git a/source/dofs/dof_tools.cc b/source/dofs/dof_tools.cc index 8bdac599c5..20994ff690 100644 --- a/source/dofs/dof_tools.cc +++ b/source/dofs/dof_tools.cc @@ -2293,7 +2293,7 @@ namespace DoFTools } - // This functino is deprecated: + // This function is deprecated: template DEAL_II_DEPRECATED_EARLY void map_dofs_to_support_points( @@ -2314,7 +2314,7 @@ namespace DoFTools } - // This functino is deprecated: + // This function is deprecated: template DEAL_II_DEPRECATED_EARLY void map_dofs_to_support_points( diff --git a/source/grid/grid_tools.cc b/source/grid/grid_tools.cc index 43dead96e9..3162580712 100644 --- a/source/grid/grid_tools.cc +++ b/source/grid/grid_tools.cc @@ -6771,7 +6771,7 @@ namespace GridTools std::stable_sort(recv_components.begin(), recv_components.end(), [&](const auto &a, const auto &b) { - // intersecton index + // intersection index if (std::get<1>(a) != std::get<1>(b)) return std::get<1>(a) < std::get<1>(b); diff --git a/source/lac/petsc_parallel_block_sparse_matrix.cc b/source/lac/petsc_parallel_block_sparse_matrix.cc index 5c529a5006..9db5f83f2f 100644 --- a/source/lac/petsc_parallel_block_sparse_matrix.cc +++ b/source/lac/petsc_parallel_block_sparse_matrix.cc @@ -164,7 +164,7 @@ namespace PETScWrappers PetscErrorCode ierr; // Create empty matrices if needed - // This is neeeded by the base class + // This is needed by the base class // not by MATNEST std::vector row_sizes(m, size_type(-1)); std::vector col_sizes(n, size_type(-1)); diff --git a/source/lac/petsc_solver.cc b/source/lac/petsc_solver.cc index 79d2ca98fb..d5b8b2f37e 100644 --- a/source/lac/petsc_solver.cc +++ b/source/lac/petsc_solver.cc @@ -102,7 +102,7 @@ namespace PETScWrappers /* * by default we set up the preconditioner only once. - * this can be overriden by command line. + * this can be overridden by command line. */ AssertPETSc(KSPSetReusePreconditioner(ksp, PETSC_TRUE)); } @@ -755,7 +755,7 @@ namespace PETScWrappers /* * by default we set up the preconditioner only once. - * this can be overriden by command line. + * this can be overridden by command line. */ AssertPETSc(KSPSetReusePreconditioner(ksp, PETSC_TRUE)); }