]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix codespell findings 8124/head
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Mon, 13 May 2019 01:50:27 +0000 (21:50 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Mon, 13 May 2019 02:03:55 +0000 (22:03 -0400)
doc/news/8.4.2-vs-8.5.0.h
examples/step-62/step-62.cc
include/deal.II/differentiation/sd/symengine_math.h
include/deal.II/meshworker/scratch_data.h
include/deal.II/opencascade/manifold_lib.h
source/algorithms/timestep_control.cc
source/differentiation/sd/symengine_scalar_operations.cc
source/distributed/tria.cc
source/particles/particle_handler.cc
tests/fe/fe_enriched_color_07.cc
tests/hp/crash_21.cc

index c76c3907a7bc5328184a1ddf27f56c45cb811f5f..c8df8d98f55261865d4670a69e344d15305916ef 100644 (file)
@@ -1656,7 +1656,7 @@ inconvenience this causes.
   New: Added TrilinosWrappers::SolveDirect::initialize and
   TrilinosWrappers::SolverDirect::solve to solve distributed linear systems
   with multiple right hand sides without needing to refactorize the matrix
-  everytime.
+  every time.
   <br>
   (Michael Harmon, 2016/06/30)
  </li>
index 9993acf5fd3ec5eb92a15722e5b05192433b5cbf..1ad27e35a5af9ab401aa01019194ab2f2fb721b6 100644 (file)
@@ -1013,7 +1013,7 @@ namespace step62
          position_idx < parameters.nb_probe_points;
          ++position_idx)
       {
-        // Because of the way the operator + and - are overloaded. To substract
+        // Because of the way the operator + and - are overloaded to subtract
         // two points, the following has to be done:
         // `Point_b<dim> + (-Point_a<dim>)`
         const Point<dim> p =
index f8773e557b189917370ed19349dd83cd5d1539cc..f67d98be73f7e8a2995b54e7373ee3a1eb275ff3 100644 (file)
@@ -194,7 +194,7 @@ namespace Differentiation
     //@}
 
     /**
-     * @name Trignometric functions
+     * @name Trigonometric functions
      */
     //@{
 
@@ -378,7 +378,7 @@ namespace Differentiation
     //@}
 
     /**
-     * @name Hyperbolic trignometric functions
+     * @name Hyperbolic trigonometric functions
      */
     //@{
 
index 7c408deb1fed047ed13b17c77dbcd4abf1c1a679..5c9343bc1279432adc80613836b7531fc3b6115e 100644 (file)
@@ -82,7 +82,7 @@ namespace MeshWorker
    * discontinuous Galerkin methods).
    *
    * If you need to retrieve values or gradients of finite element solution
-   * vectors, on the cell, face, or subface that has just beeing initialized
+   * vectors, on the cell, face, or subface that has just been initialized
    * with one of the functions in @ref CurrentCellMethods, you can use the
    * methods in @ref CurrentCellEvaluation.
    *
index 0a7c3cc0d465ceb5189892600873bc2dbe07adf1..b9e0e852d1955af63d38408a59ee1fff30762bfe 100644 (file)
@@ -361,7 +361,7 @@ namespace OpenCASCADE
     /**
      * The constructor takes an OpenCASCADE TopoDS_Face @p face and an optional
      * @p tolerance. This class uses the interval OpenCASCADE variables @var u,
-     * @var v to descrive the manifold.
+     * @var v to describe the manifold.
      */
     NURBSPatchManifold(const TopoDS_Face &face, const double tolerance = 1e-7);
 
index 44e8f6661a7234fb7cc8c32d37dcd8634f79a404..9923a25c7cf3f32fc346be5bc09ec4394b41aecc 100644 (file)
@@ -73,11 +73,11 @@ TimestepControl::parse_parameters(ParameterHandler &param)
   max_step(param.get_double("Max step"));
   final(param.get_double("Final"));
   tolerance(param.get_double("Tolerance"));
