]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix typos in tests/ subdirectory
authorluz paz <luzpaz@pm.me>
Tue, 2 Aug 2022 04:22:26 +0000 (00:22 -0400)
committerluz paz <luzpaz@pm.me>
Tue, 2 Aug 2022 13:25:33 +0000 (09:25 -0400)
50 files changed:
tests/base/discrete_time_1.cc
tests/base/functions_10_move.cc
tests/base/functions_11_move.cc
tests/base/hdf5_05.cc
tests/base/hdf5_06.cc
tests/cgal/cgal_point_01.cc
tests/cgal/cgal_surface_mesh_04.cc
tests/cgal/cgal_surface_mesh_07.cc
tests/fe/fe_conformity_test.h
tests/fe/fe_enriched_color_07.cc
tests/fe/nedelec_projection_01.cc
tests/fe/rt_bubbles_16.cc
tests/grid/get_cells_at_coarsest_common_level_02.cc
tests/grid/intergrid_constraints.cc
tests/hp/laplace.h
tests/lac/block_linear_operator_01.cc
tests/lac/block_linear_operator_02.cc
tests/lac/qr_10.cc
tests/lac/solver_fire_rosenbrock_01.cc
tests/manifold/elliptical_manifold_01.cc
tests/manifold/transfinite_manifold_11.cc
tests/matrix_free/compute_diagonal_07.cc
tests/mpi/data_out_faces_02.cc
tests/mpi/hp_hanging_node_constraints_01.cc
tests/mpi/no_flux_constraints_03.cc
tests/mpi/p4est_2d_find_point_owner_rank_01.cc
tests/mpi/p4est_2d_find_point_owner_rank_02.cc
tests/mpi/p4est_3d_find_point_owner_rank_01.cc
tests/mpi/p4est_3d_find_point_owner_rank_02.cc
tests/non_matching/face_quadrature_generator.cc
tests/numerics/project_bv_div_conf_02.cc
tests/numerics/project_bv_div_conf_03.cc
tests/optimization/line_minimization_02.cc
tests/particles/particle_handler_21.cc
tests/quick_tests/boost_zlib.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_05.cc
tests/simplex/data_out_write_hdf5_01.cc
tests/simplex/data_out_write_hdf5_01.mpirun=1.with_hdf5=on.output
tests/simplex/data_out_write_hdf5_02.cc
tests/simplex/data_out_write_hdf5_02.mpirun=4.with_hdf5=on.with_metis=on.output
tests/simplex/hanging_nodes.h
tests/simplex/refinement_03.cc
tests/sparsity/dynamic_sparsity_pattern_compute_Tmmult_1.cc
tests/sparsity/dynamic_sparsity_pattern_compute_Tmmult_2.cc
tests/sundials/n_vector.cc
tests/symengine/basic_06.cc
tests/symengine/sd_common_tests/batch_optimizer_04.h
tests/symengine/sd_common_tests/batch_optimizer_06.h
tests/symengine/symengine_number_type_01.cc
tests/tests.h

index b37ee917d49ec0d29d37fc117df160b80aea86d9..f23e1df2d78d47ef99a546d8dfcd56862f99bd7e 100644 (file)
@@ -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;
 }
 
index 2294cfb4e2227bacb22d66a7854f011cd3dd1da5..75e84719810a5d8ef3294fe8e94a8cc3789c0519 100644 (file)
@@ -79,7 +79,7 @@ check()
   Functions::InterpolatedTensorProductGridData<dim> 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)
index 44f25056d7834079d8e72af5157cc685f75a19c0..7afa0a64b73116b39ea7275f32b9d1033d638217 100644 (file)
@@ -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());
 
