]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix various typos 16007/head
authorluzpaz <luzpaz@users.noreply.github.com>
Mon, 18 Sep 2023 18:22:49 +0000 (18:22 +0000)
committerluzpaz <luzpaz@users.noreply.github.com>
Mon, 18 Sep 2023 18:22:49 +0000 (18:22 +0000)
Found via `codespell -q 3 -S ./bundled,./doc/news -L ans,ba,bu,clen,commend,compontent,inout,nd,pres,re-use,ro,rotat,stoer,workd`

42 files changed:
cmake/macros/macro_deal_ii_pickup_tests.cmake
cmake/macros/macro_define_interface_target.cmake
cmake/macros/macro_populate_target_properties.cmake
cmake/macros/macro_shell_escape_option_groups.cmake
cmake/setup_compiler_flags_gnu.cmake
examples/step-77/doc/results.dox
examples/step-79/step-79.cc
include/deal.II/cgal/utilities.h
include/deal.II/grid/tensor_product_manifold.h
include/deal.II/grid/tria.h
include/deal.II/matrix_free/constraint_info.h
include/deal.II/multigrid/mg_transfer_global_coarsening.h
include/deal.II/numerics/vector_tools_boundary.templates.h
include/deal.II/opencascade/utilities.h
include/deal.II/optimization/line_minimization.h
source/differentiation/ad/adolc_number_types.cc
source/dofs/dof_tools_constraints.cc
source/grid/grid_in.cc
source/hp/refinement.cc
source/lac/trilinos_precondition_ml.cc
source/matrix_free/vector_data_exchange.cc
tests/base/bounding_box_1.cc
tests/boost/node_visitor_02.cc
tests/cgal/cgal_intersect_simplices_3d_3d_02.cc
tests/codim_one/bem.cc
tests/codim_one/integrate_one_over_r.cc
tests/fe/fe_enriched_compare_to_fe_system.cc
tests/fe/fe_enriched_compare_to_fe_system_2.cc
tests/grid/distributed_compute_point_locations_03.cc
tests/hp/fe_nothing_18.cc
tests/lac/packaged_operation_02.cc
tests/lac/tensor_product_matrix.h
tests/matrix_free/parallel_multigrid_adaptive_07.cc
tests/multigrid-global-coarsening/parallel_multigrid_adaptive_07.cc
tests/optimization/step-44.h
tests/performance/collect_measurements
tests/petsc/petsc_ts_03.cc
tests/petsc/step-77-snes.cc
tests/symengine/basic_05.cc
tests/symengine/batch_optimizer_03_1a.cc
tests/symengine/sd_common_tests/batch_optimizer_02.h
tests/symengine/sd_common_tests/batch_optimizer_03.h

index 0dc8560eeac8bb214c28dc13421ec122af46dbe5..64ceedb29e85dc133807920cc6a6687c810f1d8e 100644 (file)
@@ -163,7 +163,7 @@ macro(deal_ii_pickup_tests)
          "running mpi tests within the testsuite. As a consequence all "
          "tests that require an mpi launcher have been disabled.\n"
          "If you want to run tests with mpi then please configure deal.II "
-         "by either setting the MPIEXEC environemt variable or the CMake "
+         "by either setting the MPIEXEC environment variable or the CMake "
          "variable MPIEXEC_EXECUTABLE to a full path to the MPI launcher "
          "program.\n\n"
          )
index 54d1b295850448f6259662099b16e4bf9177ddca..ef0bf0764a68e8b967812eefcfe5fea4b0d6d97f 100644 (file)
@@ -46,7 +46,7 @@
 #   targets), respectively.
 #
 # The default name, i.e., interface_<feature>(|_debug|_release) can be
-# overriden by the optional second argument. For example,
+# overridden by the optional second argument. For example,
 #   define_interface_target(DEAL_II base_configuration)
 # will define interface_base_configuration* targets but query all
 # information from DEAL_II_* variables.
