From 2bf69f109da8948e3d72017b108016df8f8d2277 Mon Sep 17 00:00:00 2001 From: Rene Gassmoeller Date: Mon, 12 Aug 2024 13:00:56 -0600 Subject: [PATCH] Typo configuration --- .github/workflows/typos.yml | 62 +++++++++++++++++++ .typos.toml | 51 +++++++++++++++ doc/news/5.1.0-vs-5.2.0.h | 2 +- doc/news/8.4.2-vs-8.5.0.h | 2 +- doc/news/8.5.0-vs-9.0.0.h | 2 +- doc/news/9.3.3-vs-9.4.0.h | 2 +- doc/news/changes/minor/20240812Gassmoeller | 4 ++ examples/step-83/doc/intro.dox | 2 +- examples/step-83/doc/results.dox | 2 +- include/deal.II/base/time_stepping.h | 2 +- include/deal.II/grid/reference_cell.h | 2 +- include/deal.II/lac/petsc_ts.templates.h | 2 +- .../lac/trilinos_tpetra_precondition.h | 8 +-- tests/arpack/arpack_advection_diffusion.cc | 2 +- .../parpack_advection_diffusion_petsc.cc | 2 +- .../parpack_advection_diffusion_trilinos.cc | 2 +- tests/base/derivative_form_trivial_copy.cc | 2 +- tests/base/polynomial_minus_equals.cc | 4 +- tests/base/replace_in_string_01.cc | 8 +-- tests/bits/iterators_01.cc | 2 +- tests/boost/node_visitor_01.cc | 2 +- tests/cgal/cgal_mesh_criteria.cc | 6 +- tests/codim_one/fe_dgq_prolongation_01.cc | 2 +- tests/distributed_grids/2d_refinement_10.cc | 30 ++++----- .../distributed_grids/2d_refinement_10.output | 2 +- tests/distributed_grids/3d_refinement_12.cc | 30 ++++----- .../distributed_grids/3d_refinement_12.output | 2 +- tests/dofs/dof_constraints_11_x.cc | 3 +- tests/fe/br_approximation_01.cc | 7 ++- tests/fe/fe_conformity_test.h | 12 ++-- tests/fe/rt_approximation_01.cc | 7 ++- .../complex_real_full_matrix_09.cc | 2 +- tests/full_matrix/full_matrix_66.cc | 2 +- tests/grid/torus_01.cc | 2 +- tests/hp/fe_nothing_18.cc | 22 +++---- tests/hp/identity_constraints_01.cc | 2 +- tests/hp/identity_constraints_01.output | 6 +- tests/hp/identity_constraints_02.cc | 2 +- tests/hp/identity_constraints_02.output | 8 +-- .../assembler_simple_mgmatrix_04.cc | 6 +- tests/lac/constrained_linear_operator_01.cc | 2 +- tests/lac/diagonal_matrix_02.cc | 2 +- .../mappings/mapping_get_vertices_on_face.cc | 2 +- tests/mappings/mapping_q_cache_05.cc | 16 ++--- tests/mappings/mapping_q_cache_06.cc | 6 +- tests/mappings/mapping_q_cache_07.cc | 6 +- .../face_to_cell_index_nodal_simplex.cc | 6 +- tests/matrix_free/hp_dg_01.cc | 2 +- tests/matrix_free/matrix_vector_rt_01.cc | 2 +- tests/matrix_free/matrix_vector_rt_face_01.cc | 2 +- tests/mpi/derivative_approximation_01.cc | 2 +- ...c => petsc_distribute_01_inhomogeneous.cc} | 0 ...mogeneous.with_petsc=true.mpirun=1.output} | 0 ...ogeneous.with_petsc=true.mpirun=10.output} | 0 ...mogeneous.with_petsc=true.mpirun=2.output} | 0 ...mogeneous.with_petsc=true.mpirun=4.output} | 0 ...> trilinos_distribute_01_inhomogeneous.cc} | 0 ...eneous.with_trilinos=true.mpirun=1.output} | 0 ...neous.with_trilinos=true.mpirun=10.output} | 0 ...eneous.with_trilinos=true.mpirun=2.output} | 0 ...eneous.with_trilinos=true.mpirun=4.output} | 0 .../global_id_01.cc | 4 +- tests/multigrid/transfer_system_01.cc | 13 ---- tests/multigrid/transfer_system_02.cc | 13 ---- tests/multigrid/transfer_system_03.cc | 13 ---- tests/multigrid/transfer_system_04.cc | 13 ---- .../multigrid/transfer_system_adaptive_01.cc | 13 ---- .../multigrid/transfer_system_adaptive_02.cc | 13 ---- .../multigrid/transfer_system_adaptive_03.cc | 13 ---- .../multigrid/transfer_system_adaptive_04.cc | 13 ---- .../multigrid/transfer_system_adaptive_05.cc | 13 ---- .../multigrid/transfer_system_adaptive_06.cc | 13 ---- .../multigrid/transfer_system_adaptive_07.cc | 13 ---- .../multigrid/transfer_system_adaptive_08.cc | 13 ---- tests/non_matching/mesh_classifier.cc | 6 +- .../mesh_classifier.with_lapack=on.output | 4 +- .../prm/parameter_handler_26_fail.json | 2 +- .../prm/parameter_handler_26_fail.prm | 2 +- tests/particles/property_pool_03.cc | 2 +- .../performance/timing_matrix_free_kokkos.cc | 2 +- tests/petsc/step-77-snes.cc | 6 +- tests/petsc_complex/00.cc | 2 +- .../data_out_resample_01.cc | 8 +-- .../data_out_resample_02.cc | 8 +-- tests/simplex/mapping_fe_fields_02.cc | 4 +- tests/simplex/orientation_04.cc | 4 +- tests/tensors/constexpr_tensor.cc | 2 +- .../tensors/symmetric_tensor_trivial_copy.cc | 2 +- tests/tensors/tensor_trivial_copy.cc | 2 +- 89 files changed, 273 insertions(+), 311 deletions(-) create mode 100644 .github/workflows/typos.yml create mode 100644 .typos.toml create mode 100644 doc/news/changes/minor/20240812Gassmoeller rename tests/mpi/{petsc_distribute_01_inhomogenous.cc => petsc_distribute_01_inhomogeneous.cc} (100%) rename tests/mpi/{petsc_distribute_01_inhomogenous.with_petsc=true.mpirun=1.output => petsc_distribute_01_inhomogeneous.with_petsc=true.mpirun=1.output} (100%) rename tests/mpi/{petsc_distribute_01_inhomogenous.with_petsc=true.mpirun=10.output => petsc_distribute_01_inhomogeneous.with_petsc=true.mpirun=10.output} (100%) rename tests/mpi/{petsc_distribute_01_inhomogenous.with_petsc=true.mpirun=2.output => petsc_distribute_01_inhomogeneous.with_petsc=true.mpirun=2.output} (100%) rename tests/mpi/{petsc_distribute_01_inhomogenous.with_petsc=true.mpirun=4.output => petsc_distribute_01_inhomogeneous.with_petsc=true.mpirun=4.output} (100%) rename tests/mpi/{trilinos_distribute_01_inhomogenous.cc => trilinos_distribute_01_inhomogeneous.cc} (100%) rename tests/mpi/{trilinos_distribute_01_inhomogenous.with_trilinos=true.mpirun=1.output => trilinos_distribute_01_inhomogeneous.with_trilinos=true.mpirun=1.output} (100%) rename tests/mpi/{trilinos_distribute_01_inhomogenous.with_trilinos=true.mpirun=10.output => trilinos_distribute_01_inhomogeneous.with_trilinos=true.mpirun=10.output} (100%) rename tests/mpi/{trilinos_distribute_01_inhomogenous.with_trilinos=true.mpirun=2.output => trilinos_distribute_01_inhomogeneous.with_trilinos=true.mpirun=2.output} (100%) rename tests/mpi/{trilinos_distribute_01_inhomogenous.with_trilinos=true.mpirun=4.output => trilinos_distribute_01_inhomogeneous.with_trilinos=true.mpirun=4.output} (100%) diff --git a/.github/workflows/typos.yml b/.github/workflows/typos.yml new file mode 100644 index 0000000000..760528c1fb --- /dev/null +++ b/.github/workflows/typos.yml @@ -0,0 +1,62 @@ +name: Spell Check with Typos +on: + push: + branches: + - 'master' + pull_request: + +concurrency: + group: ${{ github.actor }}-${{ github.ref }}-typos + cancel-in-progress: true + +permissions: write-all + +jobs: + typos-check: + name: Check for new typos + runs-on: ubuntu-latest + timeout-minutes: 5 + steps: + - name: Checkout the Checkout Actions Repository + uses: actions/checkout@v4 + with: + persist-credentials: false + - name: Check spelling with typos + env: + GH_TOKEN: "${{ github.token }}" + run: | + mkdir -p "${{ runner.temp }}/typos" + wget --secure-protocol=TLSv1_3 --max-redirect=1 --retry-on-host-error --retry-connrefused --tries=3 \ + --quiet --output-document=- "https://github.com/crate-ci/typos/releases/download/v1.19.0/typos-v1.19.0-x86_64-unknown-linux-musl.tar.gz" \ + | tar -xz -C "${{ runner.temp }}/typos" ./typos + "${{ runner.temp }}/typos/typos" --version + + "${{ runner.temp }}/typos/typos" --config .typos.toml --format json doc examples include source tests >> ${{ runner.temp }}/typos.jsonl || true + - name: Update repo with fixable typos + uses: crate-ci/typos@v1.19.0 + with: + write_changes: true + config: ./.typos.toml + files: doc examples include source tests + - name: Store typos diff file + run: git diff > changes-typos.diff + - name: archive typos results + uses: actions/upload-artifact@v4 + with: + name: changes-typos.diff + path: changes-typos.diff + - name: Report typos as warnings + run: | + python -c ' + import sys, json + old = set() + clean = True + with open(sys.argv[1]) as file: + for line in file: + new = json.loads(line) + if new["type"] == "typo": + clean = False + print("::warning file={},line={},col={}::perhaps \"{}\" should be \"{}\".".format( + new["path"], new["line_num"], new["byte_offset"], + new["typo"], " or ".join(new["corrections"]))) + sys.exit(1 if not clean else 0)' "${{ runner.temp }}/typos.jsonl" diff --git a/.typos.toml b/.typos.toml new file mode 100644 index 0000000000..f636e74cf1 --- /dev/null +++ b/.typos.toml @@ -0,0 +1,51 @@ +[default] +# Don't check text that matches the following regexes' +extend-ignore-re = [ + '\\cite\{.*\}', # citations contain arbitrary keys, + '@cite \w' +] + +[default.extend-identifiers] +# Don't correct these whole identifiers (word-groups) +bungartz2016precice = "bungartz2016precice" +chourdakis2021precice = "chourdakis2021precice" +y_FoR = "y_FoR" +use_degress = "use_degress" +MPI_MODE_WRONLY = "MPI_MODE_WRONLY" +Equil = "Equil" +multline = "multline" + +[default.extend-words] +# Don't correct these word (parts) +OCE = "OCE" +MIS = "MIS" +parm = "parm" +nd = "nd" +inout = "inout" +datas = "datas" +Elemente = "Elemente" +Methode = "Methode" +workd = "workd" +Stoer = "Stoer" +Lik = "Lik" +htmp = "htmp" +Numer = "Numer" +ue = "ue" +reord = "reord" +Uite = "Uite" +strat = "strat" +Ned = "Ned" +BA = "BA" +Fike = "Fike" +clen = "clen" + +# Don't check the following files +[files] +extend-exclude = [ + # "*.output", + "tests/parameter_handler/parameter_handler_25.cc", # this file contains a typo on purpose + "*.svg", + "*.pvsm", + "*.vtu", + "*.bib", # bib entries contain many arbitrary abbreviations + ] diff --git a/doc/news/5.1.0-vs-5.2.0.h b/doc/news/5.1.0-vs-5.2.0.h index 7375b08ce3..dffcaa9eef 100644 --- a/doc/news/5.1.0-vs-5.2.0.h +++ b/doc/news/5.1.0-vs-5.2.0.h @@ -397,7 +397,7 @@ inconvenience this causes.
  • Improved: The class Quadrature has a new constructor generating the dim-dimensional tensor product of a - one-dimensonal formula directly. + one-dimensional formula directly.
    (GK, 2005/06/10)

    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 bd2a9b58b4..6e2f26e1df 100644 --- a/doc/news/8.4.2-vs-8.5.0.h +++ b/doc/news/8.4.2-vs-8.5.0.h @@ -1017,7 +1017,7 @@ inconvenience this causes.
  • - Improved: ContraintMatrix::distribute_local_to_global now does a bulk write of + Improved: ConstraintMatrix::distribute_local_to_global now does a bulk write of all vector values at once. This improves performance with PETScWrappers::MPI::Vector by about 10%.
    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 4fd133a5e5..62843f2c90 100644 --- a/doc/news/8.5.0-vs-9.0.0.h +++ b/doc/news/8.5.0-vs-9.0.0.h @@ -1037,7 +1037,7 @@ inconvenience this causes.
  • New: FECollection gained an equality comparison operator. Both FiniteElement - and FECollcetion have a non-equality comparison operator now. + and FECollection have a non-equality comparison operator now.
    (Daniel Arndt, 2018/04/25)
  • diff --git a/doc/news/9.3.3-vs-9.4.0.h b/doc/news/9.3.3-vs-9.4.0.h index 452ba65507..ac9539dea9 100644 --- a/doc/news/9.3.3-vs-9.4.0.h +++ b/doc/news/9.3.3-vs-9.4.0.h @@ -1645,7 +1645,7 @@ inconvenience this causes.
  • - New: You can now perform range-based iterations on hp::FECollecion, hp::QCollection, + New: You can now perform range-based iterations on hp::FECollection, hp::QCollection, and hp::MappingCollection objects.
    (Peter Munch, 2021/10/27) diff --git a/doc/news/changes/minor/20240812Gassmoeller b/doc/news/changes/minor/20240812Gassmoeller new file mode 100644 index 0000000000..cb2b19e0d3 --- /dev/null +++ b/doc/news/changes/minor/20240812Gassmoeller @@ -0,0 +1,4 @@ +New: deal.II contributions are now automatically checked +for typos using the 'typos' software. +
    +(Rene Gassmoeller, 2024/08/12) diff --git a/examples/step-83/doc/intro.dox b/examples/step-83/doc/intro.dox index 5c7408bbda..43634c38e4 100644 --- a/examples/step-83/doc/intro.dox +++ b/examples/step-83/doc/intro.dox @@ -606,7 +606,7 @@ in the program below, a "checkpoint" actually consists of a number of files -- one file into which we write the program's member variables, and several into which the triangulation puts its information. We then would have to rename several files, -preferrably as a single, "atomic" operation that cannot be +preferably as a single, "atomic" operation that cannot be interrupted. Implementing this is tricky and non-trivial (though possible), and so we will not show this part and instead just assume that nothing will happen between renaming the first diff --git a/examples/step-83/doc/results.dox b/examples/step-83/doc/results.dox index 75c26765b9..acb61b1892 100644 --- a/examples/step-83/doc/results.dox +++ b/examples/step-83/doc/results.dox @@ -112,7 +112,7 @@ lines: [...] @endcode What each of these numbers represents is hard to tell in practice, and also -entirely unimporant for our current purposes -- it's +entirely unimportant for our current purposes -- it's a representation of the many objects that make up this program's state, and from which one can restore its state. The point simply being that this is what serialization produces: A long list (a sequence) of bits that we can put diff --git a/include/deal.II/base/time_stepping.h b/include/deal.II/base/time_stepping.h index 16fbf228ef..257e612f50 100644 --- a/include/deal.II/base/time_stepping.h +++ b/include/deal.II/base/time_stepping.h @@ -508,7 +508,7 @@ namespace TimeStepping const double t, const double factor_solution, const double factor_ai, - const VectorType &corrent_ri, + const VectorType ¤t_ri, VectorType &vec_ki, VectorType &solution, VectorType &next_ri) const; diff --git a/include/deal.II/grid/reference_cell.h b/include/deal.II/grid/reference_cell.h index 507fc33600..4271b77778 100644 --- a/include/deal.II/grid/reference_cell.h +++ b/include/deal.II/grid/reference_cell.h @@ -68,7 +68,7 @@ namespace internal /** * Enum of different choices for istropic refinement. * There are 3 different ways to refine a tetrahedral, here we save the - * different possibilities. It is different to RefinementPossibilites are these + * different possibilities. It is different to RefinementPossibilities are these * are options in the case that an isotropic refinement is conducted. */ enum class IsotropicRefinementChoice : std::uint8_t diff --git a/include/deal.II/lac/petsc_ts.templates.h b/include/deal.II/lac/petsc_ts.templates.h index f3c351885b..a292f46678 100644 --- a/include/deal.II/lac/petsc_ts.templates.h +++ b/include/deal.II/lac/petsc_ts.templates.h @@ -1081,7 +1081,7 @@ namespace PETScWrappers // If we have the decide_and_prepare_for_remeshing callback // set, then we also need to have the callback for actually - // transfering the solution: + // transferring the solution: AssertThrow(interpolate || transfer_solution_vectors_to_new_mesh, StandardExceptions::ExcFunctionNotProvided( "transfer_solution_vectors_to_new_mesh")); diff --git a/include/deal.II/lac/trilinos_tpetra_precondition.h b/include/deal.II/lac/trilinos_tpetra_precondition.h index 9650d732bf..dc3e8427d8 100644 --- a/include/deal.II/lac/trilinos_tpetra_precondition.h +++ b/include/deal.II/lac/trilinos_tpetra_precondition.h @@ -73,7 +73,7 @@ namespace LinearAlgebra PreconditionBase() = default; /** - * @brief Desctructor. + * @brief Destructor. * Destroys the preconditioner, leaving an object like just after having * called the constructor. */ @@ -853,7 +853,7 @@ namespace LinearAlgebra */ double min_eigenvalue; /** - * @brief Estimated ratio between maximum and mimimum eigenvalue. + * @brief Estimated ratio between maximum and minimum eigenvalue. * */ double eigenvalue_ratio; @@ -930,7 +930,7 @@ namespace LinearAlgebra * @brief Constructor. * * Before factorization each diagonal entry will be modified by the - * following fomula \f[a_{ii}^{new} = \alpha\sign(a_{ii})+\beta a_{ii} + * following formula \f[a_{ii}^{new} = \alpha\sign(a_{ii})+\beta a_{ii} * \f] with \f[\alpha\f] given by ilu_atol and \f[\beta\f] given by * ilu_rtol. * @@ -1014,7 +1014,7 @@ namespace LinearAlgebra * @brief Constructor. * * Before factorization each diagonal entry will be modified by the - * following fomula \f[a_{ii}^{new} = \alpha\sign(a_{ii})+\beta a_{ii} + * following formula \f[a_{ii}^{new} = \alpha\sign(a_{ii})+\beta a_{ii} * \f] with \f[\alpha\f] given by ilut_atol and \f[\beta\f] given by * ilut_rtol. * diff --git a/tests/arpack/arpack_advection_diffusion.cc b/tests/arpack/arpack_advection_diffusion.cc index b83ff81d06..64c7a5d844 100644 --- a/tests/arpack/arpack_advection_diffusion.cc +++ b/tests/arpack/arpack_advection_diffusion.cc @@ -18,7 +18,7 @@ * Joscha Gedicke, U Heidelberg * * This file tests the non-symmetric interface to ARPACK for an - advection-diffussion + advection-diffusion * operator. The advection is chosen in such a way that we compute complex eigenvalues. * The most critical case when we cut a complex conjugate pair is tested, i.e. diff --git a/tests/arpack/parpack_advection_diffusion_petsc.cc b/tests/arpack/parpack_advection_diffusion_petsc.cc index f535afb12f..411417b6eb 100644 --- a/tests/arpack/parpack_advection_diffusion_petsc.cc +++ b/tests/arpack/parpack_advection_diffusion_petsc.cc @@ -13,7 +13,7 @@ * ------------------------------------------------------------------------ * This file tests the non-symmetric interface to PARPACK for an - advection-diffussion + advection-diffusion * operator with PETSc mpi vectors. * * We test that the computed vectors are eigenvectors and mass-normal, i.e. diff --git a/tests/arpack/parpack_advection_diffusion_trilinos.cc b/tests/arpack/parpack_advection_diffusion_trilinos.cc index e3354e9c48..73cb2b1c88 100644 --- a/tests/arpack/parpack_advection_diffusion_trilinos.cc +++ b/tests/arpack/parpack_advection_diffusion_trilinos.cc @@ -13,7 +13,7 @@ * ------------------------------------------------------------------------ * This file tests the non-symmetric interface to PARPACK for an - advection-diffussion + advection-diffusion * operator with Trilinos mpi vectors. * * We test that the computed vectors are eigenvectors and mass-normal, i.e. diff --git a/tests/base/derivative_form_trivial_copy.cc b/tests/base/derivative_form_trivial_copy.cc index 3c31788469..37684bddac 100644 --- a/tests/base/derivative_form_trivial_copy.cc +++ b/tests/base/derivative_form_trivial_copy.cc @@ -16,7 +16,7 @@ // Verify that DerivativeForm is trivially copyable. // TODO not all compilers that support enough of a subset of C++11 to compile -// the library (notably GCC 4.8) implement std::is_trivally_copyable. At some +// the library (notably GCC 4.8) implement std::is_trivially_copyable. At some // point in the future we should use that instead of the boost equivalent. #include diff --git a/tests/base/polynomial_minus_equals.cc b/tests/base/polynomial_minus_equals.cc index 212725dcb2..1b9ccfcd70 100644 --- a/tests/base/polynomial_minus_equals.cc +++ b/tests/base/polynomial_minus_equals.cc @@ -42,7 +42,7 @@ main() std::vector coefficients_a; // arbitrary point - double evalutation_number = 12.123; + double evaluation_number = 12.123; for (unsigned int pp = 0; pp < p_dim; ++pp) { @@ -53,6 +53,6 @@ main() test_poly_b -= test_poly_a; - deallog << test_poly_b.value(evalutation_number) << std::endl; + deallog << test_poly_b.value(evaluation_number) << std::endl; } } diff --git a/tests/base/replace_in_string_01.cc b/tests/base/replace_in_string_01.cc index 159e87f9ab..754a85e89d 100644 --- a/tests/base/replace_in_string_01.cc +++ b/tests/base/replace_in_string_01.cc @@ -37,11 +37,11 @@ check(const std::string in, void test() { - check("wie geht es dir?", "dir", "euch", "wie geht es euch?"); + check("how are you?", "you", "you all", "how are you all?"); check("empty from", "", "abc", "empty from"); - check("eins zwei drei", "ei", "", "ns zw dr"); - check("eins zwei drei", "zwei", "zweiundvierzig", "eins zweiundvierzig drei"); - check("wer das liest ist doof", "das liest ", "", "wer ist doof"); + check("one two three", "e", "", "on two thr"); + check("one two three", "two", "fortytwo", "one fortytwo three"); + check("how are you?", "how are ", "", "you?"); check("string string", "string", "", " "); check(" same is same", " same", " same", " same is same"); check(" ", " ", "", ""); diff --git a/tests/bits/iterators_01.cc b/tests/bits/iterators_01.cc index 43fd4a1cd7..8b26d8a18b 100644 --- a/tests/bits/iterators_01.cc +++ b/tests/bits/iterators_01.cc @@ -51,7 +51,7 @@ main() internal::BlockVectorIterators::Iterator, false>>::iterator_category; - using intervall_iterator_category = + using interval_iterator_category = std::iterator_traits::iterator_category; using element_iterator_category = std::iterator_traits::iterator_category; diff --git a/tests/boost/node_visitor_01.cc b/tests/boost/node_visitor_01.cc index be30f4b9a1..167cc57335 100644 --- a/tests/boost/node_visitor_01.cc +++ b/tests/boost/node_visitor_01.cc @@ -63,7 +63,7 @@ main() if (level == 2) { Assert(boxes_in_boxes.size() == 0, - ExcMessage("Leafs have no children.")); + ExcMessage("Leaves have no children.")); } else { diff --git a/tests/cgal/cgal_mesh_criteria.cc b/tests/cgal/cgal_mesh_criteria.cc index df5c9983a9..0d8e1bf96b 100644 --- a/tests/cgal/cgal_mesh_criteria.cc +++ b/tests/cgal/cgal_mesh_criteria.cc @@ -48,17 +48,17 @@ test() AdditionalData<3> data; data.cell_size = .1; cgal_surface_mesh_to_cgal_triangulation(sm, tria, data); - const unsigned int n_intial_facets = tria.number_of_facets_in_complex(); + const unsigned int n_initial_facets = tria.number_of_facets_in_complex(); tria.clear(); data.cell_size = .5; cgal_surface_mesh_to_cgal_triangulation(sm, tria, data); Assert( - n_intial_facets > tria.number_of_facets_in_complex(), + n_initial_facets > tria.number_of_facets_in_complex(), ExcMessage( "The number of facets in the finer mesh must be greater than the number of facets in the coarse mesh.")); deallog << std::boolalpha - << (n_intial_facets > tria.number_of_facets_in_complex()) + << (n_initial_facets > tria.number_of_facets_in_complex()) << std::endl; } diff --git a/tests/codim_one/fe_dgq_prolongation_01.cc b/tests/codim_one/fe_dgq_prolongation_01.cc index 7cbc919f21..0b2af65205 100644 --- a/tests/codim_one/fe_dgq_prolongation_01.cc +++ b/tests/codim_one/fe_dgq_prolongation_01.cc @@ -13,7 +13,7 @@ // ------------------------------------------------------------------------ -// this is the root cause for solution_tranfer_01: the prolongation +// this is the root cause for solution_transfer_01: the prolongation // matrices for FE_DGQ were not computed at all #include diff --git a/tests/distributed_grids/2d_refinement_10.cc b/tests/distributed_grids/2d_refinement_10.cc index 804f9f06c3..abbd37297f 100644 --- a/tests/distributed_grids/2d_refinement_10.cc +++ b/tests/distributed_grids/2d_refinement_10.cc @@ -123,8 +123,8 @@ main(int argc, char *argv[]) std::vector n_cell_smooth; std::vector n_cell_no_smooth; - std::set> final_cell_center_loactions_smooth; - std::set> final_cell_center_loactions_no_smooth; + std::set> final_cell_center_locations_smooth; + std::set> final_cell_center_locations_no_smooth; if (I_am_host) { deallog << "Flag limit_level_difference_at_vertices set:" << std::endl; @@ -132,7 +132,7 @@ main(int argc, char *argv[]) { TriaTest tria_test( dealii::Triangulation::limit_level_difference_at_vertices); - tria_test.run(n_cell_smooth, final_cell_center_loactions_smooth); + tria_test.run(n_cell_smooth, final_cell_center_locations_smooth); } if (I_am_host) { @@ -140,7 +140,7 @@ main(int argc, char *argv[]) } { TriaTest tria_test(dealii::Triangulation::none); - tria_test.run(n_cell_no_smooth, final_cell_center_loactions_no_smooth); + tria_test.run(n_cell_no_smooth, final_cell_center_locations_no_smooth); } if (I_am_host) { @@ -161,26 +161,26 @@ main(int argc, char *argv[]) } } { - bool cell_center_loactions_are_same = - (final_cell_center_loactions_smooth.size() == - final_cell_center_loactions_no_smooth.size()); + bool cell_center_locations_are_same = + (final_cell_center_locations_smooth.size() == + final_cell_center_locations_no_smooth.size()); std::set>::const_iterator it1 = - final_cell_center_loactions_smooth.begin(); + final_cell_center_locations_smooth.begin(); std::set>::const_iterator it2 = - final_cell_center_loactions_no_smooth.begin(); + final_cell_center_locations_no_smooth.begin(); - for (; cell_center_loactions_are_same && - (it1 != final_cell_center_loactions_smooth.end()); + for (; cell_center_locations_are_same && + (it1 != final_cell_center_locations_smooth.end()); ++it1, ++it2) { - cell_center_loactions_are_same = - cell_center_loactions_are_same && (*it1 == *it2); + cell_center_locations_are_same = + cell_center_locations_are_same && (*it1 == *it2); } if (I_am_host) { - deallog << "cell_center_loactions_are_same = " - << cell_center_loactions_are_same << std::endl; + deallog << "cell_center_locations_are_same = " + << cell_center_locations_are_same << std::endl; } } diff --git a/tests/distributed_grids/2d_refinement_10.output b/tests/distributed_grids/2d_refinement_10.output index fa349ed428..a83cfad86b 100644 --- a/tests/distributed_grids/2d_refinement_10.output +++ b/tests/distributed_grids/2d_refinement_10.output @@ -103,4 +103,4 @@ DEAL:2d::0.875000 0.625000 DEAL:2d::0.875000 0.875000 DEAL:2d::Compare result: DEAL:2d::n_cells_are_same = 1 -DEAL:2d::cell_center_loactions_are_same = 1 +DEAL:2d::cell_center_locations_are_same = 1 diff --git a/tests/distributed_grids/3d_refinement_12.cc b/tests/distributed_grids/3d_refinement_12.cc index cacd5683c7..aa45bd015f 100644 --- a/tests/distributed_grids/3d_refinement_12.cc +++ b/tests/distributed_grids/3d_refinement_12.cc @@ -123,8 +123,8 @@ main(int argc, char *argv[]) std::vector n_cell_smooth; std::vector n_cell_no_smooth; - std::set> final_cell_center_loactions_smooth; - std::set> final_cell_center_loactions_no_smooth; + std::set> final_cell_center_locations_smooth; + std::set> final_cell_center_locations_no_smooth; if (I_am_host) { deallog << "Flag limit_level_difference_at_vertices set:" << std::endl; @@ -132,7 +132,7 @@ main(int argc, char *argv[]) { TriaTest tria_test( dealii::Triangulation::limit_level_difference_at_vertices); - tria_test.run(n_cell_smooth, final_cell_center_loactions_smooth); + tria_test.run(n_cell_smooth, final_cell_center_locations_smooth); } if (I_am_host) { @@ -140,7 +140,7 @@ main(int argc, char *argv[]) } { TriaTest tria_test(dealii::Triangulation::none); - tria_test.run(n_cell_no_smooth, final_cell_center_loactions_no_smooth); + tria_test.run(n_cell_no_smooth, final_cell_center_locations_no_smooth); } if (I_am_host) { @@ -161,26 +161,26 @@ main(int argc, char *argv[]) } } { - bool cell_center_loactions_are_same = - (final_cell_center_loactions_smooth.size() == - final_cell_center_loactions_no_smooth.size()); + bool cell_center_locations_are_same = + (final_cell_center_locations_smooth.size() == + final_cell_center_locations_no_smooth.size()); std::set>::const_iterator it1 = - final_cell_center_loactions_smooth.begin(); + final_cell_center_locations_smooth.begin(); std::set>::const_iterator it2 = - final_cell_center_loactions_no_smooth.begin(); + final_cell_center_locations_no_smooth.begin(); - for (; cell_center_loactions_are_same && - (it1 != final_cell_center_loactions_smooth.end()); + for (; cell_center_locations_are_same && + (it1 != final_cell_center_locations_smooth.end()); ++it1, ++it2) { - cell_center_loactions_are_same = - cell_center_loactions_are_same && (*it1 == *it2); + cell_center_locations_are_same = + cell_center_locations_are_same && (*it1 == *it2); } if (I_am_host) { - deallog << "cell_center_loactions_are_same = " - << cell_center_loactions_are_same << std::endl; + deallog << "cell_center_locations_are_same = " + << cell_center_locations_are_same << std::endl; } } diff --git a/tests/distributed_grids/3d_refinement_12.output b/tests/distributed_grids/3d_refinement_12.output index 81aea2f43c..6716e3cea9 100644 --- a/tests/distributed_grids/3d_refinement_12.output +++ b/tests/distributed_grids/3d_refinement_12.output @@ -383,4 +383,4 @@ DEAL:3d::0.875000 0.875000 0.625000 DEAL:3d::0.875000 0.875000 0.875000 DEAL:3d::Compare result: DEAL:3d::n_cells_are_same = 1 -DEAL:3d::cell_center_loactions_are_same = 1 +DEAL:3d::cell_center_locations_are_same = 1 diff --git a/tests/dofs/dof_constraints_11_x.cc b/tests/dofs/dof_constraints_11_x.cc index 0db7f5625d..a33d17511e 100644 --- a/tests/dofs/dof_constraints_11_x.cc +++ b/tests/dofs/dof_constraints_11_x.cc @@ -14,8 +14,7 @@ -// simply check what happens when condensing BlockDyanmicSparsityPattern. This -// test was written when I changed a few things in the algorithm. +// simply check what happens when condensing BlockDynamicSparsityPattern. #include #include diff --git a/tests/fe/br_approximation_01.cc b/tests/fe/br_approximation_01.cc index 7e67b204b6..15f718bdfa 100644 --- a/tests/fe/br_approximation_01.cc +++ b/tests/fe/br_approximation_01.cc @@ -455,15 +455,16 @@ main() MappingQ1Eulerian<2> mapping_euler(*dof_handler_def, deformation); // Try rotating the elements - for (double rotat = 0; rotat < 2 * numbers::PI; rotat += 0.25 * numbers::PI) + for (double rotate = 0; rotate < 2 * numbers::PI; + rotate += 0.25 * numbers::PI) { // Rotate element VectorTools::project(*dof_handler_def, hn_constraints_def, QGauss<2>(6), - TestDef1<2>(2, rotat), + TestDef1<2>(2, rotate), deformation); - deallog << "phi = " << rotat << std::endl; + deallog << "phi = " << rotate << std::endl; TestProjection(mapping_euler, dof_handler); } diff --git a/tests/fe/fe_conformity_test.h b/tests/fe/fe_conformity_test.h index c83ca58304..27326e4958 100644 --- a/tests/fe/fe_conformity_test.h +++ b/tests/fe/fe_conformity_test.h @@ -91,7 +91,7 @@ namespace FEConforimityTest DoFHandler dof_handler; AffineConstraints constraints; - Vector random_fe_funtion; + Vector random_fe_function; const unsigned int config_switch; @@ -266,10 +266,10 @@ namespace FEConforimityTest constraints.close(); } - random_fe_funtion.reinit(dof_handler.n_dofs()); + random_fe_function.reinit(dof_handler.n_dofs()); // Fill vector with pseudo-random values - fill_vector_randomly(random_fe_funtion, /* min */ -5.0, /* max */ 5.0); + fill_vector_randomly(random_fe_function, /* min */ -5.0, /* max */ 5.0); } // make_dofs() @@ -453,7 +453,7 @@ namespace FEConforimityTest case FiniteElementData::Conformity::H1: { get_function_jump(fe_interface_values, - random_fe_funtion, + random_fe_function, interface_jumps); deallog << "Function jumps (at quad points) in cell " @@ -466,7 +466,7 @@ namespace FEConforimityTest case FiniteElementData::Conformity::Hdiv: { get_normal_jump(fe_interface_values, - random_fe_funtion, + random_fe_function, interface_jumps); deallog << "Normal jumps (at quad points) in cell " @@ -479,7 +479,7 @@ namespace FEConforimityTest case FiniteElementData::Conformity::Hcurl: { get_tangential_jump(fe_interface_values, - random_fe_funtion, + random_fe_function, interface_jumps); deallog << "Tangential jumps (at quad points) in cell " diff --git a/tests/fe/rt_approximation_01.cc b/tests/fe/rt_approximation_01.cc index 0bcb5072cf..a5ecdaef0e 100644 --- a/tests/fe/rt_approximation_01.cc +++ b/tests/fe/rt_approximation_01.cc @@ -467,15 +467,16 @@ main() MappingQ1Eulerian<2> mapping_euler(*dof_handler_def, deformation); // Try rotating the elements - for (double rotat = 0; rotat < 2 * numbers::PI; rotat += 0.25 * numbers::PI) + for (double rotate = 0; rotate < 2 * numbers::PI; + rotate += 0.25 * numbers::PI) { // Rotate element VectorTools::project(*dof_handler_def, hn_constraints_def, QGauss<2>(6), - TestDef1<2>(2, rotat), + TestDef1<2>(2, rotate), deformation); - deallog << "phi = " << rotat << std::endl; + deallog << "phi = " << rotate << std::endl; TestProjection(mapping_euler, dof_handler); } diff --git a/tests/full_matrix/complex_real_full_matrix_09.cc b/tests/full_matrix/complex_real_full_matrix_09.cc index e83f60c207..ccb5e38911 100644 --- a/tests/full_matrix/complex_real_full_matrix_09.cc +++ b/tests/full_matrix/complex_real_full_matrix_09.cc @@ -14,7 +14,7 @@ -// check assignment from IdenityMatrix. like the full_matrix_* tests, but use +// check assignment from IdentityMatrix. like the full_matrix_* tests, but use // complex-valued matrices and vectors, even though we only store real values // in them diff --git a/tests/full_matrix/full_matrix_66.cc b/tests/full_matrix/full_matrix_66.cc index 1f0082308f..acf377c63a 100644 --- a/tests/full_matrix/full_matrix_66.cc +++ b/tests/full_matrix/full_matrix_66.cc @@ -14,7 +14,7 @@ -// check assignment from IdenityMatrix +// check assignment from IdentityMatrix #include "../tests.h" diff --git a/tests/grid/torus_01.cc b/tests/grid/torus_01.cc index 42afc28430..76b04896b4 100644 --- a/tests/grid/torus_01.cc +++ b/tests/grid/torus_01.cc @@ -13,7 +13,7 @@ // ------------------------------------------------------------------------ // test GridTools::torus() the manifolds attached to the torus (TorusManifold, -// ToriodalManifold, TransfiniteInterpolationManifold), output visually +// ToroidalManifold, TransfiniteInterpolationManifold), output visually // checked #include diff --git a/tests/hp/fe_nothing_18.cc b/tests/hp/fe_nothing_18.cc index 4f48c14902..b17dc99edc 100644 --- a/tests/hp/fe_nothing_18.cc +++ b/tests/hp/fe_nothing_18.cc @@ -87,11 +87,11 @@ private: void setup_system(); - const unsigned int n_blocks; // total number of blocks - const unsigned int n_components; // total number of components - const unsigned int first_u_comp; // where displacements starts - const unsigned int first_lamda_comp; // where lagrage multipliers start - const unsigned int degree; // of shape functions + const unsigned int n_blocks; // total number of blocks + const unsigned int n_components; // total number of components + const unsigned int first_u_comp; // where displacements starts + const unsigned int first_lambda_comp; // where lagrage multipliers start + const unsigned int degree; // of shape functions std::vector dofs_per_block; @@ -118,7 +118,7 @@ private: // used for integral evaluation const FEValuesExtractors::Vector u_fe; - const FEValuesExtractors::Vector lamda_fe; + const FEValuesExtractors::Vector lambda_fe; unsigned int id_of_lagrange_mult; double beta1; @@ -156,7 +156,7 @@ public: virtual void vector_value(const Point &p, Vector &values) const; virtual double - value(const Point &p, unsigned int compoment) const; + value(const Point &p, unsigned int component) const; }; template @@ -169,7 +169,7 @@ BoundaryValues::vector_value(const Point &p, template inline double -BoundaryValues::value(const Point &p, unsigned int compoment) const +BoundaryValues::value(const Point &p, unsigned int component) const { return -0.001; } @@ -237,7 +237,7 @@ ElasticProblem::ElasticProblem() : n_blocks(2) , n_components(dim * n_blocks) , first_u_comp(0) - , first_lamda_comp(dim) + , first_lambda_comp(dim) , degree(1) , dofs_per_block(n_blocks) , dof_handler(triangulation) @@ -254,7 +254,7 @@ ElasticProblem::ElasticProblem() dim // same for lagrange multipliers ) , u_fe(first_u_comp) - , lamda_fe(first_lamda_comp) + , lambda_fe(first_lambda_comp) , id_of_lagrange_mult(1) , beta1(1.0) { @@ -343,7 +343,7 @@ ElasticProblem::setup_system() << n_elasticity_cells << std::endl; Assert(n_lagrange_cells > 0, ExcInternalError()); // there should be at least 1 cell! Otherwise - // DoFHanlder crashes with 0 dofs for block 2! + // DoFHandler crashes with 0 dofs for block 2! // //(2) distribute DoFs dof_handler.distribute_dofs( diff --git a/tests/hp/identity_constraints_01.cc b/tests/hp/identity_constraints_01.cc index e8549c2d47..c2ed646a6b 100644 --- a/tests/hp/identity_constraints_01.cc +++ b/tests/hp/identity_constraints_01.cc @@ -60,7 +60,7 @@ test() deallog << "Total constraints: " << constraints.n_constraints() << std::endl - << " Inhomogenous constraints: " << constraints.n_inhomogeneities() + << " Inhomogeneous constraints: " << constraints.n_inhomogeneities() << std::endl << " Identity constraints: " << constraints.n_identities() << std::endl; diff --git a/tests/hp/identity_constraints_01.output b/tests/hp/identity_constraints_01.output index 163e459c5a..c2656e0edd 100644 --- a/tests/hp/identity_constraints_01.output +++ b/tests/hp/identity_constraints_01.output @@ -1,10 +1,10 @@ DEAL:1d::Total constraints: 0 -DEAL:1d:: Inhomogenous constraints: 0 +DEAL:1d:: Inhomogeneous constraints: 0 DEAL:1d:: Identity constraints: 0 DEAL:2d::Total constraints: 2 -DEAL:2d:: Inhomogenous constraints: 0 +DEAL:2d:: Inhomogeneous constraints: 0 DEAL:2d:: Identity constraints: 0 DEAL:3d::Total constraints: 20 -DEAL:3d:: Inhomogenous constraints: 0 +DEAL:3d:: Inhomogeneous constraints: 0 DEAL:3d:: Identity constraints: 4 diff --git a/tests/hp/identity_constraints_02.cc b/tests/hp/identity_constraints_02.cc index a600b16630..9b4e62443e 100644 --- a/tests/hp/identity_constraints_02.cc +++ b/tests/hp/identity_constraints_02.cc @@ -99,7 +99,7 @@ test(std::array fe_degrees) deallog << "Total constraints: " << constraints.n_constraints() << std::endl - << " Inhomogenous constraints: " << constraints.n_inhomogeneities() + << " Inhomogeneous constraints: " << constraints.n_inhomogeneities() << std::endl << " Identity constraints: " << constraints.n_identities() << std::endl; diff --git a/tests/hp/identity_constraints_02.output b/tests/hp/identity_constraints_02.output index 7eee87e5c7..bff4164a73 100644 --- a/tests/hp/identity_constraints_02.output +++ b/tests/hp/identity_constraints_02.output @@ -1,15 +1,15 @@ DEAL::FE degrees: 1 - 4 DEAL:2d::Total constraints: 8 -DEAL:2d:: Inhomogenous constraints: 0 +DEAL:2d:: Inhomogeneous constraints: 0 DEAL:2d:: Identity constraints: 0 DEAL:3d::Total constraints: 55 -DEAL:3d:: Inhomogenous constraints: 0 +DEAL:3d:: Inhomogeneous constraints: 0 DEAL:3d:: Identity constraints: 3 DEAL::FE degrees: 2 - 5 DEAL:2d::Total constraints: 12 -DEAL:2d:: Inhomogenous constraints: 0 +DEAL:2d:: Inhomogeneous constraints: 0 DEAL:2d:: Identity constraints: 0 DEAL:3d::Total constraints: 92 -DEAL:3d:: Inhomogenous constraints: 0 +DEAL:3d:: Inhomogeneous constraints: 0 DEAL:3d:: Identity constraints: 4 diff --git a/tests/integrators/assembler_simple_mgmatrix_04.cc b/tests/integrators/assembler_simple_mgmatrix_04.cc index a93cea17e2..ebd0523a07 100644 --- a/tests/integrators/assembler_simple_mgmatrix_04.cc +++ b/tests/integrators/assembler_simple_mgmatrix_04.cc @@ -176,15 +176,15 @@ test(FiniteElement &fe) deallog << fe.get_name() << std::endl; Triangulation tr(Triangulation::limit_level_difference_at_vertices); - std::vector repititions(dim, 1); - repititions[0] = 2; + std::vector repetitions(dim, 1); + repetitions[0] = 2; const Point p1 = (dim == 1 ? Point(-1.) : (dim == 2 ? Point(-1., -1.) : Point(-1., -1., -1.))); const Point p2 = (dim == 1 ? Point(1.) : (dim == 2 ? Point(1., 1.) : Point(1., 1., 1.))); - GridGenerator::subdivided_hyper_rectangle(tr, repititions, p1, p2); + GridGenerator::subdivided_hyper_rectangle(tr, repetitions, p1, p2); tr.begin_active()->set_refine_flag(); tr.execute_coarsening_and_refinement(); diff --git a/tests/lac/constrained_linear_operator_01.cc b/tests/lac/constrained_linear_operator_01.cc index 13d9850201..29339f06e1 100644 --- a/tests/lac/constrained_linear_operator_01.cc +++ b/tests/lac/constrained_linear_operator_01.cc @@ -19,7 +19,7 @@ // of applying the constraints directly to the solution obtained by solving // the system: // (C^T * A * C + Id_c) * x = C^t * (b - A * k) -// with the help of constrainted_linear_operator and +// with the help of constrained_linear_operator and // constrained_right_hand_side #include diff --git a/tests/lac/diagonal_matrix_02.cc b/tests/lac/diagonal_matrix_02.cc index 44dd00f07a..16a8990fa0 100644 --- a/tests/lac/diagonal_matrix_02.cc +++ b/tests/lac/diagonal_matrix_02.cc @@ -14,7 +14,7 @@ -// this tests the correctness of distribute_local_to_globa() for DiagonalMatrix +// this tests the correctness of distribute_local_to_global() for DiagonalMatrix #include #include diff --git a/tests/mappings/mapping_get_vertices_on_face.cc b/tests/mappings/mapping_get_vertices_on_face.cc index 009697156c..dde4b20492 100644 --- a/tests/mappings/mapping_get_vertices_on_face.cc +++ b/tests/mappings/mapping_get_vertices_on_face.cc @@ -13,7 +13,7 @@ // ------------------------------------------------------------------------ -// Checks if vertices on face are given in correct oder +// Checks if vertices on face are given in correct order #include diff --git a/tests/mappings/mapping_q_cache_05.cc b/tests/mappings/mapping_q_cache_05.cc index e52dee1b88..fa5db3ed51 100644 --- a/tests/mappings/mapping_q_cache_05.cc +++ b/tests/mappings/mapping_q_cache_05.cc @@ -37,10 +37,10 @@ public: {} double - value(const Point &point, const unsigned int compontent) const + value(const Point &point, const unsigned int component) const { - return std::sin(point[compontent] * 0.5 * numbers::PI) - - (is_displacement_function ? point[compontent] : 0.0); + return std::sin(point[component] * 0.5 * numbers::PI) - + (is_displacement_function ? point[component] : 0.0); } private: @@ -93,9 +93,9 @@ main() const Point<2> &p) -> Point<2> { Point<2> result; - for (unsigned int compontent = 0; compontent < 2; ++compontent) - result[compontent] = - std::sin(p[compontent] * 0.5 * numbers::PI) - p[compontent]; + for (unsigned int component = 0; component < 2; ++component) + result[component] = + std::sin(p[component] * 0.5 * numbers::PI) - p[component]; return result; }, @@ -106,8 +106,8 @@ main() const Point<2> &p) -> Point<2> { Point<2> result; - for (unsigned int compontent = 0; compontent < 2; ++compontent) - result[compontent] = std::sin(p[compontent] * 0.5 * numbers::PI); + for (unsigned int component = 0; component < 2; ++component) + result[component] = std::sin(p[component] * 0.5 * numbers::PI); return result; }, diff --git a/tests/mappings/mapping_q_cache_06.cc b/tests/mappings/mapping_q_cache_06.cc index b35b8ab6f1..de3f94c482 100644 --- a/tests/mappings/mapping_q_cache_06.cc +++ b/tests/mappings/mapping_q_cache_06.cc @@ -43,10 +43,10 @@ public: {} double - value(const Point &point, const unsigned int compontent) const + value(const Point &point, const unsigned int component) const { - return std::sin(point[compontent] * 0.5 * numbers::PI) - - (is_displacement_function ? point[compontent] : 0.0); + return std::sin(point[component] * 0.5 * numbers::PI) - + (is_displacement_function ? point[component] : 0.0); } private: diff --git a/tests/mappings/mapping_q_cache_07.cc b/tests/mappings/mapping_q_cache_07.cc index 6760e990d3..7925bcb694 100644 --- a/tests/mappings/mapping_q_cache_07.cc +++ b/tests/mappings/mapping_q_cache_07.cc @@ -65,10 +65,10 @@ test(const bool vector_describes_relative_displacement, if (vector_describes_relative_displacement) { - Vector absolut_vector(dof_handler_dim.n_dofs()); - VectorTools::get_position_vector(dof_handler_dim, absolut_vector); + Vector absolute_vector(dof_handler_dim.n_dofs()); + VectorTools::get_position_vector(dof_handler_dim, absolute_vector); - euler_vector -= absolut_vector; + euler_vector -= absolute_vector; } // output mesh with with MappingFEField based on a vector constructed diff --git a/tests/matrix_free/face_to_cell_index_nodal_simplex.cc b/tests/matrix_free/face_to_cell_index_nodal_simplex.cc index 1a8805dd0e..84688255f9 100644 --- a/tests/matrix_free/face_to_cell_index_nodal_simplex.cc +++ b/tests/matrix_free/face_to_cell_index_nodal_simplex.cc @@ -48,13 +48,13 @@ test(const FiniteElement &fe, const Quadrature &quad) Triangulation tria; GridGenerator::reference_cell(tria, fe.reference_cell()); - FE_SimplexP fe_continous(fe.degree); + FE_SimplexP fe_continuous(fe.degree); DoFHandler dof_handler(tria); - dof_handler.distribute_dofs(fe_continous); + dof_handler.distribute_dofs(fe_continuous); std::vector dof_indices( - fe_continous.n_dofs_per_face()); + fe_continuous.n_dofs_per_face()); for (const auto &cell : dof_handler.active_cell_iterators()) { unsigned int face_counter = 0; diff --git a/tests/matrix_free/hp_dg_01.cc b/tests/matrix_free/hp_dg_01.cc index cf76657a89..4528ac5938 100644 --- a/tests/matrix_free/hp_dg_01.cc +++ b/tests/matrix_free/hp_dg_01.cc @@ -12,7 +12,7 @@ // // ------------------------------------------------------------------------ -// Check if intialization of FEFaceEvaluation works for hp + DG in 3D. +// Check if initialization of FEFaceEvaluation works for hp + DG in 3D. #include #include diff --git a/tests/matrix_free/matrix_vector_rt_01.cc b/tests/matrix_free/matrix_vector_rt_01.cc index a7c2e372bc..3e8c0dcd98 100644 --- a/tests/matrix_free/matrix_vector_rt_01.cc +++ b/tests/matrix_free/matrix_vector_rt_01.cc @@ -14,7 +14,7 @@ // This function tests the correctness of the matrix-free implementation // of the FE_RaviartThomasNodal element by evaluating values + gradients -// as well as the divergence and comparing the result with FEVaules which +// as well as the divergence and comparing the result with FEValues which // is considered the reference. The mesh is a hypercube mesh with no // hanging nodes and no other constraints. diff --git a/tests/matrix_free/matrix_vector_rt_face_01.cc b/tests/matrix_free/matrix_vector_rt_face_01.cc index bd9c87820c..8492e41c1d 100644 --- a/tests/matrix_free/matrix_vector_rt_face_01.cc +++ b/tests/matrix_free/matrix_vector_rt_face_01.cc @@ -15,7 +15,7 @@ // This function tests the correctness of the matrix-free implementation // of the FE_RaviartThomasNodal element by evaluating values + gradients // as well as the divergence on faces and comparing the result with -// FEFaceVaules which is considered the reference. The mesh is a hypercube +// FEFaceValues which is considered the reference. The mesh is a hypercube // mesh with no hanging nodes and no other constraints. #include "../tests.h" diff --git a/tests/mpi/derivative_approximation_01.cc b/tests/mpi/derivative_approximation_01.cc index 5c42787f65..c851f1810c 100644 --- a/tests/mpi/derivative_approximation_01.cc +++ b/tests/mpi/derivative_approximation_01.cc @@ -14,7 +14,7 @@ -// document bug in the DerivateApproximation in parallel +// document bug in the DerivativeApproximation in parallel /* -------------------------------------------------------- An error occurred in line <3349> of file diff --git a/tests/mpi/petsc_distribute_01_inhomogenous.cc b/tests/mpi/petsc_distribute_01_inhomogeneous.cc similarity index 100% rename from tests/mpi/petsc_distribute_01_inhomogenous.cc rename to tests/mpi/petsc_distribute_01_inhomogeneous.cc diff --git a/tests/mpi/petsc_distribute_01_inhomogenous.with_petsc=true.mpirun=1.output b/tests/mpi/petsc_distribute_01_inhomogeneous.with_petsc=true.mpirun=1.output similarity index 100% rename from tests/mpi/petsc_distribute_01_inhomogenous.with_petsc=true.mpirun=1.output rename to tests/mpi/petsc_distribute_01_inhomogeneous.with_petsc=true.mpirun=1.output diff --git a/tests/mpi/petsc_distribute_01_inhomogenous.with_petsc=true.mpirun=10.output b/tests/mpi/petsc_distribute_01_inhomogeneous.with_petsc=true.mpirun=10.output similarity index 100% rename from tests/mpi/petsc_distribute_01_inhomogenous.with_petsc=true.mpirun=10.output rename to tests/mpi/petsc_distribute_01_inhomogeneous.with_petsc=true.mpirun=10.output diff --git a/tests/mpi/petsc_distribute_01_inhomogenous.with_petsc=true.mpirun=2.output b/tests/mpi/petsc_distribute_01_inhomogeneous.with_petsc=true.mpirun=2.output similarity index 100% rename from tests/mpi/petsc_distribute_01_inhomogenous.with_petsc=true.mpirun=2.output rename to tests/mpi/petsc_distribute_01_inhomogeneous.with_petsc=true.mpirun=2.output diff --git a/tests/mpi/petsc_distribute_01_inhomogenous.with_petsc=true.mpirun=4.output b/tests/mpi/petsc_distribute_01_inhomogeneous.with_petsc=true.mpirun=4.output similarity index 100% rename from tests/mpi/petsc_distribute_01_inhomogenous.with_petsc=true.mpirun=4.output rename to tests/mpi/petsc_distribute_01_inhomogeneous.with_petsc=true.mpirun=4.output diff --git a/tests/mpi/trilinos_distribute_01_inhomogenous.cc b/tests/mpi/trilinos_distribute_01_inhomogeneous.cc similarity index 100% rename from tests/mpi/trilinos_distribute_01_inhomogenous.cc rename to tests/mpi/trilinos_distribute_01_inhomogeneous.cc diff --git a/tests/mpi/trilinos_distribute_01_inhomogenous.with_trilinos=true.mpirun=1.output b/tests/mpi/trilinos_distribute_01_inhomogeneous.with_trilinos=true.mpirun=1.output similarity index 100% rename from tests/mpi/trilinos_distribute_01_inhomogenous.with_trilinos=true.mpirun=1.output rename to tests/mpi/trilinos_distribute_01_inhomogeneous.with_trilinos=true.mpirun=1.output diff --git a/tests/mpi/trilinos_distribute_01_inhomogenous.with_trilinos=true.mpirun=10.output b/tests/mpi/trilinos_distribute_01_inhomogeneous.with_trilinos=true.mpirun=10.output similarity index 100% rename from tests/mpi/trilinos_distribute_01_inhomogenous.with_trilinos=true.mpirun=10.output rename to tests/mpi/trilinos_distribute_01_inhomogeneous.with_trilinos=true.mpirun=10.output diff --git a/tests/mpi/trilinos_distribute_01_inhomogenous.with_trilinos=true.mpirun=2.output b/tests/mpi/trilinos_distribute_01_inhomogeneous.with_trilinos=true.mpirun=2.output similarity index 100% rename from tests/mpi/trilinos_distribute_01_inhomogenous.with_trilinos=true.mpirun=2.output rename to tests/mpi/trilinos_distribute_01_inhomogeneous.with_trilinos=true.mpirun=2.output diff --git a/tests/mpi/trilinos_distribute_01_inhomogenous.with_trilinos=true.mpirun=4.output b/tests/mpi/trilinos_distribute_01_inhomogeneous.with_trilinos=true.mpirun=4.output similarity index 100% rename from tests/mpi/trilinos_distribute_01_inhomogenous.with_trilinos=true.mpirun=4.output rename to tests/mpi/trilinos_distribute_01_inhomogeneous.with_trilinos=true.mpirun=4.output diff --git a/tests/multigrid-global-coarsening/global_id_01.cc b/tests/multigrid-global-coarsening/global_id_01.cc index b33125a032..e0165fbc5d 100644 --- a/tests/multigrid-global-coarsening/global_id_01.cc +++ b/tests/multigrid-global-coarsening/global_id_01.cc @@ -42,7 +42,7 @@ test(const MPI_Comm comm) GridGenerator::subdivided_hyper_cube(basetria, 4); basetria.refine_global(4); - const auto deterimine_n_coarse_cells = [&comm](auto &tria) { + const auto determine_n_coarse_cells = [&comm](auto &tria) { types::coarse_cell_id n_coarse_cells = 0; for (auto cell : tria.active_cell_iterators()) @@ -55,7 +55,7 @@ test(const MPI_Comm comm) // create translator: CellID <-> unique ID internal::CellIDTranslator cell_id_translator( - deterimine_n_coarse_cells(basetria), basetria.n_global_levels()); + determine_n_coarse_cells(basetria), basetria.n_global_levels()); for (auto cell : basetria.cell_iterators()) diff --git a/tests/multigrid/transfer_system_01.cc b/tests/multigrid/transfer_system_01.cc index 82a7991c7d..4b3d38eaae 100644 --- a/tests/multigrid/transfer_system_01.cc +++ b/tests/multigrid/transfer_system_01.cc @@ -38,19 +38,6 @@ -template -void -reinit_vector(const dealii::DoFHandler &mg_dof, - MGLevelObject> &v) -{ - for (unsigned int level = v.min_level(); level <= v.max_leve(); ++level) - { - unsigned int n = mg_dof.n_dofs(level); - v[level].reinit(n); - } -} - - template void make_matrix(const Transfer &transfer, diff --git a/tests/multigrid/transfer_system_02.cc b/tests/multigrid/transfer_system_02.cc index e5d13851db..8a2c6ef213 100644 --- a/tests/multigrid/transfer_system_02.cc +++ b/tests/multigrid/transfer_system_02.cc @@ -39,19 +39,6 @@ -template -void -reinit_vector(const dealii::DoFHandler &mg_dof, - MGLevelObject> &v) -{ - for (unsigned int level = v.min_level(); level <= v.max_leve(); ++level) - { - unsigned int n = mg_dof.n_dofs(level); - v[level].reinit(n); - } -} - - template void make_matrix(const Transfer &transfer, diff --git a/tests/multigrid/transfer_system_03.cc b/tests/multigrid/transfer_system_03.cc index c9cb8c22de..f3beb22127 100644 --- a/tests/multigrid/transfer_system_03.cc +++ b/tests/multigrid/transfer_system_03.cc @@ -40,19 +40,6 @@ -template -void -reinit_vector(const dealii::DoFHandler &mg_dof, - MGLevelObject> &v) -{ - for (unsigned int level = v.min_level(); level <= v.max_leve(); ++level) - { - unsigned int n = mg_dof.n_dofs(level); - v[level].reinit(n); - } -} - - template void make_matrix(const Transfer &transfer, diff --git a/tests/multigrid/transfer_system_04.cc b/tests/multigrid/transfer_system_04.cc index 8566dc4e63..16730d0edf 100644 --- a/tests/multigrid/transfer_system_04.cc +++ b/tests/multigrid/transfer_system_04.cc @@ -40,19 +40,6 @@ -template -void -reinit_vector(const dealii::DoFHandler &mg_dof, - MGLevelObject> &v) -{ - for (unsigned int level = v.min_level(); level <= v.max_leve(); ++level) - { - unsigned int n = mg_dof.n_dofs(level); - v[level].reinit(n); - } -} - - template void make_matrix(const Transfer &transfer, diff --git a/tests/multigrid/transfer_system_adaptive_01.cc b/tests/multigrid/transfer_system_adaptive_01.cc index 6cb654c595..aa8857eba8 100644 --- a/tests/multigrid/transfer_system_adaptive_01.cc +++ b/tests/multigrid/transfer_system_adaptive_01.cc @@ -41,19 +41,6 @@ -template -void -reinit_vector(const dealii::DoFHandler &mg_dof, - MGLevelObject> &v) -{ - for (unsigned int level = v.min_level(); level <= v.max_leve(); ++level) - { - unsigned int n = mg_dof.n_dofs(level); - v[level].reinit(n); - } -} - - template void make_matrix(const Transfer &transfer, diff --git a/tests/multigrid/transfer_system_adaptive_02.cc b/tests/multigrid/transfer_system_adaptive_02.cc index 9c3b2134e8..395121919f 100644 --- a/tests/multigrid/transfer_system_adaptive_02.cc +++ b/tests/multigrid/transfer_system_adaptive_02.cc @@ -41,19 +41,6 @@ -template -void -reinit_vector(const dealii::DoFHandler &mg_dof, - MGLevelObject> &v) -{ - for (unsigned int level = v.min_level(); level <= v.max_leve(); ++level) - { - unsigned int n = mg_dof.n_dofs(level); - v[level].reinit(n); - } -} - - template void make_matrix(const Transfer &transfer, diff --git a/tests/multigrid/transfer_system_adaptive_03.cc b/tests/multigrid/transfer_system_adaptive_03.cc index fa0ad66327..f603099c20 100644 --- a/tests/multigrid/transfer_system_adaptive_03.cc +++ b/tests/multigrid/transfer_system_adaptive_03.cc @@ -42,19 +42,6 @@ -template -void -reinit_vector(const dealii::DoFHandler &mg_dof, - MGLevelObject> &v) -{ - for (unsigned int level = v.min_level(); level <= v.max_leve(); ++level) - { - unsigned int n = mg_dof.n_dofs(level); - v[level].reinit(n); - } -} - - template void make_matrix(const Transfer &transfer, diff --git a/tests/multigrid/transfer_system_adaptive_04.cc b/tests/multigrid/transfer_system_adaptive_04.cc index 4788d09237..d2cde09005 100644 --- a/tests/multigrid/transfer_system_adaptive_04.cc +++ b/tests/multigrid/transfer_system_adaptive_04.cc @@ -41,19 +41,6 @@ -template -void -reinit_vector(const dealii::DoFHandler &mg_dof, - MGLevelObject> &v) -{ - for (unsigned int level = v.min_level(); level <= v.max_leve(); ++level) - { - unsigned int n = mg_dof.n_dofs(level); - v[level].reinit(n); - } -} - - template void make_matrix(const Transfer &transfer, diff --git a/tests/multigrid/transfer_system_adaptive_05.cc b/tests/multigrid/transfer_system_adaptive_05.cc index 53eb8efe05..59de61a86a 100644 --- a/tests/multigrid/transfer_system_adaptive_05.cc +++ b/tests/multigrid/transfer_system_adaptive_05.cc @@ -43,19 +43,6 @@ -template -void -reinit_vector(const dealii::DoFHandler &mg_dof, - MGLevelObject> &v) -{ - for (unsigned int level = v.min_level(); level <= v.max_leve(); ++level) - { - unsigned int n = mg_dof.n_dofs(level); - v[level].reinit(n); - } -} - - template void make_matrix(const Transfer &transfer, diff --git a/tests/multigrid/transfer_system_adaptive_06.cc b/tests/multigrid/transfer_system_adaptive_06.cc index 29e5fe88bc..0506b64a8d 100644 --- a/tests/multigrid/transfer_system_adaptive_06.cc +++ b/tests/multigrid/transfer_system_adaptive_06.cc @@ -41,19 +41,6 @@ -template -void -reinit_vector(const dealii::DoFHandler &mg_dof, - MGLevelObject> &v) -{ - for (unsigned int level = v.min_level(); level <= v.max_leve(); ++level) - { - unsigned int n = mg_dof.n_dofs(level); - v[level].reinit(n); - } -} - - template void make_matrix(const Transfer &transfer, diff --git a/tests/multigrid/transfer_system_adaptive_07.cc b/tests/multigrid/transfer_system_adaptive_07.cc index b9e9cec1b3..2e5a0dff4a 100644 --- a/tests/multigrid/transfer_system_adaptive_07.cc +++ b/tests/multigrid/transfer_system_adaptive_07.cc @@ -43,19 +43,6 @@ -template -void -reinit_vector(const dealii::DoFHandler &mg_dof, - MGLevelObject> &v) -{ - for (unsigned int level = v.min_level(); level <= v.max_leve(); ++level) - { - unsigned int n = mg_dof.n_dofs(level); - v[level].reinit(n); - } -} - - template void make_matrix(const Transfer &transfer, diff --git a/tests/multigrid/transfer_system_adaptive_08.cc b/tests/multigrid/transfer_system_adaptive_08.cc index f6a61497ff..876886b937 100644 --- a/tests/multigrid/transfer_system_adaptive_08.cc +++ b/tests/multigrid/transfer_system_adaptive_08.cc @@ -42,19 +42,6 @@ -template -void -reinit_vector(const dealii::DoFHandler &mg_dof, - MGLevelObject> &v) -{ - for (unsigned int level = v.min_level(); level <= v.max_leve(); ++level) - { - unsigned int n = mg_dof.n_dofs(level); - v[level].reinit(n); - } -} - - template void make_matrix(const Transfer &transfer, diff --git a/tests/non_matching/mesh_classifier.cc b/tests/non_matching/mesh_classifier.cc index 329f4870b0..087d27d4a3 100644 --- a/tests/non_matching/mesh_classifier.cc +++ b/tests/non_matching/mesh_classifier.cc @@ -289,9 +289,9 @@ setup_intersected_Q2_positive_coefficients<3>(Vector &level_set) // functions are negative between the support points. template void -test_lagrange_coefficents_positive() +test_lagrange_coefficients_positive() { - deallog << "test_lagrange_coefficents_positive" << std::endl; + deallog << "test_lagrange_coefficients_positive" << std::endl; Triangulation triangulation; GridGenerator::hyper_cube(triangulation); @@ -367,7 +367,7 @@ run_test() test_intersection_x_eq_0_plane(); // This test doesn't make sense in 1D. if (dim != 1) - test_lagrange_coefficents_positive(); + test_lagrange_coefficients_positive(); test_reclassify_called_multiple_times(); } diff --git a/tests/non_matching/mesh_classifier.with_lapack=on.output b/tests/non_matching/mesh_classifier.with_lapack=on.output index 338309e69e..50f1954936 100644 --- a/tests/non_matching/mesh_classifier.with_lapack=on.output +++ b/tests/non_matching/mesh_classifier.with_lapack=on.output @@ -95,7 +95,7 @@ DEAL::face 1 outside DEAL::face 2 intersected DEAL::face 3 intersected DEAL:: -DEAL::test_lagrange_coefficents_positive +DEAL::test_lagrange_coefficients_positive DEAL::cell intersected DEAL::face 0 outside DEAL::face 1 outside @@ -177,7 +177,7 @@ DEAL::face 3 intersected DEAL::face 4 intersected DEAL::face 5 intersected DEAL:: -DEAL::test_lagrange_coefficents_positive +DEAL::test_lagrange_coefficients_positive DEAL::cell intersected DEAL::face 0 outside DEAL::face 1 intersected diff --git a/tests/parameter_handler/prm/parameter_handler_26_fail.json b/tests/parameter_handler/prm/parameter_handler_26_fail.json index bb26073225..2df3ba6266 100644 --- a/tests/parameter_handler/prm/parameter_handler_26_fail.json +++ b/tests/parameter_handler/prm/parameter_handler_26_fail.json @@ -1,5 +1,5 @@ { "General": { - "Precison": "float" + "Precision": "float" } } diff --git a/tests/parameter_handler/prm/parameter_handler_26_fail.prm b/tests/parameter_handler/prm/parameter_handler_26_fail.prm index ecbda56223..6878b54c1a 100644 --- a/tests/parameter_handler/prm/parameter_handler_26_fail.prm +++ b/tests/parameter_handler/prm/parameter_handler_26_fail.prm @@ -1,3 +1,3 @@ subsection General - set Precison = float + set Precision = float end diff --git a/tests/particles/property_pool_03.cc b/tests/particles/property_pool_03.cc index bc5d7efb5d..9b5947a2d6 100644 --- a/tests/particles/property_pool_03.cc +++ b/tests/particles/property_pool_03.cc @@ -37,7 +37,7 @@ test() std::vector::Handle> particle_handles; - // Allocate some space in non-contigous locations + // Allocate some space in non-contiguous locations particle_handles.push_back(pool.register_particle()); particle_handles.insert(particle_handles.begin(), pool.register_particle()); particle_handles.push_back(pool.register_particle()); diff --git a/tests/performance/timing_matrix_free_kokkos.cc b/tests/performance/timing_matrix_free_kokkos.cc index d5d343e447..c9b0f53fbf 100644 --- a/tests/performance/timing_matrix_free_kokkos.cc +++ b/tests/performance/timing_matrix_free_kokkos.cc @@ -18,7 +18,7 @@ * infrastructure on the CPU. Considered are the initialization * costs and the costs for an operator evaluation. * CUDAWrapper::MatrixFree was written with CUDA and now uses - * Kokkos as backend and, as consequnce, favors GPU hardware. This + * Kokkos as backend and, as consequence, favors GPU hardware. This * performance test is meant to track the improvement of * the performance of CUDAWrapper::MatrixFree on the CPU. * diff --git a/tests/petsc/step-77-snes.cc b/tests/petsc/step-77-snes.cc index d88a754816..4617d1cb2a 100644 --- a/tests/petsc/step-77-snes.cc +++ b/tests/petsc/step-77-snes.cc @@ -323,7 +323,7 @@ namespace Step77 // The following function is similar to that in step-77, // except that it supports parallel assembly. - // The Jacobian is assembled using homogenous boundary conditions + // The Jacobian is assembled using homogeneous boundary conditions // since we always solve for the update step. // Here we don't need to reevaluate the `locally_relevant_solution` // vector since SNES guaranties that the Jacobian callback is called @@ -463,7 +463,7 @@ namespace Step77 // Again, this is basically a verbatim copy of the function in step-77. // The only differences are in how we setup the nonlinear solver and in - // the way we handle non-homogenous boundary conditions. + // the way we handle non-homogeneous boundary conditions. template void MinimalSurfaceProblem::run() @@ -586,7 +586,7 @@ namespace Step77 // We are now set up to solve the nonlinear system nonlinear_solver.solve(current_solution); - // Differently from step-77, we apply non-homogenous boundary + // Differently from step-77, we apply non-homogeneous boundary // conditions only once, after the algebraic solve is done. // Note that this call is only needed since this example uses hanging // nodes constraints. diff --git a/tests/petsc_complex/00.cc b/tests/petsc_complex/00.cc index 2c5c148262..3b0887a07b 100644 --- a/tests/petsc_complex/00.cc +++ b/tests/petsc_complex/00.cc @@ -18,7 +18,7 @@ #include "../tests.h" // These tests were used while building extensions for -// PetscSclar=complex. They check that std::complex and +// PetscScalar=complex. They check that std::complex and // PetscScalar complex are compatible without explicitly casting. // // These tests look archaic - they are the original tests used to diff --git a/tests/remote_point_evaluation/data_out_resample_01.cc b/tests/remote_point_evaluation/data_out_resample_01.cc index c73c61f0e8..00028fc67c 100644 --- a/tests/remote_point_evaluation/data_out_resample_01.cc +++ b/tests/remote_point_evaluation/data_out_resample_01.cc @@ -86,11 +86,11 @@ main(int argc, char **argv) MappingQ1 mapping_slice; - parallel::distributed::Triangulation tria_backround(comm); - GridGenerator::hyper_cube(tria_backround, -1.0, +1.0); - tria_backround.refine_global(n_refinements_1); + parallel::distributed::Triangulation tria_background(comm); + GridGenerator::hyper_cube(tria_background, -1.0, +1.0); + tria_background.refine_global(n_refinements_1); - DoFHandler dof_handler(tria_backround); + DoFHandler dof_handler(tria_background); dof_handler.distribute_dofs(FE_Q{1}); MappingQ1 mapping; diff --git a/tests/remote_point_evaluation/data_out_resample_02.cc b/tests/remote_point_evaluation/data_out_resample_02.cc index e4f18685f1..0e10743763 100644 --- a/tests/remote_point_evaluation/data_out_resample_02.cc +++ b/tests/remote_point_evaluation/data_out_resample_02.cc @@ -87,11 +87,11 @@ main(int argc, char **argv) MappingQ1 mapping_slice; - parallel::distributed::Triangulation tria_backround(comm); - GridGenerator::hyper_cube(tria_backround, -1.0, +1.0); - tria_backround.refine_global(n_refinements_1); + parallel::distributed::Triangulation tria_background(comm); + GridGenerator::hyper_cube(tria_background, -1.0, +1.0); + tria_background.refine_global(n_refinements_1); - DoFHandler dof_handler(tria_backround); + DoFHandler dof_handler(tria_background); dof_handler.distribute_dofs( FESystem(FE_Q{1}, n_components)); diff --git a/tests/simplex/mapping_fe_fields_02.cc b/tests/simplex/mapping_fe_fields_02.cc index e7a9d91afd..05de3d2913 100644 --- a/tests/simplex/mapping_fe_fields_02.cc +++ b/tests/simplex/mapping_fe_fields_02.cc @@ -47,9 +47,9 @@ public: {} double - value(const Point &point, const unsigned int compontent) const + value(const Point &point, const unsigned int component) const { - return std::sin(point[compontent] * 0.5 * numbers::PI); + return std::sin(point[component] * 0.5 * numbers::PI); } }; diff --git a/tests/simplex/orientation_04.cc b/tests/simplex/orientation_04.cc index 49c032b4c5..c348ea19b6 100644 --- a/tests/simplex/orientation_04.cc +++ b/tests/simplex/orientation_04.cc @@ -47,7 +47,7 @@ std::tuple create_triangulation(const std::vector> &vertices_, const std::vector> &cell_data_, const unsigned int face_n, - const unsigned int n_permuations, + const unsigned int n_permutations, Triangulation<3> &tria) { const ReferenceCell ref_cell = ReferenceCells::Tetrahedron; @@ -79,7 +79,7 @@ create_triangulation(const std::vector> &vertices_, tria.create_triangulation(vertices, cell_data, SubCellData()); ++permutation_n; } - while ((permutation_n < n_permuations) && + while ((permutation_n < n_permutations) && std::next_permutation(cell_data.back().vertices.begin(), cell_data.back().vertices.end())); diff --git a/tests/tensors/constexpr_tensor.cc b/tests/tensors/constexpr_tensor.cc index 457f6a7b66..9c27c74408 100644 --- a/tests/tensors/constexpr_tensor.cc +++ b/tests/tensors/constexpr_tensor.cc @@ -182,7 +182,7 @@ main() constexpr Tensor<1, 3> dummy_1; constexpr Tensor<0, 3> dummy_0; DEAL_II_CONSTEXPR auto product_result = dummy_1 * dummy_1; - DEAL_II_CONSTEXPR auto constraction_result = + DEAL_II_CONSTEXPR auto contraction_result = contract<0, 0>(dummy_1, dummy_1); DEAL_II_CONSTEXPR auto outer_product_result = outer_product(dummy_0, dummy_0); diff --git a/tests/tensors/symmetric_tensor_trivial_copy.cc b/tests/tensors/symmetric_tensor_trivial_copy.cc index 010e2f5bba..b76b294844 100644 --- a/tests/tensors/symmetric_tensor_trivial_copy.cc +++ b/tests/tensors/symmetric_tensor_trivial_copy.cc @@ -16,7 +16,7 @@ // Verify that SymmetricTensor is trivially copyable. // TODO not all compilers that support enough of a subset of C++11 to compile -// the library (notably GCC 4.8) implement std::is_trivally_copyable. At some +// the library (notably GCC 4.8) implement std::is_trivially_copyable. At some // point in the future we should use that instead of the boost equivalent. #include diff --git a/tests/tensors/tensor_trivial_copy.cc b/tests/tensors/tensor_trivial_copy.cc index 938737e040..147ff4616e 100644 --- a/tests/tensors/tensor_trivial_copy.cc +++ b/tests/tensors/tensor_trivial_copy.cc @@ -16,7 +16,7 @@ // Verify that Tensor is trivially copyable. // TODO not all compilers that support enough of a subset of C++11 to compile -// the library (notably GCC 4.8) implement std::is_trivally_copyable. At some +// the library (notably GCC 4.8) implement std::is_trivially_copyable. At some // point in the future we should use that instead of the boost equivalent. #include -- 2.39.5