From d670c56cd60127369aee2bdf753df64b98ce7c78 Mon Sep 17 00:00:00 2001 From: luz paz Date: Tue, 2 Aug 2022 00:22:26 -0400 Subject: [PATCH] Fix typos in tests/ subdirectory --- tests/base/discrete_time_1.cc | 2 +- tests/base/functions_10_move.cc | 2 +- tests/base/functions_11_move.cc | 2 +- tests/base/hdf5_05.cc | 8 ++++---- tests/base/hdf5_06.cc | 8 ++++---- tests/cgal/cgal_point_01.cc | 2 +- tests/cgal/cgal_surface_mesh_04.cc | 2 +- tests/cgal/cgal_surface_mesh_07.cc | 4 ++-- tests/fe/fe_conformity_test.h | 2 +- tests/fe/fe_enriched_color_07.cc | 4 ++-- tests/fe/nedelec_projection_01.cc | 6 +++--- tests/fe/rt_bubbles_16.cc | 2 +- tests/grid/get_cells_at_coarsest_common_level_02.cc | 2 +- tests/grid/intergrid_constraints.cc | 2 +- tests/hp/laplace.h | 2 +- tests/lac/block_linear_operator_01.cc | 2 +- tests/lac/block_linear_operator_02.cc | 2 +- tests/lac/qr_10.cc | 4 ++-- tests/lac/solver_fire_rosenbrock_01.cc | 2 +- tests/manifold/elliptical_manifold_01.cc | 2 +- tests/manifold/transfinite_manifold_11.cc | 2 +- tests/matrix_free/compute_diagonal_07.cc | 2 +- tests/mpi/data_out_faces_02.cc | 2 +- tests/mpi/hp_hanging_node_constraints_01.cc | 2 +- tests/mpi/no_flux_constraints_03.cc | 2 +- tests/mpi/p4est_2d_find_point_owner_rank_01.cc | 2 +- tests/mpi/p4est_2d_find_point_owner_rank_02.cc | 2 +- tests/mpi/p4est_3d_find_point_owner_rank_01.cc | 2 +- tests/mpi/p4est_3d_find_point_owner_rank_02.cc | 2 +- tests/non_matching/face_quadrature_generator.cc | 2 +- tests/numerics/project_bv_div_conf_02.cc | 2 +- tests/numerics/project_bv_div_conf_03.cc | 2 +- tests/optimization/line_minimization_02.cc | 2 +- tests/particles/particle_handler_21.cc | 2 +- tests/quick_tests/boost_zlib.cc | 2 +- .../vector_tools_evaluate_at_points_05.cc | 2 +- tests/simplex/data_out_write_hdf5_01.cc | 2 +- ...ta_out_write_hdf5_01.mpirun=1.with_hdf5=on.output | 12 ++++++------ tests/simplex/data_out_write_hdf5_02.cc | 2 +- ...df5_02.mpirun=4.with_hdf5=on.with_metis=on.output | 12 ++++++------ tests/simplex/hanging_nodes.h | 2 +- tests/simplex/refinement_03.cc | 2 +- .../dynamic_sparsity_pattern_compute_Tmmult_1.cc | 2 +- .../dynamic_sparsity_pattern_compute_Tmmult_2.cc | 2 +- tests/sundials/n_vector.cc | 2 +- tests/symengine/basic_06.cc | 2 +- tests/symengine/sd_common_tests/batch_optimizer_04.h | 2 +- tests/symengine/sd_common_tests/batch_optimizer_06.h | 2 +- tests/symengine/symengine_number_type_01.cc | 6 +++--- tests/tests.h | 2 +- 50 files changed, 73 insertions(+), 73 deletions(-) diff --git a/tests/base/discrete_time_1.cc b/tests/base/discrete_time_1.cc index b37ee917d4..f23e1df2d7 100644 --- a/tests/base/discrete_time_1.cc +++ b/tests/base/discrete_time_1.cc @@ -79,7 +79,7 @@ test_adjust_time_step_size() print_time(time); time.advance_time(); // Here we reach the end time. print_time(time); - // If we call time.advance_time() one more time, it fails an assersion + // If we call time.advance_time() one more time, it fails an assertion deallog << "OK" << std::endl; } diff --git a/tests/base/functions_10_move.cc b/tests/base/functions_10_move.cc index 2294cfb4e2..75e8471981 100644 --- a/tests/base/functions_10_move.cc +++ b/tests/base/functions_10_move.cc @@ -79,7 +79,7 @@ check() Functions::InterpolatedTensorProductGridData f(std::move(coordinates), std::move(data)); - // Verify tha the data has really been moved + // Verify that the data has really been moved for (unsigned int d = 0; d < dim; ++d) Assert(data.size()[d] == 0, ExcInternalError()); for (unsigned int d = 0; d < dim; ++d) diff --git a/tests/base/functions_11_move.cc b/tests/base/functions_11_move.cc index 44f25056d7..7afa0a64b7 100644 --- a/tests/base/functions_11_move.cc +++ b/tests/base/functions_11_move.cc @@ -92,7 +92,7 @@ check() std::move(n_subintervals), std::move(data)); - // Verify tha the data has really been moved + // Verify that the data has really been moved for (unsigned int d = 0; d < dim; ++d) Assert(data.size()[d] == 0, ExcInternalError()); diff --git a/tests/base/hdf5_05.cc b/tests/base/hdf5_05.cc index abfc9d635f..a93f182549 100644 --- a/tests/base/hdf5_05.cc +++ b/tests/base/hdf5_05.cc @@ -556,7 +556,7 @@ write_test(HDF5::Group & root_group, 0, // fourth point 0, 0, - 3}; // fith point + 3}; // fifth point std::vector data = {32, 33, 35, 36, 38}; dataset.write_selection(data, coordinates); @@ -776,7 +776,7 @@ write_test(HDF5::Group & root_group, 0, // fourth point 0, 0, - 3}; // fith point + 3}; // fifth point Vector data(5); data[0] = 32; data[1] = 33; @@ -1087,7 +1087,7 @@ read_test(HDF5::Group root_group, 1, // fourth point 0, 3, - 2}; // fith point + 2}; // fifth point auto data = dataset.read_selection>(coordinates); @@ -1121,7 +1121,7 @@ read_test(HDF5::Group root_group, 1, // fourth point 0, 3, - 2}; // fith point + 2}; // fifth point auto data = dataset.read_selection>(coordinates); diff --git a/tests/base/hdf5_06.cc b/tests/base/hdf5_06.cc index e2c16ba5c6..82483785fe 100644 --- a/tests/base/hdf5_06.cc +++ b/tests/base/hdf5_06.cc @@ -523,7 +523,7 @@ write_test(HDF5::Group &root_group) 0, // fourth point 0, 0, - 3}; // fith point + 3}; // fifth point std::vector data = {32, 33, 35, 36, 38}; dataset.write_selection(data, coordinates); @@ -720,7 +720,7 @@ write_test(HDF5::Group &root_group) 0, // fourth point 0, 0, - 3}; // fith point + 3}; // fifth point Vector data(5); data[0] = 32; data[1] = 33; @@ -1037,7 +1037,7 @@ read_test(HDF5::Group root_group) 1, // fourth point 0, 3, - 2}; // fith point + 2}; // fifth point auto data = dataset.read_selection>(coordinates); @@ -1073,7 +1073,7 @@ read_test(HDF5::Group root_group) 1, // fourth point 0, 3, - 2}; // fith point + 2}; // fifth point auto data = dataset.read_selection>(coordinates); diff --git a/tests/cgal/cgal_point_01.cc b/tests/cgal/cgal_point_01.cc index 81e2ac516c..751b6114b9 100644 --- a/tests/cgal/cgal_point_01.cc +++ b/tests/cgal/cgal_point_01.cc @@ -13,7 +13,7 @@ // // --------------------------------------------------------------------- -// Test conversion from CGAL to deal.II Point and viceversa +// Test conversion from CGAL to deal.II Point and vice-versa #include diff --git a/tests/cgal/cgal_surface_mesh_04.cc b/tests/cgal/cgal_surface_mesh_04.cc index d603012725..36636b6da4 100644 --- a/tests/cgal/cgal_surface_mesh_04.cc +++ b/tests/cgal/cgal_surface_mesh_04.cc @@ -14,7 +14,7 @@ // --------------------------------------------------------------------- // Convert a deal.II triangulation to a CGAL surface mesh. In the 2D case, -// thw whole triangulation is a 2D surface mesh. In 3D, the surface mesh +// the whole triangulation is a 2D surface mesh. In 3D, the surface mesh // describes the boundary of the deal.II Triangulation. #include diff --git a/tests/cgal/cgal_surface_mesh_07.cc b/tests/cgal/cgal_surface_mesh_07.cc index 892d34bf12..c56aa86615 100644 --- a/tests/cgal/cgal_surface_mesh_07.cc +++ b/tests/cgal/cgal_surface_mesh_07.cc @@ -15,8 +15,8 @@ // Create a Surface_mesh from each cell of an hyper ball, to check for // orientation issues that may arise in Hexaedrons with non-standard face -// orientations. Make sure this works also when tranforming the grid to a -// simplex one. +// orientations. Make sure this works also when transforming the grid to +// a simplex one. #include diff --git a/tests/fe/fe_conformity_test.h b/tests/fe/fe_conformity_test.h index 8ca10995a2..f022f20b42 100644 --- a/tests/fe/fe_conformity_test.h +++ b/tests/fe/fe_conformity_test.h @@ -206,7 +206,7 @@ namespace FEConforimityTest { triangulation.clear(); - // alias for better readabilty + // alias for better readability const unsigned int n_rotate_central_square = config_switch; GridGenerator::non_standard_orientation_mesh(triangulation, diff --git a/tests/fe/fe_enriched_color_07.cc b/tests/fe/fe_enriched_color_07.cc index 67ddae103d..d021e7c87d 100644 --- a/tests/fe/fe_enriched_color_07.cc +++ b/tests/fe/fe_enriched_color_07.cc @@ -592,7 +592,7 @@ ParameterCollection::print() /* * EstimateEnrichmentFunction is used to estimate enrichment function by - * solveing a 1D poisson problem with right hand side and boundary + * solving a 1D poisson problem with right hand side and boundary * expression provided as a string of single variable 'x', to be * interpreted as distance from @par center. * @@ -1818,7 +1818,7 @@ LaplaceProblem::run() if (prm.debug_level >= 2 && this_mpi_process == 0) output_results(cycle); - // Donot refine if loop is at the end + // Do not refine if loop is at the end if (cycle != prm.cycles) refine_grid(); diff --git a/tests/fe/nedelec_projection_01.cc b/tests/fe/nedelec_projection_01.cc index 802d3525e0..0ef1ae3fc8 100644 --- a/tests/fe/nedelec_projection_01.cc +++ b/tests/fe/nedelec_projection_01.cc @@ -92,7 +92,7 @@ test() VectorTools::project_boundary_values_curl_conforming_l2( dof_handler, - 0, // starting compenent + 0, // starting component BoundaryValues(), 1, // face ID1 constraints, @@ -126,14 +126,14 @@ test() VectorTools::project_boundary_values_curl_conforming_l2( dof_handler, - 0, // starting compenent + 0, // starting component BoundaryValues(), 1, // face ID1 constraints, StaticMappingQ1::mapping); VectorTools::project_boundary_values_curl_conforming_l2( dof_handler, - dim, // starting compenent + dim, // starting component BoundaryValues(), 1, // face ID1 constraints, diff --git a/tests/fe/rt_bubbles_16.cc b/tests/fe/rt_bubbles_16.cc index debc03d3dc..60c2a59df9 100644 --- a/tests/fe/rt_bubbles_16.cc +++ b/tests/fe/rt_bubbles_16.cc @@ -16,7 +16,7 @@ // The test is used to check the restriction_is_additive flags. The // face degrees of freedom of an RT_Bubbles element must be non-additive -// as they have continuity requrements. The interior DoFs however must +// as they have continuity requirements. The interior DoFs however must // be additive. #include diff --git a/tests/grid/get_cells_at_coarsest_common_level_02.cc b/tests/grid/get_cells_at_coarsest_common_level_02.cc index 882fc638d3..2d82b855bc 100644 --- a/tests/grid/get_cells_at_coarsest_common_level_02.cc +++ b/tests/grid/get_cells_at_coarsest_common_level_02.cc @@ -56,7 +56,7 @@ test() GridTools::get_cells_at_coarsest_common_level>( patch_cells); - // in uniform refinemenet(without any hanging nodes), we expect the size + // in uniform refinement(without any hanging nodes), we expect the size // of vector of patch_cells for each cell be equal to the vector of // coarse_cells around that cell Assert(patch_cells.size() == coarse_cells.size(), ExcInternalError()); diff --git a/tests/grid/intergrid_constraints.cc b/tests/grid/intergrid_constraints.cc index d0a27e48ee..86bd0caa9f 100644 --- a/tests/grid/intergrid_constraints.cc +++ b/tests/grid/intergrid_constraints.cc @@ -166,7 +166,7 @@ check() cell->set_refine_flag(); // make sure that the - // corrsponding cell + // corresponding cell // on grid 2 is also // refined if that // has not yet diff --git a/tests/hp/laplace.h b/tests/hp/laplace.h index 4b27b71492..97d9d2b438 100644 --- a/tests/hp/laplace.h +++ b/tests/hp/laplace.h @@ -188,7 +188,7 @@ protected: -// implementatoin +// implementation template Laplace::Laplace(const Function &force_function, const Function &exact_solution, diff --git a/tests/lac/block_linear_operator_01.cc b/tests/lac/block_linear_operator_01.cc index e69fe2f4ce..46fd1f3eaa 100644 --- a/tests/lac/block_linear_operator_01.cc +++ b/tests/lac/block_linear_operator_01.cc @@ -169,7 +169,7 @@ main() PRINTME("Tvmult_add", x); - // Test vector reinitalization: + // Test vector reinitialization: op_x = op_b * op_b * op_b; op_x.vmult(x, u); diff --git a/tests/lac/block_linear_operator_02.cc b/tests/lac/block_linear_operator_02.cc index 81552ac3cb..827c01e180 100644 --- a/tests/lac/block_linear_operator_02.cc +++ b/tests/lac/block_linear_operator_02.cc @@ -140,7 +140,7 @@ main() PRINTME("(A-B).Tvmult_add", x); - // Test vector reinitalization: + // Test vector reinitialization: op_x = op_b * op_b * op_b; op_x.vmult(x, u); diff --git a/tests/lac/qr_10.cc b/tests/lac/qr_10.cc index 8f98b0d505..871adbba58 100644 --- a/tests/lac/qr_10.cc +++ b/tests/lac/qr_10.cc @@ -18,13 +18,13 @@ #include "../tests.h" /* - * Test ImplicitQR::append_column() with lineary dependent columns. + * Test ImplicitQR::append_column() with linearly dependent columns. * The output should be the same as qr_03 test plus extra output due to * the rejected column. */ /* - * MWE in Python for standard QR with 3 linearly independet columns. We will add + * MWE in Python for standard QR with 3 linearly independent columns. We will add the fourth one: import numpy as np diff --git a/tests/lac/solver_fire_rosenbrock_01.cc b/tests/lac/solver_fire_rosenbrock_01.cc index 7ed8facde3..61d01287c9 100644 --- a/tests/lac/solver_fire_rosenbrock_01.cc +++ b/tests/lac/solver_fire_rosenbrock_01.cc @@ -24,7 +24,7 @@ -// Test to verify correctness of SolverFIRE::sovle() +// Test to verify correctness of SolverFIRE::solve() // The objective function is the extended Rosenbrock function. // The Rosenbrock function is a non-convex function used as a test problem // for optimization algorithms introduced by Howard H. Rosenbrock. diff --git a/tests/manifold/elliptical_manifold_01.cc b/tests/manifold/elliptical_manifold_01.cc index 4036bf3c3c..9f534d9497 100644 --- a/tests/manifold/elliptical_manifold_01.cc +++ b/tests/manifold/elliptical_manifold_01.cc @@ -76,7 +76,7 @@ namespace - // Generate an hyper_shell over an EllipticalManifold having an abitrary + // Generate an hyper_shell over an EllipticalManifold having an arbitrary // center, and the major axis oriented in the direction of the x-axis. // // inner_radius and outer_radius parameters correspond to the diff --git a/tests/manifold/transfinite_manifold_11.cc b/tests/manifold/transfinite_manifold_11.cc index 690a40e243..fb21a88aba 100644 --- a/tests/manifold/transfinite_manifold_11.cc +++ b/tests/manifold/transfinite_manifold_11.cc @@ -138,7 +138,7 @@ main() * -0.1271 -0.0177875 -> 0.253794 -0.0323121 * -0.1271 -0.015564 -> 0.251301 -0.0309146 * - * The following is a simplified version that fails with a sligthly + * The following is a simplified version that fails with a slightly * different error message. */ diff --git a/tests/matrix_free/compute_diagonal_07.cc b/tests/matrix_free/compute_diagonal_07.cc index f6c7c19070..64397d9a3f 100644 --- a/tests/matrix_free/compute_diagonal_07.cc +++ b/tests/matrix_free/compute_diagonal_07.cc @@ -15,7 +15,7 @@ -// Similar to compute_diagonal_02 but testing block vectorss. +// Similar to compute_diagonal_02 but testing block vectors. #include diff --git a/tests/mpi/data_out_faces_02.cc b/tests/mpi/data_out_faces_02.cc index 4bf0518cdc..1bdb5590a5 100644 --- a/tests/mpi/data_out_faces_02.cc +++ b/tests/mpi/data_out_faces_02.cc @@ -21,7 +21,7 @@ // experiencing was the mesh I was testing on was too coarse for // larger number of processors. This test case shows that as // well. For 4 processors the code produces output without error -// for both the 12 repitions and the 2 repititions. For 6 and 12 +// for both the 12 repitions and the 2 repetitions. For 6 and 12 // processors only the 12 repetition case produces the proper // output. Fortunately it does show as long as the mesh is // adequately refined DataOutFaces produces the output for each diff --git a/tests/mpi/hp_hanging_node_constraints_01.cc b/tests/mpi/hp_hanging_node_constraints_01.cc index 6af4563110..88e069a05e 100644 --- a/tests/mpi/hp_hanging_node_constraints_01.cc +++ b/tests/mpi/hp_hanging_node_constraints_01.cc @@ -66,7 +66,7 @@ test() cell->set_refine_flag(); tria.execute_coarsening_and_refinement(); - // setup finite elemets + // setup finite elements hp::FECollection fes; fes.push_back(FE_Q(1)); diff --git a/tests/mpi/no_flux_constraints_03.cc b/tests/mpi/no_flux_constraints_03.cc index 25b71d6427..1868f1a3bb 100644 --- a/tests/mpi/no_flux_constraints_03.cc +++ b/tests/mpi/no_flux_constraints_03.cc @@ -17,7 +17,7 @@ // check that the AffineConstraints with hanging nodes and // no-normal-flux constraints on an adaptively refined hyper_cube are the same -// independet of the number of CPUs +// independent of the number of CPUs #include diff --git a/tests/mpi/p4est_2d_find_point_owner_rank_01.cc b/tests/mpi/p4est_2d_find_point_owner_rank_01.cc index 4da881e38d..e2e17946d5 100644 --- a/tests/mpi/p4est_2d_find_point_owner_rank_01.cc +++ b/tests/mpi/p4est_2d_find_point_owner_rank_01.cc @@ -30,7 +30,7 @@ main(int argc, char *argv[]) /* - * We craete a distrubuted mesh with three cells (tree roots), e.g., a + * We create a distributed mesh with three cells (tree roots), e.g., a * hyper_L. We want to find the mpi rank of a single fixed point. On all * processes we must find the same owner. */ diff --git a/tests/mpi/p4est_2d_find_point_owner_rank_02.cc b/tests/mpi/p4est_2d_find_point_owner_rank_02.cc index 19b82ee2af..e2f8f5b2f3 100644 --- a/tests/mpi/p4est_2d_find_point_owner_rank_02.cc +++ b/tests/mpi/p4est_2d_find_point_owner_rank_02.cc @@ -31,7 +31,7 @@ main(int argc, char *argv[]) /* - * We craete a distrubuted mesh with three cells (tree roots), e.g., a + * We create a distributed mesh with three cells (tree roots), e.g., a * hyper_L. We want to find the mpi rank of a set of fixed points. On all * processes we must find the same owner ranks. */ diff --git a/tests/mpi/p4est_3d_find_point_owner_rank_01.cc b/tests/mpi/p4est_3d_find_point_owner_rank_01.cc index 1387b1836c..23344c21ef 100644 --- a/tests/mpi/p4est_3d_find_point_owner_rank_01.cc +++ b/tests/mpi/p4est_3d_find_point_owner_rank_01.cc @@ -30,7 +30,7 @@ main(int argc, char *argv[]) /* - * We craete a distrubuted mesh with three cells (tree roots), e.g., a + * We create a distributed mesh with three cells (tree roots), e.g., a * hyper_L. We want to find the mpi rank of a single fixed point. On all * processes we must find the same owner. */ diff --git a/tests/mpi/p4est_3d_find_point_owner_rank_02.cc b/tests/mpi/p4est_3d_find_point_owner_rank_02.cc index b5cb75d0b3..e7d1e9aba3 100644 --- a/tests/mpi/p4est_3d_find_point_owner_rank_02.cc +++ b/tests/mpi/p4est_3d_find_point_owner_rank_02.cc @@ -31,7 +31,7 @@ main(int argc, char *argv[]) /* - * We craete a distrubuted mesh with three cells (tree roots), e.g., a + * We create a distributed mesh with three cells (tree roots), e.g., a * hyper_L. We want to find the mpi rank of a set of fixed points. On all * processes we must find the same owner ranks. */ diff --git a/tests/non_matching/face_quadrature_generator.cc b/tests/non_matching/face_quadrature_generator.cc index 148222c2f2..c5eaf604ec 100644 --- a/tests/non_matching/face_quadrature_generator.cc +++ b/tests/non_matching/face_quadrature_generator.cc @@ -81,7 +81,7 @@ test_plane_cuts_through_center() for (int d = 0; d < dim; ++d) center(d) = .5; - // For each coordinate direction set up a plane throught the center. + // For each coordinate direction set up a plane through the center. for (int plane_direction = 0; plane_direction < dim; ++plane_direction) { const Tensor<1, dim> normal = Point::unit_vector(plane_direction); diff --git a/tests/numerics/project_bv_div_conf_02.cc b/tests/numerics/project_bv_div_conf_02.cc index 37ef91e0da..c9048247d4 100644 --- a/tests/numerics/project_bv_div_conf_02.cc +++ b/tests/numerics/project_bv_div_conf_02.cc @@ -14,7 +14,7 @@ // --------------------------------------------------------------------- // Test VectorTools::project_boundary_values_div_conforming for the -// case that the DoFHandler constains is more than one FE_RaviartThomas element. +// case that the DoFHandler contains is more than one FE_RaviartThomas element. #include diff --git a/tests/numerics/project_bv_div_conf_03.cc b/tests/numerics/project_bv_div_conf_03.cc index 583cff2506..441697eb8b 100644 --- a/tests/numerics/project_bv_div_conf_03.cc +++ b/tests/numerics/project_bv_div_conf_03.cc @@ -14,7 +14,7 @@ // --------------------------------------------------------------------- // Test VectorTools::project_boundary_values_div_conforming convergence rates -// for the case that the DoFHandler constains more than one +// for the case that the DoFHandler contains more than one // FE_RaviartThomas element. #include diff --git a/tests/optimization/line_minimization_02.cc b/tests/optimization/line_minimization_02.cc index 66da8e0fed..e7872fe300 100644 --- a/tests/optimization/line_minimization_02.cc +++ b/tests/optimization/line_minimization_02.cc @@ -99,7 +99,7 @@ test() { deallog << "Case 3:" << std::endl; // Now do a big step so that next one in bracketing satisfies both Wolf: - // at the termination point the derivative is alos negative! + // at the termination point the derivative is also negative! // Also that point satisfies both Wolfe conditions as well, but // we are interested in another segment, which contains local // minimizer diff --git a/tests/particles/particle_handler_21.cc b/tests/particles/particle_handler_21.cc index 7d358eb979..fcc95206c4 100644 --- a/tests/particles/particle_handler_21.cc +++ b/tests/particles/particle_handler_21.cc @@ -118,7 +118,7 @@ void ParticleTracking::generate_particles() { // We create an hyper ball triangulation which we globally refine. The bug - // that this test tries to reproduce only occured in curevd geometry. + // that this test tries to reproduce only occurred in curved geometry. Point center_of_triangulation; center_of_triangulation[0] = 0.; center_of_triangulation[1] = 0.; diff --git a/tests/quick_tests/boost_zlib.cc b/tests/quick_tests/boost_zlib.cc index 724b3441f6..b65dd6d651 100644 --- a/tests/quick_tests/boost_zlib.cc +++ b/tests/quick_tests/boost_zlib.cc @@ -13,7 +13,7 @@ // // --------------------------------------------------------------------- -// Adoptation of base/utilities_pack_unpack_01.cc as a quick test. +// Adaptation of base/utilities_pack_unpack_01.cc as a quick test. // test Utilities::pack/unpack on some types. diff --git a/tests/remote_point_evaluation/vector_tools_evaluate_at_points_05.cc b/tests/remote_point_evaluation/vector_tools_evaluate_at_points_05.cc index 1423b2027d..06add57346 100644 --- a/tests/remote_point_evaluation/vector_tools_evaluate_at_points_05.cc +++ b/tests/remote_point_evaluation/vector_tools_evaluate_at_points_05.cc @@ -129,7 +129,7 @@ test() const unsigned int n_refinements_1 = 2; const unsigned int n_refinements_2 = 3; - // backgroud mesh + // background mesh parallel::distributed::Triangulation tria_1(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria_1, -1.0, +1.0); tria_1.refine_global(n_refinements_1); diff --git a/tests/simplex/data_out_write_hdf5_01.cc b/tests/simplex/data_out_write_hdf5_01.cc index 50e6a346af..3535d2ae50 100644 --- a/tests/simplex/data_out_write_hdf5_01.cc +++ b/tests/simplex/data_out_write_hdf5_01.cc @@ -114,7 +114,7 @@ test(const FiniteElement &fe, const unsigned int n_components) deallog << "Files " << output_basename + ".h5" << " and " << output_basename + ".xdmf" - << " created succesfully!" << std::endl; + << " created successfully!" << std::endl; } int diff --git a/tests/simplex/data_out_write_hdf5_01.mpirun=1.with_hdf5=on.output b/tests/simplex/data_out_write_hdf5_01.mpirun=1.with_hdf5=on.output index a967ed464e..7fb907f90d 100644 --- a/tests/simplex/data_out_write_hdf5_01.mpirun=1.with_hdf5=on.output +++ b/tests/simplex/data_out_write_hdf5_01.mpirun=1.with_hdf5=on.output @@ -1,7 +1,7 @@ -DEAL::Files test.2.0.h5 and test.2.0.xdmf created succesfully! -DEAL::Files test.2.1.h5 and test.2.1.xdmf created succesfully! -DEAL::Files test.2.2.h5 and test.2.2.xdmf created succesfully! -DEAL::Files test.3.0.h5 and test.3.0.xdmf created succesfully! -DEAL::Files test.3.1.h5 and test.3.1.xdmf created succesfully! -DEAL::Files test.3.2.h5 and test.3.2.xdmf created succesfully! \ No newline at end of file +DEAL::Files test.2.0.h5 and test.2.0.xdmf created successfully! +DEAL::Files test.2.1.h5 and test.2.1.xdmf created successfully! +DEAL::Files test.2.2.h5 and test.2.2.xdmf created successfully! +DEAL::Files test.3.0.h5 and test.3.0.xdmf created successfully! +DEAL::Files test.3.1.h5 and test.3.1.xdmf created successfully! +DEAL::Files test.3.2.h5 and test.3.2.xdmf created successfully! \ No newline at end of file diff --git a/tests/simplex/data_out_write_hdf5_02.cc b/tests/simplex/data_out_write_hdf5_02.cc index 1aa2ece445..8bcc16475f 100644 --- a/tests/simplex/data_out_write_hdf5_02.cc +++ b/tests/simplex/data_out_write_hdf5_02.cc @@ -137,7 +137,7 @@ test(const FiniteElement &fe, const unsigned int n_components) deallog << "Files " << output_basename + ".h5" << " and " << output_basename + ".xdmf" - << " created succesfully!" << std::endl; + << " created successfully!" << std::endl; } } diff --git a/tests/simplex/data_out_write_hdf5_02.mpirun=4.with_hdf5=on.with_metis=on.output b/tests/simplex/data_out_write_hdf5_02.mpirun=4.with_hdf5=on.with_metis=on.output index a967ed464e..7fb907f90d 100644 --- a/tests/simplex/data_out_write_hdf5_02.mpirun=4.with_hdf5=on.with_metis=on.output +++ b/tests/simplex/data_out_write_hdf5_02.mpirun=4.with_hdf5=on.with_metis=on.output @@ -1,7 +1,7 @@ -DEAL::Files test.2.0.h5 and test.2.0.xdmf created succesfully! -DEAL::Files test.2.1.h5 and test.2.1.xdmf created succesfully! -DEAL::Files test.2.2.h5 and test.2.2.xdmf created succesfully! -DEAL::Files test.3.0.h5 and test.3.0.xdmf created succesfully! -DEAL::Files test.3.1.h5 and test.3.1.xdmf created succesfully! -DEAL::Files test.3.2.h5 and test.3.2.xdmf created succesfully! \ No newline at end of file +DEAL::Files test.2.0.h5 and test.2.0.xdmf created successfully! +DEAL::Files test.2.1.h5 and test.2.1.xdmf created successfully! +DEAL::Files test.2.2.h5 and test.2.2.xdmf created successfully! +DEAL::Files test.3.0.h5 and test.3.0.xdmf created successfully! +DEAL::Files test.3.1.h5 and test.3.1.xdmf created successfully! +DEAL::Files test.3.2.h5 and test.3.2.xdmf created successfully! \ No newline at end of file diff --git a/tests/simplex/hanging_nodes.h b/tests/simplex/hanging_nodes.h index 309ac2eb90..252094ab24 100644 --- a/tests/simplex/hanging_nodes.h +++ b/tests/simplex/hanging_nodes.h @@ -15,7 +15,7 @@ -// miscellaneous helper funcions for hanging_nodes_* tests +// miscellaneous helper functions for hanging_nodes_* tests #include diff --git a/tests/simplex/refinement_03.cc b/tests/simplex/refinement_03.cc index b72cd17947..94fcf2649f 100644 --- a/tests/simplex/refinement_03.cc +++ b/tests/simplex/refinement_03.cc @@ -53,7 +53,7 @@ test() unrefined_f = f; // verify whether unrefined cell and neighboring children have matching - // vertices on their correpsonding subface + // vertices on their corresponding subface for (unsigned int sf = 0; sf < GeometryInfo::max_children_per_face; ++sf) { // unrefined vertex on subface diff --git a/tests/sparsity/dynamic_sparsity_pattern_compute_Tmmult_1.cc b/tests/sparsity/dynamic_sparsity_pattern_compute_Tmmult_1.cc index a4735c09e2..3fda326e48 100644 --- a/tests/sparsity/dynamic_sparsity_pattern_compute_Tmmult_1.cc +++ b/tests/sparsity/dynamic_sparsity_pattern_compute_Tmmult_1.cc @@ -18,7 +18,7 @@ // check DynamicSparsityPattern::compute_Tmmult_pattern(). Test if // multiplication with each combination of SparsityPatternTypes is possible. -// This is an adoptation of the dynamic_sparsity_pattern_compute_mmult_1.cc +// This is an adaptation of the dynamic_sparsity_pattern_compute_mmult_1.cc #include #include diff --git a/tests/sparsity/dynamic_sparsity_pattern_compute_Tmmult_2.cc b/tests/sparsity/dynamic_sparsity_pattern_compute_Tmmult_2.cc index 9fbc04c33c..2139eae066 100644 --- a/tests/sparsity/dynamic_sparsity_pattern_compute_Tmmult_2.cc +++ b/tests/sparsity/dynamic_sparsity_pattern_compute_Tmmult_2.cc @@ -18,7 +18,7 @@ // check DynamicSparsityPattern::compute_Tmmult_pattern(). Test if // multiplication of two patterns yield the right DynamicSparsityPattern. This -// is an adoptation of the dynamic_sparsity_pattern_compute_mmult_2.cc +// is an adaptation of the dynamic_sparsity_pattern_compute_mmult_2.cc #include #include diff --git a/tests/sundials/n_vector.cc b/tests/sundials/n_vector.cc index 8e9fa96a08..a23fbcba81 100644 --- a/tests/sundials/n_vector.cc +++ b/tests/sundials/n_vector.cc @@ -69,7 +69,7 @@ namespace } /** - * Create a vector for testing and intialize all entries to @p value. + * Create a vector for testing and initialize all entries to @p value. */ template VectorType diff --git a/tests/symengine/basic_06.cc b/tests/symengine/basic_06.cc index 5db199829b..20d85eb68e 100644 --- a/tests/symengine/basic_06.cc +++ b/tests/symengine/basic_06.cc @@ -48,7 +48,7 @@ main(int argc, char *argv[]) // 0. Define some independent variables // Here we have two definitions of Q: One it is treated as a completely - // indepdent variable, and the other where its dependence on C is + // independent variable, and the other where its dependence on C is // explicitly defined SE::RCP C = SE::symbol("C"); // Primary variable SE::RCP Qi = SE::symbol("Qi"); // Some internal variable diff --git a/tests/symengine/sd_common_tests/batch_optimizer_04.h b/tests/symengine/sd_common_tests/batch_optimizer_04.h index 2af4534ab6..34cba23c69 100644 --- a/tests/symengine/sd_common_tests/batch_optimizer_04.h +++ b/tests/symengine/sd_common_tests/batch_optimizer_04.h @@ -98,7 +98,7 @@ test_serialization() // Optimizer SD::BatchOptimizer optimizer; - // Deserialze + // Deserialize deallog << "Deserializing..." << std::endl; std::istringstream iss(oss.str()); boost::archive::text_iarchive ia(iss, boost::archive::no_header); diff --git a/tests/symengine/sd_common_tests/batch_optimizer_06.h b/tests/symengine/sd_common_tests/batch_optimizer_06.h index 4a6b9a63d2..c47c4ca53c 100644 --- a/tests/symengine/sd_common_tests/batch_optimizer_06.h +++ b/tests/symengine/sd_common_tests/batch_optimizer_06.h @@ -203,7 +203,7 @@ test_serialization(const int n_runs, TimerOutput &timer) // Optimizer SD::BatchOptimizer optimizer; - // Deserialze + // Deserialize std::cout << "Deserializing..." << std::endl; std::istringstream iss(oss.str()); boost::archive::text_iarchive ia(iss, boost::archive::no_header); diff --git a/tests/symengine/symengine_number_type_01.cc b/tests/symengine/symengine_number_type_01.cc index 3eab565f3a..61617aa104 100644 --- a/tests/symengine/symengine_number_type_01.cc +++ b/tests/symengine/symengine_number_type_01.cc @@ -686,7 +686,7 @@ main() f *= x; // f = x^2 const SD_number_t df_dx = f.differentiate(x); Assert(static_cast(df_dx == (2.0 * x)), - ExcMessage("Problem with differentiaton")); + ExcMessage("Problem with differentiation")); } std::cout << "Basic differentiation (Symbol)" << std::endl; @@ -698,7 +698,7 @@ main() f *= x; // f = x^2 const SD_number_t df_dx = f.differentiate(symb_x); Assert(static_cast(df_dx == SD_number_t(2.0 * x)), - ExcMessage("Problem with differentiaton")); + ExcMessage("Problem with differentiation")); } std::cout << "Basic differentiation (Basic representing a symbolic type)" @@ -716,7 +716,7 @@ main() // 2.0 * SD_number_t(symb_x_plus_y) = 2.0*(x + y) // Assert(static_cast(df_dxpy == (2.0 * // SD_number_t(symb_x_plus_y))), - // ExcMessage("Problem with differentiaton")); + // ExcMessage("Problem with differentiation")); } } diff --git a/tests/tests.h b/tests/tests.h index 96ec56c149..6778eeeced 100644 --- a/tests/tests.h +++ b/tests/tests.h @@ -421,7 +421,7 @@ filter_out_small_numbers(const Number number, const double tolerance) * If we run 64 tests at the same time on a 64-core system, and each of * them runs 64 threads, then we get astronomical loads. Limit concurrency * to a fixed (small) number of threads, independent of the core count. The - * limit defaults to 3 and can be overriden by the environment variable + * limit defaults to 3 and can be overridden by the environment variable * TEST_N_THREADS. */ inline unsigned int -- 2.39.5