index c85f4f070841a0e99d037f7b4e1a30651b9a47cb..c097dfd214c2ef7f24919e6961bd6ddb662a9bd2 100644 (file)
@@ -65,7 +65,7 @@ function(populate_target_properties _target _build)
 
   #
   # Do not add bundled include directories to bundled_ targets. First of
-  # all this is unnecessary, secondly, this severly trips up ICC-19 that
+  # all this is unnecessary, secondly, this severely trips up ICC-19 that
   # cannot handle the additional -isystem include properly...
   #
   if(NOT "${_target}" MATCHES "^bundled_")
index 78dca443c07e2f6f252d5689be88ae1d6d8c1486..465cd50051675d0f6c811803422a4b2f4e534d44 100644 (file)
@@ -53,7 +53,7 @@ macro(shell_escape_option_groups _variable)
 
   #
   # In addition try to merge options of the form "-Wl,-flag -Wl,/path". We
-  # do this by detecting all occurences of a flag ("-Wl,-[-]flag") followed
+  # do this by detecting all occurrences of a flag ("-Wl,-[-]flag") followed
   # by an option that doesn't start with a dash ("-Wl,[option]"):
   #
   string(REGEX REPLACE
index 08eca34883e5000a1dcef238e6c225e8cba11a72..b3424f3f274f15f7bf8753252f1715f077b02bb7 100644 (file)
@@ -199,7 +199,7 @@ if (CMAKE_BUILD_TYPE MATCHES "Debug")
 
   #
   # We have to ensure that we emit floating-point instructions in debug
-  # mode that preserve the occurence of floating-point exceptions and don't
+  # mode that preserve the occurrence of floating-point exceptions and don't
   # introduce new ones. gcc plays nicely in this regard by enabling
   # `-ftrapping-math` per default, at least for the level of optimization
   # we have in debug mode. clang however is more aggressive and assumes
index 88e1cb378ff0f1dd72a44dbe3c59d579a29953a6..2d7ac8c948b732591b6d601a998768c8f24d5157 100644 (file)
@@ -269,7 +269,7 @@ Mesh refinement step 0
 By default, PETSc uses a Newton solver with cubic backtracking,
 resampling the Jacobian matrix at each Newton step.  That is, we
 compute and factorize the matrix once per Newton step, and then sample
-the residual to check for a successul line-search.
+the residual to check for a successful line-search.
 
 The attentive reader should have noticed that in this case we are
 computing one more extra residual per Newton step.  This is because
index 141688b5f65cff72cfda73dd5bb97ab861e90248..faf392acd59ad03419c78831a8b3dda64e1b8ced 100644 (file)
@@ -1687,7 +1687,7 @@ namespace SAND
       }
 
     // Then compute the residual and take the $l_1$ norms of the
-    // components that correspond to Lagrange mulipliers. We add
+    // components that correspond to Lagrange multipliers. We add
     // those to the objective function computed above, and return
     // the sum at the bottom:
     const BlockVector<double> test_rhs = calculate_test_rhs(test_solution);
index 42b0df7bf38e46d5134562a4c247f318db8be43e..337eb3a09dc1c15498151e692632f97cdda88d31 100644 (file)
@@ -37,7 +37,7 @@
 #  include <CGAL/Mesh_complex_3_in_triangulation_3.h>
 #  include <CGAL/Mesh_criteria_3.h>
 #  include <CGAL/Mesh_triangulation_3.h>
-// Disable a warnung that we get with gcc-13 about a potential unitialized
+// Disable a warnung that we get with gcc-13 about a potential uninitialized
 // usage of an <anonymous> lambda function in this external CGAL header.
 DEAL_II_DISABLE_EXTRA_DIAGNOSTICS
 #  include <CGAL/Polygon_mesh_processing/corefinement.h>