-  print_step              = param.get_double("Print step");
-  const std::string strat = param.get("Strategy");
-  if (strat == std::string("uniform"))
+  print_step                 = param.get_double("Print step");
+  const std::string strategy = param.get("Strategy");
+  if (strategy == std::string("uniform"))
     strategy_val = uniform;
-  else if (strat == std::string("doubling"))
+  else if (strategy == std::string("doubling"))
     strategy_val = doubling;
 }
 
index 438b80425710ee6d6d5ad85155c1b3cc14bd235d..19554e0c26038fe11f43648e86465143a40f746f 100644 (file)
@@ -229,7 +229,7 @@ namespace Differentiation
                   // Here we substitute in symbol_values_resolved instead of
                   // symbol_values, in order to break any cyclic dependencies.
                   // The earlier entries in the dictionary are in this way
-                  // guarenteed to be resolved before any subsequent entries,
+                  // guaranteed to be resolved before any subsequent entries,
                   // thereby breaking the dependency loop.
                   out = out.substitute(symbol_values_resolved);
                 }
index 7025f659d9b0c537e0bed9aaa1aa03383ef8607f..95a9af60435a6eeec02d43d7188ef35bed4ebc27 100644 (file)
@@ -1351,7 +1351,7 @@ namespace parallel
       //
       // To deal with the case that at least one of the processors does not own
       // any cell at all, we will exchange the information about the data sizes
-      // among them later. The code inbetween is still well-defined, since the
+      // among them later. The code in between is still well-defined, since the
       // following loops will be skipped.
       std::vector<unsigned int> local_sizes_fixed(
         1 + n_callbacks_fixed + (variable_size_data_stored ? 1 : 0));
index af3b69a031601fc886924ba8846c62df721b0551..75828e053576e957936c666819123eb929b1c04c 100644 (file)
@@ -69,12 +69,13 @@ namespace Particles
   template <int dim, int spacedim>
   void
   ParticleHandler<dim, spacedim>::initialize(
-    const parallel::distributed::Triangulation<dim, spacedim> &tria,
-    const Mapping<dim, spacedim> &                             mapp,
-    const unsigned int                                         n_properties)
+    const parallel::distributed::Triangulation<dim, spacedim>
+      &                           new_triangulation,
+    const Mapping<dim, spacedim> &new_mapping,
+    const unsigned int            n_properties)
   {
-    triangulation = &tria;
-    mapping       = &mapp;
+    triangulation = &new_triangulation;
+    mapping       = &new_mapping;
 
     // Create the memory pool that will store all particle properties
     property_pool = std_cxx14::make_unique<PropertyPool>(n_properties);
index 6a761f8d4a14e3376d384491469964769000e0a9..4336637df312ce848c5d29369ad56c1d372630ba 100644 (file)
@@ -1247,12 +1247,12 @@ LaplaceProblem<dim>::make_enrichment_functions()
        * function for which the enrichment function is to be estimated.
        *
        * The center is 0 since the function is evaluated with respect to
-       * relative position from focal point anyway.
+       * the relative position from the focal point anyway.
        *
-       * For hexahedral cells, dimension can extend upto sqrt(3) < 2 times!
-       * So take a factor of 4 as size of the problem. This ensures that
+       * For hexahedral cells, the dimension can extend up to sqrt(3) < 2 times!
+       * So take a factor of 4 as size of the problem. This ensures that the
        * enrichment function can be evaluated at all points in the enrichment
-       * domain
+       * domain.
        */
       double center = 0;
       double sigma  = prm.sigmas[i];
index 882775c698822fdfe612a05995013ae2056a5bca..c54a735874c20f7e6fe01e24e5ba577f313c633b 100644 (file)
@@ -18,7 +18,7 @@
 // a problem uncovered by Baerbel Janssen in that
 // DoFTools::make_flux_sparsity_pattern aborted in 1d with adaptively refined
 // meshes and hp DoFHandlers. this actually uncovered all sorts of other
-// problems that led to a long sequence of assertions triggered everytime one
+// problems that led to a long sequence of assertions triggered every time one
 // of them was fixed. this test cumulatively makes sure everything is ok
 
 // while there, also test the same code in 2d (3d appears to take too long)

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.