index abfc9d635f94e65ce384f6494f0998f8b2746c53..a93f18254901fa3274b6824e39a888cde2f29082 100644 (file)
@@ -556,7 +556,7 @@ write_test(HDF5::Group &      root_group,
                                             0, // fourth point
                                             0,
                                             0,
-                                            3}; // fith point
+                                            3}; // fifth point
         std::vector<Number>  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<Number>       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<std::vector<Number>>(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<Vector<Number>>(coordinates);
 
index e2c16ba5c6e5b3f92750fe74d7dbe8a9e5a4b2d0..82483785fe7d01967efd42f5bb6f759c5ef2adef 100644 (file)
@@ -523,7 +523,7 @@ write_test(HDF5::Group &root_group)
                                           0, // fourth point
                                           0,
                                           0,
-                                          3}; // fith point
+                                          3}; // fifth point
       std::vector<Number>  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<Number>       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<std::vector<Number>>(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<Vector<Number>>(coordinates);
 
index 81e2ac516c0b5a5951b401de4cb3415736963072..751b6114b901247f140f0a12003be866b0a75f94 100644 (file)
@@ -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 <deal.II/base/point.h>
 
index d603012725aec7cdb85d9c66951b37f203f7f8b8..36636b6da4805a3a75eac4483d001232c07b9fed 100644 (file)
@@ -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 <deal.II/base/config.h>
index 892d34bf12bc6c0dd8368e3438a867a193b3ed5a..c56aa86615bdc94a75714dc571a22026667998a0 100644 (file)
@@ -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
+// simplex one.
 
 #include <deal.II/base/config.h>
 
index 8ca10995a2032f69787a3fedceb69bf53ff29b81..f022f20b429bceb4f462206ec350969fa660bb79 100644 (file)
@@ -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,
index 67ddae103d8fb18d068c2ab200aa91e47393bc54..d021e7c87d195310148b74ea3f568d8259633e28 100644 (file)
@@ -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<dim>::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();
 
index 802d3525e0493a37787737d98a41c7dcd911a2a8..0ef1ae3fc8a73ce89f2196695e32a5682d4717f3 100644 (file)
@@ -92,7 +92,7 @@ test()
 
     VectorTools::project_boundary_values_curl_conforming_l2(
       dof_handler,
-      0, // starting compenent
+      0, // starting component
       BoundaryValues<dim>(),
       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<dim>(),
       1, // face ID1
       constraints,
       StaticMappingQ1<dim>::mapping);
     VectorTools::project_boundary_values_curl_conforming_l2(
       dof_handler,
-      dim, // starting compenent
+      dim, // starting component
       BoundaryValues<dim>(),
       1, // face ID1
       constraints,
index debc03d3dcf63099ff761ace7a538aa0715404ed..60c2a59df95e9ed70248a8acf68c891bb458c6d7 100644 (file)
@@ -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 <deal.II/fe/fe_rt_bubbles.h>
index 882fc638d3871923ce481be66471ef7cca8766a7..2d82b855bc246047403012a5b6adb559359ba2c3 100644 (file)
@@ -56,7 +56,7 @@ test()
         GridTools::get_cells_at_coarsest_common_level<Triangulation<dim>>(
           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());
index d0a27e48ee1ebb0e3b362b0e9f4cdbd7dcdd24c7..86bd0caa9f43b72b75536a6e52e45a00b50f9c9b 100644 (file)
@@ -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
index 4b27b7149233d73d4dd23ec363170e32d1bbc1a5..97d9d2b438fbcccf661212cf1e0494142d95928d 100644 (file)
@@ -188,7 +188,7 @@ protected:
 
 
 
-// implementatoin
+// implementation
 template <int dim>
 Laplace<dim>::Laplace(const Function<dim> &force_function,
                       const Function<dim> &exact_solution,
index e69fe2f4ce16fc22112fbd9bd5fe10c6b1d6accb..46fd1f3eaaf3bc780502e324f93a443af85dc3e4 100644 (file)
@@ -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);
index 81552ac3cb7a1907a4025802d2723ce3c7d7b405..827c01e1800dd706d0fe66cced027841adc94402 100644 (file)
@@ -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);
index 8f98b0d5050eabc6879b04c3adedfcf944bb8c4b..871adbba58f88af94a48425f94ecea6950dc2dcc 100644 (file)
 #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
index 7ed8facde37c3b89bdc4c0b47fbc9f6c4b7ba2c6..61d01287c95b989aa209c4fcecf55556b4e7172c 100644 (file)
@@ -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.
index 4036bf3c3c81fbb6e7cf6cca8f66c28e9a173d1c..9f534d94973e1f21109ae755e15f4555f80cdaf3 100644 (file)
@@ -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
index 690a40e243f8c46aec2d822bfc2c5ec2b81dfb8e..fb21a88aba62be8b642d8fd20ea5190a7aef2b09 100644 (file)
@@ -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.
    */
 
index f6c7c190706401e113e08afecb9cd14389cfd719..64397d9a3f86fdd31ff7edae1a53c841c059d825 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// Similar to compute_diagonal_02 but testing block vectorss.
+// Similar to compute_diagonal_02 but testing block vectors.
 
 #include <deal.II/lac/la_parallel_block_vector.h>
 
index 4bf0518cdcec03a9eb8a900e6a779dff4eb91dd8..1bdb5590a5f1cb95c206ee97cda859c0b9fd544f 100644 (file)
@@ -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
index 6af4563110c83026be1ab9c14c1fb3b2fae232a7..88e069a05e538958ebab34ffbbca390fd83bd68c 100644 (file)
@@ -66,7 +66,7 @@ test()
       cell->set_refine_flag();
   tria.execute_coarsening_and_refinement();
 
-  // setup finite elemets
+  // setup finite elements
   hp::FECollection<dim> fes;
   fes.push_back(FE_Q<dim>(1));
 
index 25b71d6427ba5e04dbc4036574954a7c0a3996aa..1868f1a3bb400ee82aef8eca558c6bd614cb19d8 100644 (file)
@@ -17,7 +17,7 @@
 
 // check that the AffineConstraints<double> 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 <deal.II/base/tensor.h>
 
index 4da881e38d9d866164d98103e7e968dcca4689e4..e2e17946d5617e50d01b93dcdbea064c7b7bf1fd 100644 (file)
@@ -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.
    */
index 19b82ee2af309f6b54d462b4cede0396ef7dcc92..e2f8f5b2f3abe61be514bbe4493d20cab9976a45 100644 (file)
@@ -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.
    */
index 1387b1836c8411a9f8655a99b2d6c6e3e6455d23..23344c21ef31f2e9f1cac497b919e377f378d7a4 100644 (file)
@@ -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.
    */
index b5cb75d0b344b891a2b8000d058fd45ed7b60a24..e7d1e9aba3720946ec183b92ec7c024c6548645d 100644 (file)
@@ -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.
    */
index 148222c2f20f2f3ac7d7387f78fdbdb491bacd2a..c5eaf604ec420a4b47b2b4d3a8973389e9479c34 100644 (file)
@@ -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<dim>::unit_vector(plane_direction);
index 37ef91e0da72ca43fa8134cbb9bcd2eac9fdad12..c9048247d449619718ae1e1f5c9f33d7b952e8d5 100644 (file)
@@ -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 <deal.II/base/function.h>
 
index 583cff2506ce0e11a8942603ad76ecf9f306e23a..441697eb8b9be02b390cb2df541d3fc362b337fb 100644 (file)
@@ -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 <deal.II/base/function.h>
index 66da8e0fedafe7f79872b4b61fb24aa2b31b85ca..e7872fe30097f78f68ffda1cb259c25241eaa8c3 100644 (file)
@@ -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
index 7d358eb979b0518473461e1067711295f740dacf..fcc95206c473fb0f9afee20dec68d8d1b7eb36f1 100644 (file)
@@ -118,7 +118,7 @@ void
 ParticleTracking<dim>::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<dim> center_of_triangulation;
   center_of_triangulation[0] = 0.;
   center_of_triangulation[1] = 0.;
index 724b3441f66c4ea60f087f1de2205072c4e84875..b65dd6d651a193c8a7cc30027378439448b11f7b 100644 (file)
@@ -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.
 
index 1423b2027d189811952c9ce7d58d80513d400883..06add5734619623c12595d5b7e447d100c470c5c 100644 (file)
@@ -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<dim> tria_1(MPI_COMM_WORLD);
   GridGenerator::hyper_cube(tria_1, -1.0, +1.0);
   tria_1.refine_global(n_refinements_1);
index 50e6a346affe8cb56f751453678a08f6458826e3..3535d2ae505f48f8efb3d5d3beb3718f9e7b91f7 100644 (file)
@@ -114,7 +114,7 @@ test(const FiniteElement<dim, spacedim> &fe, const unsigned int n_components)
 
   deallog << "Files " << output_basename + ".h5"
           << " and " << output_basename + ".xdmf"
-          << " created succesfully!" << std::endl;
+          << " created successfully!" << std::endl;
 }
 
 int
