From a2159039704cd914137c6f7551cb1978e5642226 Mon Sep 17 00:00:00 2001 From: luzpaz Date: Mon, 18 Sep 2023 18:22:49 +0000 Subject: [PATCH] Fix various typos Found via `codespell -q 3 -S ./bundled,./doc/news -L ans,ba,bu,clen,commend,compontent,inout,nd,pres,re-use,ro,rotat,stoer,workd` --- cmake/macros/macro_deal_ii_pickup_tests.cmake | 2 +- cmake/macros/macro_define_interface_target.cmake | 2 +- cmake/macros/macro_populate_target_properties.cmake | 2 +- cmake/macros/macro_shell_escape_option_groups.cmake | 2 +- cmake/setup_compiler_flags_gnu.cmake | 2 +- examples/step-77/doc/results.dox | 2 +- examples/step-79/step-79.cc | 2 +- include/deal.II/cgal/utilities.h | 2 +- include/deal.II/grid/tensor_product_manifold.h | 4 ++-- include/deal.II/grid/tria.h | 2 +- include/deal.II/matrix_free/constraint_info.h | 2 +- include/deal.II/multigrid/mg_transfer_global_coarsening.h | 4 ++-- include/deal.II/numerics/vector_tools_boundary.templates.h | 2 +- include/deal.II/opencascade/utilities.h | 2 +- include/deal.II/optimization/line_minimization.h | 2 +- source/differentiation/ad/adolc_number_types.cc | 2 +- source/dofs/dof_tools_constraints.cc | 2 +- source/grid/grid_in.cc | 2 +- source/hp/refinement.cc | 2 +- source/lac/trilinos_precondition_ml.cc | 2 +- source/matrix_free/vector_data_exchange.cc | 2 +- tests/base/bounding_box_1.cc | 6 +++--- tests/boost/node_visitor_02.cc | 2 +- tests/cgal/cgal_intersect_simplices_3d_3d_02.cc | 2 +- tests/codim_one/bem.cc | 2 +- tests/codim_one/integrate_one_over_r.cc | 2 +- tests/fe/fe_enriched_compare_to_fe_system.cc | 2 +- tests/fe/fe_enriched_compare_to_fe_system_2.cc | 2 +- tests/grid/distributed_compute_point_locations_03.cc | 2 +- tests/hp/fe_nothing_18.cc | 2 +- tests/lac/packaged_operation_02.cc | 4 ++-- tests/lac/tensor_product_matrix.h | 4 ++-- tests/matrix_free/parallel_multigrid_adaptive_07.cc | 2 +- .../parallel_multigrid_adaptive_07.cc | 2 +- tests/optimization/step-44.h | 2 +- tests/performance/collect_measurements | 2 +- tests/petsc/petsc_ts_03.cc | 2 +- tests/petsc/step-77-snes.cc | 2 +- tests/symengine/basic_05.cc | 2 +- tests/symengine/batch_optimizer_03_1a.cc | 2 +- tests/symengine/sd_common_tests/batch_optimizer_02.h | 2 +- tests/symengine/sd_common_tests/batch_optimizer_03.h | 2 +- 42 files changed, 48 insertions(+), 48 deletions(-) diff --git a/cmake/macros/macro_deal_ii_pickup_tests.cmake b/cmake/macros/macro_deal_ii_pickup_tests.cmake index 0dc8560eea..64ceedb29e 100644 --- a/cmake/macros/macro_deal_ii_pickup_tests.cmake +++ b/cmake/macros/macro_deal_ii_pickup_tests.cmake @@ -163,7 +163,7 @@ macro(deal_ii_pickup_tests) "running mpi tests within the testsuite. As a consequence all " "tests that require an mpi launcher have been disabled.\n" "If you want to run tests with mpi then please configure deal.II " - "by either setting the MPIEXEC environemt variable or the CMake " + "by either setting the MPIEXEC environment variable or the CMake " "variable MPIEXEC_EXECUTABLE to a full path to the MPI launcher " "program.\n\n" ) diff --git a/cmake/macros/macro_define_interface_target.cmake b/cmake/macros/macro_define_interface_target.cmake index 54d1b29585..ef0bf0764a 100644 --- a/cmake/macros/macro_define_interface_target.cmake +++ b/cmake/macros/macro_define_interface_target.cmake @@ -46,7 +46,7 @@ # targets), respectively. # # The default name, i.e., interface_(|_debug|_release) can be -# overriden by the optional second argument. For example, +# overridden by the optional second argument. For example, # define_interface_target(DEAL_II base_configuration) # will define interface_base_configuration* targets but query all # information from DEAL_II_* variables. diff --git a/cmake/macros/macro_populate_target_properties.cmake b/cmake/macros/macro_populate_target_properties.cmake index c85f4f0708..c097dfd214 100644 --- a/cmake/macros/macro_populate_target_properties.cmake +++ b/cmake/macros/macro_populate_target_properties.cmake @@ -65,7 +65,7 @@ function(populate_target_properties _target _build) # # Do not add bundled include directories to bundled_ targets. First of - # all this is unnecessary, secondly, this severly trips up ICC-19 that + # all this is unnecessary, secondly, this severely trips up ICC-19 that # cannot handle the additional -isystem include properly... # if(NOT "${_target}" MATCHES "^bundled_") diff --git a/cmake/macros/macro_shell_escape_option_groups.cmake b/cmake/macros/macro_shell_escape_option_groups.cmake index 78dca443c0..465cd50051 100644 --- a/cmake/macros/macro_shell_escape_option_groups.cmake +++ b/cmake/macros/macro_shell_escape_option_groups.cmake @@ -53,7 +53,7 @@ macro(shell_escape_option_groups _variable) # # In addition try to merge options of the form "-Wl,-flag -Wl,/path". We - # do this by detecting all occurences of a flag ("-Wl,-[-]flag") followed + # do this by detecting all occurrences of a flag ("-Wl,-[-]flag") followed # by an option that doesn't start with a dash ("-Wl,[option]"): # string(REGEX REPLACE diff --git a/cmake/setup_compiler_flags_gnu.cmake b/cmake/setup_compiler_flags_gnu.cmake index 08eca34883..b3424f3f27 100644 --- a/cmake/setup_compiler_flags_gnu.cmake +++ b/cmake/setup_compiler_flags_gnu.cmake @@ -199,7 +199,7 @@ if (CMAKE_BUILD_TYPE MATCHES "Debug") # # We have to ensure that we emit floating-point instructions in debug - # mode that preserve the occurence of floating-point exceptions and don't + # mode that preserve the occurrence of floating-point exceptions and don't # introduce new ones. gcc plays nicely in this regard by enabling # `-ftrapping-math` per default, at least for the level of optimization # we have in debug mode. clang however is more aggressive and assumes diff --git a/examples/step-77/doc/results.dox b/examples/step-77/doc/results.dox index 88e1cb378f..2d7ac8c948 100644 --- a/examples/step-77/doc/results.dox +++ b/examples/step-77/doc/results.dox @@ -269,7 +269,7 @@ Mesh refinement step 0 By default, PETSc uses a Newton solver with cubic backtracking, resampling the Jacobian matrix at each Newton step. That is, we compute and factorize the matrix once per Newton step, and then sample -the residual to check for a successul line-search. +the residual to check for a successful line-search. The attentive reader should have noticed that in this case we are computing one more extra residual per Newton step. This is because diff --git a/examples/step-79/step-79.cc b/examples/step-79/step-79.cc index 141688b5f6..faf392acd5 100644 --- a/examples/step-79/step-79.cc +++ b/examples/step-79/step-79.cc @@ -1687,7 +1687,7 @@ namespace SAND } // Then compute the residual and take the $l_1$ norms of the - // components that correspond to Lagrange mulipliers. We add + // components that correspond to Lagrange multipliers. We add // those to the objective function computed above, and return // the sum at the bottom: const BlockVector test_rhs = calculate_test_rhs(test_solution); diff --git a/include/deal.II/cgal/utilities.h b/include/deal.II/cgal/utilities.h index 42b0df7bf3..337eb3a09d 100644 --- a/include/deal.II/cgal/utilities.h +++ b/include/deal.II/cgal/utilities.h @@ -37,7 +37,7 @@ # include # include # include -// Disable a warnung that we get with gcc-13 about a potential unitialized +// Disable a warnung that we get with gcc-13 about a potential uninitialized // usage of an lambda function in this external CGAL header. DEAL_II_DISABLE_EXTRA_DIAGNOSTICS # include diff --git a/include/deal.II/grid/tensor_product_manifold.h b/include/deal.II/grid/tensor_product_manifold.h index a6e5c54ea3..c9a4d35d96 100644 --- a/include/deal.II/grid/tensor_product_manifold.h +++ b/include/deal.II/grid/tensor_product_manifold.h @@ -54,10 +54,10 @@ DEAL_II_NAMESPACE_OPEN * @tparam dim Dimension of cells (needs to match first template argument of * the Triangulation to be attached to. * @tparam dim_A Dimension of ChartManifold A. - * @tparam spacedim_A Spacial dimension of ChartManifold A. + * @tparam spacedim_A Spatial dimension of ChartManifold A. * @tparam chartdim_A Chart dimension of ChartManifold A. * @tparam dim_B Dimension of ChartManifold B. - * @tparam spacedim_B Spacial dimension of ChartManifold B. + * @tparam spacedim_B Spatial dimension of ChartManifold B. * @tparam chartdim_B Chart dimension of ChartManifold B. */ template diff --git a/include/deal.II/multigrid/mg_transfer_global_coarsening.h b/include/deal.II/multigrid/mg_transfer_global_coarsening.h index 222cb12923..cbfdcc04e6 100644 --- a/include/deal.II/multigrid/mg_transfer_global_coarsening.h +++ b/include/deal.II/multigrid/mg_transfer_global_coarsening.h @@ -1013,7 +1013,7 @@ public: /** @} */ /** - * @name Tranfer functions. + * @name Transfer functions. */ /** @{ */ @@ -1349,7 +1349,7 @@ MGTransferMF::initialize_dof_vector( partitioner = external_partitioners[level - transfer.min_level()]; } - // check if vectors are already correctly initalized + // check if vectors are already correctly initialized // yes: same partitioners are used if (vec.get_partitioner().get() == partitioner.get()) diff --git a/include/deal.II/numerics/vector_tools_boundary.templates.h b/include/deal.II/numerics/vector_tools_boundary.templates.h index 3d51d2e1f2..6bd811a010 100644 --- a/include/deal.II/numerics/vector_tools_boundary.templates.h +++ b/include/deal.II/numerics/vector_tools_boundary.templates.h @@ -2272,7 +2272,7 @@ namespace VectorTools std::vector &dof_values, std::vector &projected_dofs) { - // Compute the intergral over the product of the normal components of + // Compute the integral over the product of the normal components of // the boundary function times the normal components of the shape // functions supported on the boundary. const FEValuesExtractors::Vector vec(first_vector_component); diff --git a/include/deal.II/opencascade/utilities.h b/include/deal.II/opencascade/utilities.h index 59587bc539..3563e02908 100644 --- a/include/deal.II/opencascade/utilities.h +++ b/include/deal.II/opencascade/utilities.h @@ -142,7 +142,7 @@ namespace OpenCASCADE * mesh it automatically. We remark that the automatic mesh generation in * OpenCASCADE takes care only of the geometrical resemblance between the * shape and the mesh, to control the shape and regularity of the triangles - * you should use other meshing softwares. The two arguments `deflection` and + * you should use other meshing software. The two arguments `deflection` and * `angular_deflection` select the accuracy of the created triangulation with * respect to the original topological shape. The argument * `sew_different_faces` gives the possibility to use a Sewer from OpenCASCADE diff --git a/include/deal.II/optimization/line_minimization.h b/include/deal.II/optimization/line_minimization.h index b4e99c51bb..82227fa59c 100644 --- a/include/deal.II/optimization/line_minimization.h +++ b/include/deal.II/optimization/line_minimization.h @@ -216,7 +216,7 @@ namespace LineMinimization * // Ensure that the Dirichlet constraints are correctly applied, * // irrespective of the step size * constraints.distribute(newton_update_trial); - * // Now add the constribution from the previously accepted solution + * // Now add the contribution from the previously accepted solution * // history. * const Vector solution_total_trial = * get_solution_total(newton_update_trial); diff --git a/source/differentiation/ad/adolc_number_types.cc b/source/differentiation/ad/adolc_number_types.cc index 4bb9e357c7..17cf9a4065 100644 --- a/source/differentiation/ad/adolc_number_types.cc +++ b/source/differentiation/ad/adolc_number_types.cc @@ -36,7 +36,7 @@ namespace numbers namespace { // Apply some comparator and extract the boolean result of the operation, - // instead of the "adub" return type tpyically returned by ADOL-C for + // instead of the "adub" return type typically returned by ADOL-C for // such a comparison. This is implemented as a general function so that // the list of implemented comparative operations can be easily extended. bool diff --git a/source/dofs/dof_tools_constraints.cc b/source/dofs/dof_tools_constraints.cc index db9f5458dc..f134f3181b 100644 --- a/source/dofs/dof_tools_constraints.cc +++ b/source/dofs/dof_tools_constraints.cc @@ -2725,7 +2725,7 @@ namespace DoFTools // when on cell 1, we compute the weights of dof 'x' to be 1/2 from // parameter dofs 0 and 1, respectively. however, when later we are on // cell 2, we again compute the prolongation of shape function 1 - // restricted to cell 2 to the globla grid and find that the weight of + // restricted to cell 2 to the global grid and find that the weight of // global dof 'x' now is zero. however, we should not overwrite the old // value. // diff --git a/source/grid/grid_in.cc b/source/grid/grid_in.cc index 513a879d8e..8722b54f42 100644 --- a/source/grid/grid_in.cc +++ b/source/grid/grid_in.cc @@ -1369,7 +1369,7 @@ GridIn::read_dbmesh(std::istream &in) // of fields of which I have no // clue what they mean. skip them // all and leave the interpretation - // to other implementors... + // to other implementers... while (getline(in, line), ((line.find("End") == std::string::npos) && (in))) ; // ok, so we are not at the end of diff --git a/source/hp/refinement.cc b/source/hp/refinement.cc index d5d6eede70..36f6851f34 100644 --- a/source/hp/refinement.cc +++ b/source/hp/refinement.cc @@ -308,7 +308,7 @@ namespace hp // that apply to all or none of the cells at once. However here, we // do not know which threshold would suffice for this task because the // user could provide any comparison function. Thus if necessary, we - // overwrite the user's choice with suitable functions simplying + // overwrite the user's choice with suitable functions simply // returning 'true' and 'false' for any cell with reference wrappers. // Thus, no function object copies are stored. // diff --git a/source/lac/trilinos_precondition_ml.cc b/source/lac/trilinos_precondition_ml.cc index 302fee6b5f..b20160c965 100644 --- a/source/lac/trilinos_precondition_ml.cc +++ b/source/lac/trilinos_precondition_ml.cc @@ -74,7 +74,7 @@ namespace TrilinosWrappers ML_Epetra::SetDefaults("SA", parameter_list); // uncoupled mode can give a lot of warnings or even fail when there - // are too many entries per row and aggreggation gets complicated, but + // are too many entries per row and aggregation gets complicated, but // MIS does not work if too few elements are located on one // processor. work around these warnings by choosing the different // strategies in different situations: for low order, always use the diff --git a/source/matrix_free/vector_data_exchange.cc b/source/matrix_free/vector_data_exchange.cc index 72b0f2f3f7..064982f049 100644 --- a/source/matrix_free/vector_data_exchange.cc +++ b/source/matrix_free/vector_data_exchange.cc @@ -389,7 +389,7 @@ namespace internal const auto &ghost_indices_within_larger_ghost_set = partitioner->ghost_indices_within_larger_ghost_set(); - // temporal data strucutures + // temporal data structures std::vector n_ghost_indices_in_larger_set_by_remote_rank; std::vector> ghost_targets_data; diff --git a/tests/base/bounding_box_1.cc b/tests/base/bounding_box_1.cc index 18bd0d068e..09c7087ed3 100644 --- a/tests/base/bounding_box_1.cc +++ b/tests/base/bounding_box_1.cc @@ -105,7 +105,7 @@ test_bounding_box() } deallog << std::endl; - // Initalize box with point + // Initialize box with point { Point p; for (unsigned int i = 0; i < spacedim; ++i) @@ -118,7 +118,7 @@ test_bounding_box() } deallog << std::endl; - // Initalize box with box + // Initialize box with box { BoundingBox bb(b); deallog << "Boundary points: " << std::endl; @@ -127,7 +127,7 @@ test_bounding_box() } deallog << std::endl; - // Initalize box with box + // Initialize box with box { BoundingBox bb; bb = b; diff --git a/tests/boost/node_visitor_02.cc b/tests/boost/node_visitor_02.cc index 85e4e89970..7a7932f3c4 100644 --- a/tests/boost/node_visitor_02.cc +++ b/tests/boost/node_visitor_02.cc @@ -13,7 +13,7 @@ // // --------------------------------------------------------------------- -// Use information from NodeVisitor to print show explicitely the boxes +// Use information from NodeVisitor to print show explicitly the boxes // associated to each parent node on the previous level #include diff --git a/tests/cgal/cgal_intersect_simplices_3d_3d_02.cc b/tests/cgal/cgal_intersect_simplices_3d_3d_02.cc index cd35ec5dea..97a5645b0a 100644 --- a/tests/cgal/cgal_intersect_simplices_3d_3d_02.cc +++ b/tests/cgal/cgal_intersect_simplices_3d_3d_02.cc @@ -13,7 +13,7 @@ // // --------------------------------------------------------------------- -// Compute intersection of two 3D cells. This additional test is added becase +// Compute intersection of two 3D cells. This additional test is added because // intersections are not found with inexact kernels. #include diff --git a/tests/codim_one/bem.cc b/tests/codim_one/bem.cc index 7117085608..566542264d 100644 --- a/tests/codim_one/bem.cc +++ b/tests/codim_one/bem.cc @@ -122,7 +122,7 @@ BEM::run() SphericalManifold boundary(p); tria.set_manifold(1, boundary); - // works up to cycle<9, but for testin purpose, we stop at 4 + // works up to cycle<9, but for testing purpose, we stop at 4 for (unsigned int cycle = 0; cycle < 4; ++cycle) { tria.set_manifold(1, boundary); diff --git a/tests/codim_one/integrate_one_over_r.cc b/tests/codim_one/integrate_one_over_r.cc index 3db1f3d2c9..f3bb777aa2 100644 --- a/tests/codim_one/integrate_one_over_r.cc +++ b/tests/codim_one/integrate_one_over_r.cc @@ -93,7 +93,7 @@ main() deallog << std::endl; else deallog - << ", desing: " << approx_integral_2 - exact_integral + << ", design: " << approx_integral_2 - exact_integral << std::endl; } } diff --git a/tests/fe/fe_enriched_compare_to_fe_system.cc b/tests/fe/fe_enriched_compare_to_fe_system.cc index 1034dd0cd6..4fd21a9d77 100644 --- a/tests/fe/fe_enriched_compare_to_fe_system.cc +++ b/tests/fe/fe_enriched_compare_to_fe_system.cc @@ -51,7 +51,7 @@ const double eps = 1e-10; // move nodes randomly // and compare FEEnriched to FESystem with explicit treatment of // the product rule for -// valus, gradients, hessians on +// values, gradients, hessians on // elements and faces. // The comparison is straight forward because local dofs are enumerated // in the same way for FE_System and FEEnriched. diff --git a/tests/fe/fe_enriched_compare_to_fe_system_2.cc b/tests/fe/fe_enriched_compare_to_fe_system_2.cc index ab2a491f76..9cd61abe13 100644 --- a/tests/fe/fe_enriched_compare_to_fe_system_2.cc +++ b/tests/fe/fe_enriched_compare_to_fe_system_2.cc @@ -51,7 +51,7 @@ const double eps = 1e-10; // move nodes randomly // and compare FEEnriched to FESystem with explicit treatment of // the product rule for -// valus, gradients, hessians on +// values, gradients, hessians on // elements and faces. // The comparison is straight forward because local dofs are enumerated // in the same way for FE_System and FEEnriched. diff --git a/tests/grid/distributed_compute_point_locations_03.cc b/tests/grid/distributed_compute_point_locations_03.cc index 33474f3ecb..008cfd83cb 100644 --- a/tests/grid/distributed_compute_point_locations_03.cc +++ b/tests/grid/distributed_compute_point_locations_03.cc @@ -49,7 +49,7 @@ test_distributed_cpt(unsigned int ref_cube) << std::endl; deallog << "Cube refinements: " << ref_cube << std::endl; - // Creeating the cube on which to run distributed cpt loc + // Creating the cube on which to run distributed cpt loc parallel::distributed::Triangulation cube_d(mpi_communicator); GridGenerator::hyper_cube(cube_d); cube_d.refine_global(ref_cube); diff --git a/tests/hp/fe_nothing_18.cc b/tests/hp/fe_nothing_18.cc index cdfbeee71d..2c3c897277 100644 --- a/tests/hp/fe_nothing_18.cc +++ b/tests/hp/fe_nothing_18.cc @@ -242,7 +242,7 @@ ElasticProblem::ElasticProblem() , degree(1) , dofs_per_block(n_blocks) , dof_handler(triangulation) - , /*assotiate dof_handler to the triangulation */ + , /*associate dof_handler to the triangulation */ elasticity_fe( FE_Q(degree), dim, // use dim FE_Q of a given degree to represent displacements diff --git a/tests/lac/packaged_operation_02.cc b/tests/lac/packaged_operation_02.cc index 573c0138d0..65dc3a6fc7 100644 --- a/tests/lac/packaged_operation_02.cc +++ b/tests/lac/packaged_operation_02.cc @@ -20,7 +20,7 @@ #include "../tests.h" -// and a _lot_ of stuff to create a linera oprator +// and a _lot_ of stuff to create a linear operator #include #include @@ -67,7 +67,7 @@ main() static const int dim = 2; - // Create mass marix M, and an iterative inverse MInv: + // Create mass matrix M, and an iterative inverse MInv: Triangulation triangulation; GridGenerator::hyper_cube(triangulation); diff --git a/tests/lac/tensor_product_matrix.h b/tests/lac/tensor_product_matrix.h index 85f3d506a7..d7ca6a091e 100644 --- a/tests/lac/tensor_product_matrix.h +++ b/tests/lac/tensor_product_matrix.h @@ -65,7 +65,7 @@ namespace dealii } // Compute harmonic extent of each locally owned cell including of each - // of its neighbors. If there is no neigbor, its extent is zero. + // of its neighbors. If there is no neighbor, its extent is zero. template std::vector> compute_harmonic_patch_extent(const Mapping &mapping, @@ -79,7 +79,7 @@ namespace dealii quadrature); // 2) accumulate for each face the normal extent for the - // neigboring cell(s); here we also consider periodicies + // neighboring cell(s); here we also consider periodicies std::vector face_extent(triangulation.n_faces(), 0.0); for (const auto &cell : triangulation.active_cell_iterators()) diff --git a/tests/matrix_free/parallel_multigrid_adaptive_07.cc b/tests/matrix_free/parallel_multigrid_adaptive_07.cc index 06164975aa..cf750d6ba8 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_07.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_07.cc @@ -18,7 +18,7 @@ // This test is similar to parallel_multigrid_adaptive_06 but we also test // for different polynomial degree in different blocks. // We expect to have the same iteration numbers as in -// parallel_multigrid_adaptive_06 with repsect to the highest polynomial +// parallel_multigrid_adaptive_06 with respect to the highest polynomial // degree used. diff --git a/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_07.cc b/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_07.cc index 3175054b23..ab0bc413a6 100644 --- a/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_07.cc +++ b/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_07.cc @@ -18,7 +18,7 @@ // This test is similar to parallel_multigrid_adaptive_06 but we also test // for different polynomial degree in different blocks. // We expect to have the same iteration numbers as in -// parallel_multigrid_adaptive_06 with repsect to the highest polynomial +// parallel_multigrid_adaptive_06 with respect to the highest polynomial // degree used. diff --git a/tests/optimization/step-44.h b/tests/optimization/step-44.h index 745f022136..6ec2ede11b 100644 --- a/tests/optimization/step-44.h +++ b/tests/optimization/step-44.h @@ -1331,7 +1331,7 @@ namespace Step44 BlockVector solution_delta_trial(newton_update); solution_delta_trial *= ss; this->constraints.distribute(solution_delta_trial); - // Now add the constribution from the previously accepted solution + // Now add the contribution from the previously accepted solution // history. solution_delta_trial += solution_delta; diff --git a/tests/performance/collect_measurements b/tests/performance/collect_measurements index 9c2ce80282..8a0230cbcb 100755 --- a/tests/performance/collect_measurements +++ b/tests/performance/collect_measurements @@ -23,7 +23,7 @@ # # -# First, collect some metatadata: +# First, collect some metadata: # site="${1}" diff --git a/tests/petsc/petsc_ts_03.cc b/tests/petsc/petsc_ts_03.cc index 2fbc400bab..6a10bc9767 100644 --- a/tests/petsc/petsc_ts_03.cc +++ b/tests/petsc/petsc_ts_03.cc @@ -171,7 +171,7 @@ public: << ')' << std::endl; }; - // This callback is invoked after a successfull stage. + // This callback is invoked after a successful stage. // Here we only print that the callback is invoked. time_stepper.distribute = [&](const real_type t, VectorType &) -> void { deallog << "Distribute at time " << t << std::endl; diff --git a/tests/petsc/step-77-snes.cc b/tests/petsc/step-77-snes.cc index b20d67e3bc..ee1984e3b5 100644 --- a/tests/petsc/step-77-snes.cc +++ b/tests/petsc/step-77-snes.cc @@ -496,7 +496,7 @@ namespace Step77 // reach; but you might want to look into what other members of the // PETScWrappers::NonlinearSolverData class has and play with them). // - // When using the PETSc nonlinear solver, we have two possibilites, + // When using the PETSc nonlinear solver, we have two possibilities, // both of them are coded below for this example. // - In the case with `user_control` set to true // there is complete control of the linear system solution process diff --git a/tests/symengine/basic_05.cc b/tests/symengine/basic_05.cc index 8ebd728212..8f6586fbb4 100644 --- a/tests/symengine/basic_05.cc +++ b/tests/symengine/basic_05.cc @@ -13,7 +13,7 @@ // // --------------------------------------------------------------------- -// Check that SymEngine can do some optimsation on diffentiated expressions +// Check that SymEngine can do some optimsation on differentiated expressions // using lambda functions // This is an extension of basic_04.cc diff --git a/tests/symengine/batch_optimizer_03_1a.cc b/tests/symengine/batch_optimizer_03_1a.cc index 6dec948d1b..358eac27ef 100644 --- a/tests/symengine/batch_optimizer_03_1a.cc +++ b/tests/symengine/batch_optimizer_03_1a.cc @@ -20,7 +20,7 @@ // See tests/symengine/basic_06.cc and tests/symengine/basic_07.cc for // a more simple example of differentiation of symbols with // explicit/implicit relationships. -// We invoke the batch optimzer before symbolic evaluation takes place. +// We invoke the batch optimizer before symbolic evaluation takes place. // // Here we use only dictionary substitution, and invoke no symbolic // optimizations. diff --git a/tests/symengine/sd_common_tests/batch_optimizer_02.h b/tests/symengine/sd_common_tests/batch_optimizer_02.h index a04ed980fc..9b9b682878 100644 --- a/tests/symengine/sd_common_tests/batch_optimizer_02.h +++ b/tests/symengine/sd_common_tests/batch_optimizer_02.h @@ -17,7 +17,7 @@ // Check that the wrapper for symengine numbers can be integrated into the // tensor class and works as expected. // This test is the same as symengine_wrapper_03.cc, except that we invoke the -// batch optimzer before symbolic evaluation takes place. +// batch optimizer before symbolic evaluation takes place. #include diff --git a/tests/symengine/sd_common_tests/batch_optimizer_03.h b/tests/symengine/sd_common_tests/batch_optimizer_03.h index 2706c1eaac..2165397230 100644 --- a/tests/symengine/sd_common_tests/batch_optimizer_03.h +++ b/tests/symengine/sd_common_tests/batch_optimizer_03.h @@ -20,7 +20,7 @@ // See tests/symengine/basic_06.cc and tests/symengine/basic_07.cc for // a more simple example of differentiation of symbols with // explicit/implicit relationships. -// We invoke the batch optimzer before symbolic evaluation takes place. +// We invoke the batch optimizer before symbolic evaluation takes place. #include #include -- 2.39.5