index a6e5c54ea3ba108f5883bfefe3cf7d95914f46b0..c9a4d35d96f84afb1f901230fcb8c6aab7b7d355 100644 (file)
@@ -54,10 +54,10 @@ DEAL_II_NAMESPACE_OPEN
  * @tparam dim Dimension of cells (needs to match first template argument of
  * the Triangulation to be attached to.
  * @tparam dim_A Dimension of ChartManifold A.
- * @tparam spacedim_A Spacial dimension of ChartManifold A.
+ * @tparam spacedim_A Spatial dimension of ChartManifold A.
  * @tparam chartdim_A Chart dimension of ChartManifold A.
  * @tparam dim_B Dimension of ChartManifold B.
- * @tparam spacedim_B Spacial dimension of ChartManifold B.
+ * @tparam spacedim_B Spatial dimension of ChartManifold B.
  * @tparam chartdim_B Chart dimension of ChartManifold B.
  */
 template <int dim,
index 6be48bd07cd94fbc36d254b3f107c52fdc844b85..704baa95f51679fc720ced6102550d3e3f3af386 100644 (file)
@@ -3606,7 +3606,7 @@ public:
 
   /**
    * Save the triangulation into the given file. Internally, this
-   * function calls the save funtion which uses BOOST archives. This
+   * function calls the save function which uses BOOST archives. This
    * is a placeholder implementation that, in the near future, will also
    * attach the data associated with the triangulation
    */
index 27dc2648d393865a77883aabe5425816ab666787..d3c7d7727c6bab61895bac625c1de72573143050 100644 (file)
@@ -78,7 +78,7 @@ namespace internal
 
     /**
      * A helper class to apply constraints in matrix-free loops in
-     * user code. It combines constraint related functionalties from
+     * user code. It combines constraint related functionalities from
      * MatrixFree and FEEvaluation.
      */
     template <int dim, typename Number>
index 222cb12923560eb87016300b6ec16e3e36124f4c..cbfdcc04e63117ecb4117bc7b7ecab1988cd935c 100644 (file)
@@ -1013,7 +1013,7 @@ public:
   /** @} */
 
   /**
-   * @name Tranfer functions.
+   * @name Transfer functions.
    */
   /** @{ */
 
@@ -1349,7 +1349,7 @@ MGTransferMF<dim, Number>::initialize_dof_vector(
       partitioner = external_partitioners[level - transfer.min_level()];
     }
 
-  // check if vectors are already correctly initalized
+  // check if vectors are already correctly initialized
 
   // yes: same partitioners are used
   if (vec.get_partitioner().get() == partitioner.get())
index 3d51d2e1f2ab8587fc38852a08c4619e0d62c567..6bd811a010e54fa04034412f7675ff985ce1ebac 100644 (file)
@@ -2272,7 +2272,7 @@ namespace VectorTools
       std::vector<number>                        &dof_values,
       std::vector<types::global_dof_index>       &projected_dofs)
     {
-      // Compute the intergral over the product of the normal components of
+      // Compute the integral over the product of the normal components of
       // the boundary function times the normal components of the shape
       // functions supported on the boundary.
       const FEValuesExtractors::Vector vec(first_vector_component);
index 59587bc5399f351c4ea27d0a8897c38d91fe0ec5..3563e029085119debe930e391eef43e21735a64d 100644 (file)
@@ -142,7 +142,7 @@ namespace OpenCASCADE
    * mesh it automatically. We remark that the automatic mesh generation in
    * OpenCASCADE takes care only of the geometrical resemblance between the
    * shape and the mesh, to control the shape and regularity of the triangles
-   * you should use other meshing softwares. The two arguments `deflection` and
+   * you should use other meshing software. The two arguments `deflection` and
    * `angular_deflection` select the accuracy of the created triangulation with
    * respect to the original topological shape. The argument
    * `sew_different_faces` gives the possibility to use a Sewer from OpenCASCADE
index b4e99c51bb11b141d929bc027770772181d417b5..82227fa59c0e6b374e3bc082a0ed06a6e60da0cc 100644 (file)
@@ -216,7 +216,7 @@ namespace LineMinimization
    *     // Ensure that the Dirichlet constraints are correctly applied,
    *     // irrespective of the step size
    *     constraints.distribute(newton_update_trial);
-   *     // Now add the constribution from the previously accepted solution
+   *     // Now add the contribution from the previously accepted solution
    *     // history.
    *     const Vector<double> solution_total_trial =
    *       get_solution_total(newton_update_trial);
index 4bb9e357c7970bf79ee44931759a03b16c70b60f..17cf9a40651ebbaea30351a9faeb9a7fa3212715 100644 (file)
@@ -36,7 +36,7 @@ namespace numbers
     namespace
     {
       // Apply some comparator and extract the boolean result of the operation,
-      // instead of the "adub" return type tpyically returned by ADOL-C for
+      // instead of the "adub" return type typically returned by ADOL-C for
       // such a comparison. This is implemented as a general function so that
       // the list of implemented comparative operations can be easily extended.
       bool
index db9f5458dc1d7f84dec0a145ffcfc94f05e0f356..f134f3181b4be0b5ff924bcc1d9cad7b87b44760 100644 (file)
@@ -2725,7 +2725,7 @@ namespace DoFTools
         // when on cell 1, we compute the weights of dof 'x' to be 1/2 from
         // parameter dofs 0 and 1, respectively. however, when later we are on
         // cell 2, we again compute the prolongation of shape function 1
-        // restricted to cell 2 to the globla grid and find that the weight of
+        // restricted to cell 2 to the global grid and find that the weight of
         // global dof 'x' now is zero. however, we should not overwrite the old
         // value.
         //
index 513a879d8e18d09cddde5ca9a875ec2919905db9..8722b54f42e41278181c18978a8fb5ccb96b9856 100644 (file)
@@ -1369,7 +1369,7 @@ GridIn<dim, spacedim>::read_dbmesh(std::istream &in)
   // of fields of which I have no
   // clue what they mean. skip them
   // all and leave the interpretation
-  // to other implementors...
+  // to other implementers...
   while (getline(in, line), ((line.find("End") == std::string::npos) && (in)))
     ;
   // ok, so we are not at the end of
index d5d6eede70413c4178c62c5ab6e963012456eeb3..36f6851f34dbdede2736702bcad738b7e24839c9 100644 (file)
@@ -308,7 +308,7 @@ namespace hp
       //     that apply to all or none of the cells at once. However here, we
       //     do not know which threshold would suffice for this task because the
       //     user could provide any comparison function. Thus if necessary, we
-      //     overwrite the user's choice with suitable functions simplying
+      //     overwrite the user's choice with suitable functions simply
       //     returning 'true' and 'false' for any cell with reference wrappers.
       //     Thus, no function object copies are stored.
       //
index 302fee6b5f8139fd1204399c0f037b766ab7e769..b20160c965a276ab73fae55e1a19349f3f6bfc29 100644 (file)
@@ -74,7 +74,7 @@ namespace TrilinosWrappers
         ML_Epetra::SetDefaults("SA", parameter_list);
 
         // uncoupled mode can give a lot of warnings or even fail when there
-        // are too many entries per row and aggreggation gets complicated, but
+        // are too many entries per row and aggregation gets complicated, but
         // MIS does not work if too few elements are located on one
         // processor. work around these warnings by choosing the different
         // strategies in different situations: for low order, always use the
index 72b0f2f3f769570fa3c968863f83ee05eb751484..064982f0490a9d1790465c87b3883d4d1a56f075 100644 (file)
@@ -389,7 +389,7 @@ namespace internal
         const auto &ghost_indices_within_larger_ghost_set =
           partitioner->ghost_indices_within_larger_ghost_set();
 
-        // temporal data strucutures
+        // temporal data structures
         std::vector<unsigned int> n_ghost_indices_in_larger_set_by_remote_rank;
 
         std::vector<std::array<unsigned int, 3>> ghost_targets_data;
index 18bd0d068e6ddaa9693ae607366b889b249ae556..09c7087ed372d4e3b56b306621efeab438308287 100644 (file)
@@ -105,7 +105,7 @@ test_bounding_box()
   }
   deallog << std::endl;
 
-  // Initalize box with point
+  // Initialize box with point
   {
     Point<spacedim> p;
     for (unsigned int i = 0; i < spacedim; ++i)
@@ -118,7 +118,7 @@ test_bounding_box()
   }
   deallog << std::endl;
 
-  // Initalize box with box
+  // Initialize box with box
   {
     BoundingBox<spacedim> bb(b);
     deallog << "Boundary points: " << std::endl;
@@ -127,7 +127,7 @@ test_bounding_box()
   }
   deallog << std::endl;
 
-  // Initalize box with box
+  // Initialize box with box
   {
     BoundingBox<spacedim> bb;
     bb = b;
index 85e4e899705f931c7c1622faee3aed16e140da37..7a7932f3c49ffe587070888a1734a67277f62746 100644 (file)
@@ -13,7 +13,7 @@
 //
 // ---------------------------------------------------------------------
 
-// Use information from NodeVisitor to print show explicitely the boxes
+// Use information from NodeVisitor to print show explicitly the boxes
 // associated to each parent node on the previous level
 
 #include <deal.II/base/bounding_box.h>
index cd35ec5deae9b16012f022a270df08fc7046c259..97a5645b0ad384845a988227af74425e023d6af5 100644 (file)
@@ -13,7 +13,7 @@
 //
 // ---------------------------------------------------------------------
 
-// Compute intersection of two 3D cells. This additional test is added becase
+// Compute intersection of two 3D cells. This additional test is added because
 // intersections are not found with inexact kernels.
 
 #include <deal.II/fe/mapping_q1.h>
index 71170856080f4529e36aa6d95b0c1e0f2c1bfd07..566542264d9ef365d84fa4c377a94fdba3773cc7 100644 (file)
@@ -122,7 +122,7 @@ BEM<spacedim>::run()
       SphericalManifold<spacedim - 1, spacedim> boundary(p);
       tria.set_manifold(1, boundary);
 
-      // works up to cycle<9, but for testin purpose, we stop at 4
+      // works up to cycle<9, but for testing purpose, we stop at 4
       for (unsigned int cycle = 0; cycle < 4; ++cycle)
         {
           tria.set_manifold(1, boundary);
index 3db1f3d2c93e2ded2792fd38516105a1bea5bef2..f3bb777aa2886d3f6eab2080c8551ad1e564dbf9 100644 (file)
@@ -93,7 +93,7 @@ main()
                     deallog << std::endl;
                   else
                     deallog
-                      << ", desing: " << approx_integral_2 - exact_integral
+                      << ", design: " << approx_integral_2 - exact_integral
                       << std::endl;
                 }
             }
index 1034dd0cd68c7fe17d4e79b663955b6b7192fa99..4fd21a9d77da26242e2736d337416bb654420f00 100644 (file)
@@ -51,7 +51,7 @@ const double eps = 1e-10;
 // move nodes randomly
 // and compare FEEnriched to FESystem with explicit treatment of
 // the product rule for
-// valus, gradients, hessians on
+// values, gradients, hessians on
 // elements and faces.
 // The comparison is straight forward because local dofs are enumerated
 // in the same way for FE_System and FEEnriched.
index ab2a491f76ca1dc813f62340afcbb815b86987d1..9cd61abe13004ce1c4a5026e88e614c4fc0f64e8 100644 (file)
@@ -51,7 +51,7 @@ const double eps = 1e-10;
 // move nodes randomly
 // and compare FEEnriched to FESystem with explicit treatment of
 // the product rule for
-// valus, gradients, hessians on
+// values, gradients, hessians on
 // elements and faces.
 // The comparison is straight forward because local dofs are enumerated
 // in the same way for FE_System and FEEnriched.
index 33474f3ecbae35ff3f3bcebaacd2187a3905e80c..008cfd83cb62e3a5a0ec5ae26580f227250be97d 100644 (file)
@@ -49,7 +49,7 @@ test_distributed_cpt(unsigned int ref_cube)
           << std::endl;
   deallog << "Cube refinements: " << ref_cube << std::endl;
 
-  // Creeating the cube on which to run distributed cpt loc
+  // Creating the cube on which to run distributed cpt loc
   parallel::distributed::Triangulation<dim> cube_d(mpi_communicator);
   GridGenerator::hyper_cube(cube_d);
   cube_d.refine_global(ref_cube);
index cdfbeee71d329c95e97305b7dfa485363337892d..2c3c89727751892f04c522a8cc90fbfe0d3f41b2 100644 (file)
@@ -242,7 +242,7 @@ ElasticProblem<dim>::ElasticProblem()
   , degree(1)
   , dofs_per_block(n_blocks)
   , dof_handler(triangulation)
-  , /*assotiate dof_handler to the triangulation */
+  , /*associate dof_handler to the triangulation */
   elasticity_fe(
     FE_Q<dim>(degree),
     dim, // use dim FE_Q of a given degree to represent displacements
index 573c0138d07205ba1443c873e119808ae8501cad..65dc3a6fc7f2e108603223d40af4226731f67cd5 100644 (file)
@@ -20,7 +20,7 @@
 
 #include "../tests.h"
 
-// and a _lot_ of stuff to create a linera oprator
+// and a _lot_ of stuff to create a linear operator
 #include <deal.II/base/quadrature_lib.h>
 
 #include <deal.II/dofs/dof_handler.h>
@@ -67,7 +67,7 @@ main()
 
   static const int dim = 2;
 
-  // Create mass marix M, and an iterative inverse MInv:
+  // Create mass matrix M, and an iterative inverse MInv:
 
   Triangulation<dim> triangulation;
   GridGenerator::hyper_cube(triangulation);
index 85f3d506a7cafa50f227468de73cf8fb43b2af7e..d7ca6a091e36c67a40d3c60edc1bf8b63a57b9d9 100644 (file)
@@ -65,7 +65,7 @@ namespace dealii
     }
 
     // Compute harmonic extent of each locally owned cell including of each
-    // of its neighbors. If there is no neigbor, its extent is zero.
+    // of its neighbors. If there is no neighbor, its extent is zero.
     template <int dim>
     std::vector<dealii::ndarray<double, dim, 3>>
     compute_harmonic_patch_extent(const Mapping<dim>        &mapping,
@@ -79,7 +79,7 @@ namespace dealii
                                                 quadrature);
 
       // 2) accumulate for each face the normal extent for the
-      // neigboring cell(s); here we also consider periodicies
+      // neighboring cell(s); here we also consider periodicies
       std::vector<double> face_extent(triangulation.n_faces(), 0.0);
 
       for (const auto &cell : triangulation.active_cell_iterators())
index 06164975aa566e87a053107592783324e5ed2202..cf750d6ba8c55448d4787abc8dda4b43c2bd9c3a 100644 (file)
@@ -18,7 +18,7 @@
 // This test is similar to parallel_multigrid_adaptive_06 but we also test
 // for different polynomial degree in different blocks.
 // We expect to have the same iteration numbers as in
-// parallel_multigrid_adaptive_06 with repsect to the highest polynomial
+// parallel_multigrid_adaptive_06 with respect to the highest polynomial
 // degree used.
 
 
index 3175054b230f9826954ad18448316d9fc897d7c9..ab0bc413a6ac8a50e465cd175ab4f7584511ea47 100644 (file)
@@ -18,7 +18,7 @@
 // This test is similar to parallel_multigrid_adaptive_06 but we also test
 // for different polynomial degree in different blocks.
 // We expect to have the same iteration numbers as in
-// parallel_multigrid_adaptive_06 with repsect to the highest polynomial
+// parallel_multigrid_adaptive_06 with respect to the highest polynomial
 // degree used.
 
 
index 745f022136f606010dc4e78e8fd7fcaca4543b74..6ec2ede11b593ecd27f95bd15636b332cade88ea 100644 (file)
@@ -1331,7 +1331,7 @@ namespace Step44
             BlockVector<double> solution_delta_trial(newton_update);
             solution_delta_trial *= ss;
             this->constraints.distribute(solution_delta_trial);
-            // Now add the constribution from the previously accepted solution
+            // Now add the contribution from the previously accepted solution
             // history.
             solution_delta_trial += solution_delta;
 
index 9c2ce8028251da57597ef0fb105166e323ed03aa..8a0230cbcb10bd75f8bdf7f5f20d116cd5389c36 100755 (executable)
@@ -23,7 +23,7 @@
 #
 
 #
-# First, collect some metatadata:
+# First, collect some metadata:
 #
 
 site="${1}"
index 2fbc400babee883d819b536b3728be67e52aeacd..6a10bc9767a9736b9a573d615b0fe8c4a9ab3fd0 100644 (file)
@@ -171,7 +171,7 @@ public:
               << ')' << std::endl;
     };
 