index a967ed464e4cdebe6151d9c138163b4fdc2cdfb8..7fb907f90dcfd22acafc69ef9934768b0418da97 100644 (file)
@@ -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
index 1aa2ece445823acb50a47f6e548e3cc8f1271384..8bcc16475fa132fbaa1c0ea91946398032b72989 100644 (file)
@@ -137,7 +137,7 @@ test(const FiniteElement<dim, spacedim> &fe, const unsigned int n_components)
 
       deallog << "Files " << output_basename + ".h5"
               << " and " << output_basename + ".xdmf"
-              << " created succesfully!" << std::endl;
+              << " created successfully!" << std::endl;
     }
 }
 
index a967ed464e4cdebe6151d9c138163b4fdc2cdfb8..7fb907f90dcfd22acafc69ef9934768b0418da97 100644 (file)
@@ -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
index 309ac2eb9088e14940d4c404e164a147bc69728e..252094ab24dc0a636439c08ce86f9a773c20b9af 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// miscellaneous helper funcions for hanging_nodes_* tests
+// miscellaneous helper functions for hanging_nodes_* tests
 
 
 #include <deal.II/dofs/dof_handler.h>
index b72cd179471765782d7edce8064fe3257b8b43da..94fcf2649f7c4c258be855ffc3d506212dcb8339 100644 (file)
@@ -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<dim>::max_children_per_face; ++sf)
     {
       // unrefined vertex on subface
index a4735c09e2ad30364c1e28fb156d8a9c6251bc2c..3fda326e48269ada1a0d1de107f2061ccfe7e90f 100644 (file)
@@ -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 <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/lac/sparsity_pattern.h>
index 9fbc04c33cc6e8eeadfc892e223e568b0404a760..2139eae0660fb9120c94fb274292288ab54e8779 100644 (file)
@@ -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 <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/lac/full_matrix.h>
index 8e9fa96a085ef7c7927b56b1202d02f45a432fe2..a23fbcba81b8f80a9bd6554c5341e6f9e7587426 100644 (file)
@@ -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 <typename VectorType>
   VectorType
index 5db199829bf87c8fa8eea6afcae6ff7f412a7ada..20d85eb68e2004610168d4a59878b15cb9962587 100644 (file)
@@ -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<const SE::Symbol> C  = SE::symbol("C");  // Primary variable
   SE::RCP<const SE::Symbol> Qi = SE::symbol("Qi"); // Some internal variable
index 2af4534ab68c81f0179fcfa71d14becb9b41951a..34cba23c69adad2cd73fe5831c32c1fdc62df06a 100644 (file)
@@ -98,7 +98,7 @@ test_serialization()
     // Optimizer
     SD::BatchOptimizer<NumberType> optimizer;
 
-    // Deserialze
+    // Deserialize
     deallog << "Deserializing..." << std::endl;
     std::istringstream            iss(oss.str());
     boost::archive::text_iarchive ia(iss, boost::archive::no_header);
index 4a6b9a63d206b3384978e8f1f8490c76646e9232..c47c4ca53c3c31ff2735e94739a3ba43296a8622 100644 (file)
@@ -203,7 +203,7 @@ test_serialization(const int n_runs, TimerOutput &timer)
       // Optimizer
       SD::BatchOptimizer<NumberType> optimizer;
 
-      // Deserialze
+      // Deserialize
       std::cout << "Deserializing..." << std::endl;
       std::istringstream            iss(oss.str());
       boost::archive::text_iarchive ia(iss, boost::archive::no_header);
index 3eab565f3aeea685327cb30caa7cc0edbde667ac..61617aa104709d8f19b0856cfa897f5cc9b36b30 100644 (file)
@@ -686,7 +686,7 @@ main()
       f *= x; // f = x^2
       const SD_number_t df_dx = f.differentiate(x);
       Assert(static_cast<bool>(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<bool>(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<bool>(df_dxpy == (2.0 *
       // SD_number_t(symb_x_plus_y))),
-      //        ExcMessage("Problem with differentiaton"));
+      //        ExcMessage("Problem with differentiation"));
     }
   }
 
index 96ec56c149eaa0f521f9b91b84b92c20032d3e4d..6778eeeceddfdf15699368dbd1d06e4c50aaacdb 100644 (file)
@@ -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

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.