-    // This callback is invoked after a successfull stage.
+    // This callback is invoked after a successful stage.
     // Here we only print that the callback is invoked.
     time_stepper.distribute = [&](const real_type t, VectorType &) -> void {
       deallog << "Distribute at time " << t << std::endl;
index b20d67e3bcf603fe3499a5259eb6d3a9fcc64687..ee1984e3b505d381752db4f9fc74bd85d73ca633 100644 (file)
@@ -496,7 +496,7 @@ namespace Step77
         // reach; but you might want to look into what other members of the
         // PETScWrappers::NonlinearSolverData class has and play with them).
         //
-        // When using the PETSc nonlinear solver, we have two possibilites,
+        // When using the PETSc nonlinear solver, we have two possibilities,
         // both of them are coded below for this example.
         //  - In the case with `user_control` set to true
         //    there is complete control of the linear system solution process
index 8ebd7282121475efb9dbc5da53dc052dd0b543eb..8f6586fbb424c233b8ada11832abff95f1cfbeca 100644 (file)
@@ -13,7 +13,7 @@
 //
 // ---------------------------------------------------------------------
 
-// Check that SymEngine can do some optimsation on diffentiated expressions
+// Check that SymEngine can do some optimsation on differentiated expressions
 // using lambda functions
 // This is an extension of basic_04.cc
 
index 6dec948d1b12f0b2d0d24434a3474c2a11f5366f..358eac27ef7b421e6b77c11ca2043db862cc9b91 100644 (file)
@@ -20,7 +20,7 @@
 // See tests/symengine/basic_06.cc and tests/symengine/basic_07.cc for
 // a more simple example of differentiation of symbols with
 // explicit/implicit relationships.
-// We invoke the batch optimzer before symbolic evaluation takes place.
+// We invoke the batch optimizer before symbolic evaluation takes place.
 //
 // Here we use only dictionary substitution, and invoke no symbolic
 // optimizations.
index a04ed980fcc719be1e9b523ddefa0808fa1e604e..9b9b682878c8b250355a1150685d4c137a0f5bcc 100644 (file)
@@ -17,7 +17,7 @@
 // Check that the wrapper for symengine numbers can be integrated into the
 // tensor class and works as expected.
 // This test is the same as symengine_wrapper_03.cc, except that we invoke the
-// batch optimzer  before symbolic evaluation takes place.
+// batch optimizer before symbolic evaluation takes place.
 
 #include <deal.II/base/timer.h>
 
index 2706c1eaac63db0135a5ee94f9def44d8be86b5f..2165397230b3146626027a326623618bd071e936 100644 (file)
@@ -20,7 +20,7 @@
 // See tests/symengine/basic_06.cc and tests/symengine/basic_07.cc for
 // a more simple example of differentiation of symbols with
 // explicit/implicit relationships.
-// We invoke the batch optimzer before symbolic evaluation takes place.
+// We invoke the batch optimizer before symbolic evaluation takes place.
 
 #include <deal.II/base/symmetric_tensor.h>
 #include <deal.II/base/tensor.h>

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.