]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Found more typos
authorluz.paz <luzpaz@users.noreply.github.com>
Mon, 12 Mar 2018 05:03:33 +0000 (01:03 -0400)
committerluz paz <luzpaz@users.noreply.github.com>
Mon, 12 Mar 2018 11:37:32 +0000 (07:37 -0400)
34 files changed:
contrib/python-bindings/include/point_wrapper.h
contrib/python-bindings/include/triangulation_wrapper.h
contrib/python-bindings/notebooks/tutorial-1.ipynb
contrib/python-bindings/source/export_triangulation.cc
contrib/utilities/wrapcomments.py
examples/step-18/step-18.cc
examples/step-26/doc/intro.dox
examples/step-31/step-31.cc
examples/step-32/step-32.cc
examples/step-33/doc/results.dox
examples/step-37/doc/results.dox
examples/step-44/step-44.cc
examples/step-57/step-57.cc
examples/step-9/step-9.cc
include/deal.II/lac/trilinos_solver.h
include/deal.II/lac/vector_view.h
source/base/data_out_base.cc
source/base/parameter_acceptor.cc
source/distributed/tria.cc
source/dofs/dof_tools.cc
source/fe/fe_nedelec.cc
source/fe/mapping_q_generic.cc
source/grid/grid_in.cc
source/grid/grid_tools.cc
source/grid/grid_tools_dof_handlers.cc
source/grid/tria.cc
source/grid/tria_boundary_lib.cc
source/lac/petsc_parallel_sparse_matrix.cc
source/lac/petsc_solver.cc
source/lac/trilinos_precondition.cc
source/lac/trilinos_sparse_matrix.cc
source/lac/trilinos_sparsity_pattern.cc
source/multigrid/mg_tools.cc
tests/manifold/transfinite_manifold_07.cc

index fd014c490572091158715e176694e1506adb7250..2a95b4eeae68ab322ccaa670bb28c82e37cb07ad 100644 (file)
@@ -40,7 +40,7 @@ namespace python
     PointWrapper(boost::python::list list);
 
     /**
-     * Constructor. Intialize PointWrapper using a Point.
+     * Constructor. Initialize PointWrapper using a Point.
      */
     template <int dim>
     PointWrapper(const Point<dim> &p);
index 35d4704f2f0bd931812659186c3d37f22a65534e..a73e80ca5120bb52c86676cd13e53886ab6073d8 100644 (file)
@@ -184,7 +184,7 @@ namespace python
 
     /**
      * A subdivided parallelepided, i.e., the same as above, but where the
-     * number of subdivisions in each ot the @tparam dim directsions may vary.
+     * number of subdivisions in each of the @tparam dim directions may vary.
      * Colorizing is done according to hyper_rectangle().
      */
     void generate_varying_subdivided_parallelepiped(boost::python::list &n_subdivisions,
@@ -231,7 +231,7 @@ namespace python
      * Generate a hyper-ball intersected with the positive orthant relate to @p
      * center, which contains three elements in 2d and four in 3d. The boundary
      * indicators for the final triangulations are 0 for the curved boundary
-     * and 1 for the cut plane. The appropiate boundary class is
+     * and 1 for the cut plane. The appropriate boundary class is
      * HyperBallBoundary.
      */
     void generate_quarter_hyper_ball(PointWrapper &center,
@@ -328,7 +328,7 @@ namespace python
 
   private:
     /**
-     * Helper function for the contructors.
+     * Helper function for the constructors.
      */
     void setup(const std::string &dimension, const std::string &spacedimension);
 
index 9c76980eef0bef239b2133d0cbe1c950e5e52dfe..5dc91d03b4046b53a7bc801d933bf9de0c93c506 100644 (file)
@@ -31,7 +31,7 @@
    "cell_type": "markdown",
    "metadata": {},
    "source": [
-    "We start by creating a 2D **Triangulation** of an hyper cube and we globally refine it twice. You can read the documention of **Triangulation** by typing:\n",
+    "We start by creating a 2D **Triangulation** of an hyper cube and we globally refine it twice. You can read the documentation of **Triangulation** by typing:\n",
     "```python\n",
     "help(dealii.Triangulation)\n",
     "```\n",
index 6dc543f4eb2302cd115f12af93b7029ef57af489..ae2f62aa6099ff7d5ddcbfe1bc4f9e6bb92e6b3b 100644 (file)
@@ -182,7 +182,7 @@ namespace python
 
   const char generate_varying_subdivided_parallelepiped_docstring [] =
     "A subdivided parallelepided, i.e., the same as above, but where the    \n"
-    "number of subdivisions in each ot the dim directsions may vary.        \n"
+    "number of subdivisions in each of the dim directions may vary.         \n"
     "Colorizing is done according to hyper_rectangle().                     \n"
     ;
 
@@ -226,7 +226,7 @@ namespace python
     "Generate a hyper-ball intersected with the positive orthant relate to  \n"
     "center, which contains three elements in 2d and four in 3d. The        \n"
     "boundary indicators for the final triangulations are 0 for the curved  \n" 
-    "boundary and 1 for the cut plane. The appropiate boundary class is     \n"
+    "boundary and 1 for the cut plane. The appropriate boundary class is    \n"
     "HyperBallBoundary.                                                     \n"
     ;
 
index fe8e37650d68b3c7b43c4c917b5632983a2a1c79..2f4af7757e1f8551b2793247f7dcbdfe9985a729 100755 (executable)
@@ -31,7 +31,7 @@ import sys, re
 # As of python 2.6 we can tell the text wrapper to not break on hyphens. This is
 # usually what we want to do: we don't want to split URLs with hyphens and
 # doxygen will format 'non-primitive' as 'non- primitive' if it is
-# (inadvertantly) split across two lines.
+# (inadvertently) split across two lines.
 wrapper = textwrap.TextWrapper(break_on_hyphens=False)
 
 # take an array of lines and wrap them to 78 columns and let each line start
index ac33fc07b8e81275cf9bc2ef3b4c184b51f653f5..938adeda2e663e6f2b7864ee2d9d6a2855e6f9bf 100644 (file)
@@ -348,7 +348,7 @@ namespace Step18
   // good number of more member functions now, which we will explain below.
   //
   // The external interface of the class, however, is unchanged: it has a
-  // public constructor and desctructor, and it has a <code>run</code>
+  // public constructor and destructor, and it has a <code>run</code>
   // function that initiated all the work.
   template <int dim>
   class TopLevel
@@ -1388,7 +1388,7 @@ namespace Step18
 
         // Finally, we write the paraview record, that references all .pvtu files and
         // their respective time. Note that the variable times_and_names is declared
-        // static, so it will retain the entries from the pervious timesteps.
+        // static, so it will retain the entries from the previous timesteps.
         static std::vector<std::pair<double,std::string> > times_and_names;
         times_and_names.push_back (std::pair<double,std::string> (present_time, pvtu_master_filename));
         std::ofstream pvd_output ("solution.pvd");
index 616844299c58d4164fecd52aa88bd66979e55970..de58294e16d5325d79c5d362aa2d73d79f101ab1 100644 (file)
@@ -422,7 +422,7 @@ Here,
   \end{array}
   \right.
 @f}
-In other words, in every period of lenght $\tau$, the right hand side first
+In other words, in every period of length $\tau$, the right hand side first
 flashes on in domain 1, then off completely, then on in domain 2, then off
 completely again. This pattern is probably best observed via the little
 animation of the solution shown in the <a href="#Results">results
index 3516584150cad582fbab2d05ceb801401e514bd5..07a43270b4f8da0d5e4606fdf3935fd9bbe83b62 100644 (file)
@@ -2080,8 +2080,8 @@ namespace Step31
     temperature_solution = tmp[0];
     old_temperature_solution = tmp[1];
 
-    // After the solution has been transfered we then enforce the constraints
-    // on the transfered solution.
+    // After the solution has been transferred we then enforce the constraints
+    // on the transferred solution.
     temperature_constraints.distribute(temperature_solution);
     temperature_constraints.distribute(old_temperature_solution);
 
index b7750eda86db342fca8db8d65f8c892696d2a1e1..bd89b72e7237f4ff26480b1c42b6c12e61a2d2c2 100644 (file)
@@ -1171,7 +1171,7 @@ namespace Step32
   // The constructor of the problem is very similar to the constructor in
   // step-31. What is different is the %parallel communication: Trilinos uses
   // a message passing interface (MPI) for data distribution. When entering
-  // the BoussinesqFlowProblem class, we have to decide how the parallization
+  // the BoussinesqFlowProblem class, we have to decide how the parallelization
   // is to be done. We choose a rather simple strategy and let all processors
   // that are running the program work together, specified by the communicator
   // <code>MPI_COMM_WORLD</code>. Next, we create the output stream (as we
@@ -1659,7 +1659,7 @@ namespace Step32
   // concept). Here we chose to keep things simple (keeping in mind that this
   // function is also only called once at the beginning of the program, not in
   // every time step), and generating the right hand side is cheap anyway so
-  // we won't even notice that this part is not parallized by threads.
+  // we won't even notice that this part is not parallelized by threads.
   //
   // Regarding the implementation of inhomogeneous Dirichlet boundary
   // conditions: Since we use the temperature ConstraintMatrix, we could apply
index f25a9967a773a728325b24f38f7c93744de4aecf..f728f4d0fdc373a35402bed63616c76444a033ec 100644 (file)
@@ -225,7 +225,7 @@ refinement scheme discussed above.
 <h4>Stabilization</h4>
 
 The numerical scheme we have chosen is not particularly
-stable when the artificial viscosity is samll while is too diffusive when
+stable when the artificial viscosity is small while is too diffusive when
 the artificial viscosity is large. Furthermore, it is known there are more
 advanced techniques to stabilize the solution, for example streamline
 diffusion, least-squares stabilization terms, entropy viscosity.
@@ -260,7 +260,7 @@ faster.
 
 <h4>Cache the explicit part of residual</h4>
 
-The residual calulated in ConservationLaw::assemble_cell_term function
+The residual calculated in ConservationLaw::assemble_cell_term function
 reads 
    $R_i = \left(\frac{\mathbf{w}^{k}_{n+1} - \mathbf{w}_n}{\delta t}
     , \mathbf{z}_i \right)_K  +
index 3af36132dd51b298dc27da7e3f64913b0ee19346..789b843e4468f6936eb3a1b0fff3c60799ac145c 100644 (file)
@@ -482,7 +482,7 @@ represents a <b>linear</b> operator.
 In our matrix-free code, the right hand side computation where the
 contribution of inhomogeneous conditions ends up is completely decoupled from
 the matrix operator and handled by a different function above. Thus, we need
-to explicity generate the data that enters the right hand side rather than
+to explicitly generate the data that enters the right hand side rather than
 using a byproduct of the matrix assembly. Since we already know how to apply
 the operator on a vector, we could try to use those facilities for a vector
 where we only set the Dirichlet values:
index 3ade96dcfbdc9235ad61469be74acf4eb544bc63..f232611534dbee2e7a1104f21b785432f49ea1c3 100644 (file)
@@ -1194,7 +1194,7 @@ namespace Step44
 
 // @sect4{Threading-building-blocks structures}
 
-// The first group of private member functions is related to parallization.
+// The first group of private member functions is related to parallelization.
 // We use the Threading Building Blocks library (TBB) to perform as many
 // computationally intensive distributed tasks as possible. In particular, we
 // assemble the tangent matrix and right hand side vector, the static
index bdf3f54f66a26cf85fecbddd25524aea2910c173..0a117cd05b9665e8f2d57c56dafe363a0013fbb6 100644 (file)
@@ -609,7 +609,7 @@ namespace Step57
     BlockVector<double> tmp (dofs_per_block);
 
     // Transfer solution from coarse to fine mesh and apply boundary value
-    // constraints to the new transfered solution. Note that present_solution
+    // constraints to the new transferred solution. Note that present_solution
     // is still a vector corresponding to the old mesh.
     solution_transfer.interpolate(present_solution, tmp);
     nonzero_constraints.distribute(tmp);
index 0c51bd9893c0cbe1973fe4bb63fb330da59ede05..0129c1e6add869f33ac570ae5b58ed4ec9000016 100644 (file)
@@ -579,7 +579,7 @@ namespace Step9
   // seen that assembling in parallel does not take an incredible
   // amount of extra code as long as you diligently describe what the
   // scratch and copy data objects are, and if you define suitable
-  // functios for the local assembly and the copy operation from local
+  // functions for the local assembly and the copy operation from local
   // contributions to global objects. This done, the following will do
   // all the heavy lifting to get these operations done on multiple
   // threads on as many cores as you have in your system:
index 014f865fa41bb1ef0482fc033af9b5236f09f757..744c9702de6a6d0395564b1250330aa4e00846c3 100644 (file)
@@ -638,14 +638,14 @@ namespace TrilinosWrappers
 
     /**
      * Solve the linear system <tt>Ax=b</tt> based on the
-     * package set in intialize(). Note the matrix is not refactorized during
+     * package set in initialize(). Note the matrix is not refactorized during
      * this call.
      */
     void solve (MPI::Vector &x, const MPI::Vector &b);
 
     /**
      * Solve the linear system <tt>Ax=b</tt> based on the package set in
-     * intialize() for deal.II's own parallel vectors. Note the matrix is not
+     * initialize() for deal.II's own parallel vectors. Note the matrix is not
      * refactorized during this call.
      */
     void
index 5e7bf414484ceddc00625acea09896e94e16cb17..7707fd36d5993046c28057bb3eeb315e024e40ed 100644 (file)
@@ -312,7 +312,7 @@ template <typename Number>
 inline
 void VectorView<Number>::swap(Vector<Number> &)
 {
-  AssertThrow(false, ExcMessage("Cant' swap a VectorView with a Vector!"));
+  AssertThrow(false, ExcMessage("Can't swap a VectorView with a Vector!"));
 }
 
 #endif
index 65183d71c60720b1ccde784b1e2ec30082782424..075f64c05f418dbea253b69bb85a8cac6ca7ad23 100644 (file)
@@ -3481,7 +3481,7 @@ namespace DataOutBase
         }
     }
 
-    // max. and min. heigth of solution
+    // max. and min. height of solution
     Assert(patches.size()>0, ExcInternalError());
     double hmin=patches[0].data(0,0);
     double hmax=patches[0].data(0,0);
index be83e783d3d11021c309c6de216cf6a3272ac2c6..1da11b6c2bd2ca0a3240a5f3c83f169cd8b6a338 100644 (file)
@@ -187,7 +187,7 @@ ParameterAcceptor::get_section_path() const
     Utilities::split_string_list(my_section_name, sep);
 
   // Split string list removes trailing empty strings, but not
-  // preceeding ones. Make sure that if we had an absolute path,
+  // preceding ones. Make sure that if we had an absolute path,
   // we don't store as first section the empty string.
   if (is_absolute)
     sections.erase(sections.begin());
index e343cce94e69037b569d9cc86e5a5ce6b8d942f2..24b9171d106ebee9ce2d6113658c3089c8e34e6b 100644 (file)
@@ -491,7 +491,7 @@ namespace
                 {
                   // no, this child is locally not available in the p4est.
                   // delete all its children but, because this may not be
-                  // successfull, make sure to mark all children recursively
+                  // successful, make sure to mark all children recursively
                   // as not local.
                   delete_all_children<dim,spacedim> (dealii_cell->child(c));
                   dealii_cell->child(c)
index 0cbe913a27502a15652e0300285f0f6ba2315752..19c1edce779184dbaebb0f7d3543f1432c9d4d13 100644 (file)
@@ -1450,7 +1450,7 @@ namespace DoFTools
     Assert(dof_handler.n_dofs() > 0, ExcInternalError());
 
     // In case this function is executed with parallel::shared::Triangulation
-    // with possibly artifical cells, we need to take "true" subdomain IDs (i.e. without
+    // with possibly artificial cells, we need to take "true" subdomain IDs (i.e. without
     // artificial cells). Otherwise we are good to use subdomain_id as stored
     // in cell->subdomain_id().
     std::vector<types::subdomain_id> cell_owners (dof_handler.get_triangulation().n_active_cells());
index cb92d69969b6fb73ddc31b4782470d204a2d0bb7..cb14e9829972e65a4ac23077cc9f77e4bd02bf4b 100644 (file)
@@ -2013,7 +2013,7 @@ FE_Nedelec<dim>::get_dpo_vector (const unsigned int degree, bool dg)
 // Data field initialization
 //---------------------------------------------------------------------------
 
-// Chech wheter a given shape
+// Check whether a given shape
 // function has support on a
 // given face.
 
index 4efd7c248085298d5428900b6a3d7da1160468ff..071b5a57080f684b1228d7ed69b6175f88bddfdc 100644 (file)
@@ -98,7 +98,7 @@ namespace internal
         Assert(spacedim == 2, ExcInternalError());
 
         // For accuracy reasons, we do all arithmetics in extended precision
-        // (long double). This has a noticable effect on the hit rate for
+        // (long double). This has a noticeable effect on the hit rate for
         // borderline cases and thus makes the algorithm more robust.
         const long double x = p(0);
         const long double y = p(1);
index eec85a4729a9271cb4a1a3c2004c7afdd2f56463..b1f8029137719345f7d92a1fb63fb867a30065d8 100644 (file)
@@ -704,7 +704,7 @@ void GridIn<dim, spacedim>::read_ucd (std::istream                            &i
           for (unsigned int i=0; i<GeometryInfo<dim>::vertices_per_cell; ++i)
             in >> cells.back().vertices[i];
 
-          // to make sure that the cast wont fail
+          // to make sure that the cast won't fail
           Assert(material_id<= std::numeric_limits<types::material_id>::max(),
                  ExcIndexRange(material_id,0,std::numeric_limits<types::material_id>::max()));
           // we use only material_ids in the range from 0 to numbers::invalid_material_id-1
@@ -735,7 +735,7 @@ void GridIn<dim, spacedim>::read_ucd (std::istream                            &i
           in >> subcelldata.boundary_lines.back().vertices[0]
              >> subcelldata.boundary_lines.back().vertices[1];
 
-          // to make sure that the cast wont fail
+          // to make sure that the cast won't fail
           Assert(material_id<= std::numeric_limits<types::boundary_id>::max(),
                  ExcIndexRange(material_id,0,std::numeric_limits<types::boundary_id>::max()));
           // we use only boundary_ids in the range from 0 to numbers::internal_face_boundary_id-1
@@ -776,7 +776,7 @@ void GridIn<dim, spacedim>::read_ucd (std::istream                            &i
              >> subcelldata.boundary_quads.back().vertices[2]
              >> subcelldata.boundary_quads.back().vertices[3];
 
-          // to make sure that the cast wont fail
+          // to make sure that the cast won't fail
           Assert(material_id<= std::numeric_limits<types::boundary_id>::max(),
                  ExcIndexRange(material_id,0,std::numeric_limits<types::boundary_id>::max()));
           // we use only boundary_ids in the range from 0 to numbers::internal_face_boundary_id-1
@@ -1430,7 +1430,7 @@ void GridIn<dim, spacedim>::read_msh (std::istream &in)
           for (unsigned int i=0; i<GeometryInfo<dim>::vertices_per_cell; ++i)
             in >> cells.back().vertices[i];
 
-          // to make sure that the cast wont fail
+          // to make sure that the cast won't fail
           Assert(material_id<= std::numeric_limits<types::material_id>::max(),
                  ExcIndexRange(material_id,0,std::numeric_limits<types::material_id>::max()));
           // we use only material_ids in the range from 0 to numbers::invalid_material_id-1
@@ -1459,7 +1459,7 @@ void GridIn<dim, spacedim>::read_msh (std::istream &in)
           in >> subcelldata.boundary_lines.back().vertices[0]
              >> subcelldata.boundary_lines.back().vertices[1];
 
-          // to make sure that the cast wont fail
+          // to make sure that the cast won't fail
           Assert(material_id<= std::numeric_limits<types::boundary_id>::max(),
                  ExcIndexRange(material_id,0,std::numeric_limits<types::boundary_id>::max()));
           // we use only boundary_ids in the range from 0 to numbers::internal_face_boundary_id-1
@@ -1496,7 +1496,7 @@ void GridIn<dim, spacedim>::read_msh (std::istream &in)
              >> subcelldata.boundary_quads.back().vertices[2]
              >> subcelldata.boundary_quads.back().vertices[3];
 
-          // to make sure that the cast wont fail
+          // to make sure that the cast won't fail
           Assert(material_id<= std::numeric_limits<types::boundary_id>::max(),
                  ExcIndexRange(material_id,0,std::numeric_limits<types::boundary_id>::max()));
           // we use only boundary_ids in the range from 0 to numbers::internal_face_boundary_id-1
index 5318d8c14631952aadb38ea356616119782a5823..71535dc69561007798ac962c5d61d9640d2f0d84 100644 (file)
@@ -2024,7 +2024,7 @@ next_cell:
 #ifndef DEAL_II_WITH_MPI
 
     // without MPI, this function doesn't make sense because on cannot
-    // use parallel::distributed::Triangulation in any meaninful
+    // use parallel::distributed::Triangulation in any meaningful
     // way
     (void)triangulation;
     Assert (false, ExcMessage ("This function does not make any sense "
index a215c4e9d678eb52c52244b8303be284c1f6ef30..516327a0400d58ca67d6b0b274b2c65824746dc4 100644 (file)
@@ -1094,7 +1094,7 @@ next_cell:
                     // to the next
                   }
               }
-            //udpate the number of cells searched
+            //update the number of cells searched
             cells_searched += adjacent_cells.size();
             // if we have not found the cell in
             // question and have not yet searched every
@@ -1392,7 +1392,7 @@ next_cell:
     // uniqueness of cell iterators. std::set does this
     // automatically for us.  Later after it is all
     // constructed, we will copy to a map of vectors
-    // since that is the prefered output for other
+    // since that is the preferred output for other
     // functions.
     std::map< types::global_dof_index,std::set<typename DoFHandlerType::active_cell_iterator> > dof_to_set_of_cells_map;
 
index 16a67f5242ff2f395f1f5f56dabb192e235ce62e..cc8f7d4c67c1e1eca215db9a25822d0ad8d1b8ed 100644 (file)
@@ -2071,7 +2071,7 @@ namespace internal
                     // if we are here, it means that we want to assign a boundary indicator
                     // different from numbers::internal_face_boundary_id to an internal line.
                     // As said, this would be not allowed, and an exception should be immediately
-                    // thrown. Still, there is the possibility that one only wants to specifiy a
+                    // thrown. Still, there is the possibility that one only wants to specify a
                     // manifold_id here. If that is the case (manifold_id !=  numbers::flat_manifold_id)
                     // the operation is allowed. Otherwise, we really tried to specify a boundary_id
                     // (and not a manifold_id) to an internal face. The exception must be thrown.
@@ -5092,7 +5092,7 @@ namespace internal
                 // are not consecutive, we cannot do so and have to
                 // replace them by two lines that are consecutive. we
                 // try to avoid that situation, but it may happen
-                // nevertheless throug repeated refinement and
+                // nevertheless through repeated refinement and
                 // coarsening. thus we have to check here, as we will
                 // need some additional space to store those new lines
                 // in case we need them...
@@ -9268,13 +9268,13 @@ create_triangulation (const std::vector<Point<spacedim> >    &v,
   /*
       When the triangulation is a manifold (dim < spacedim), the normal field
       provided from the map class depends on the order of the vertices.
-      It may happen that this normal field is discontinous.
+      It may happen that this normal field is discontinuous.
       The following code takes care that this is not the case by setting the
       cell direction flag on those cell that produce the wrong orientation.
 
       To determine if 2 neighbours have the same or opposite orientation
       we use a table of truth.
-      Its entries are indexes by the local indeces of the common face.
+      Its entries are indexes by the local indices of the common face.
       For example if two elements share a face, and this face is
       face 0 for element 0 and face 1 for element 1, then
       table(0,1) will tell whether the orientation are the same (true) or
index 5f6fde7b10a4daf1d50ea162fc0f4ab75477af36..62b44b7783bdf763ab1c902118977ca5dd8e5522 100644 (file)
@@ -1420,7 +1420,7 @@ get_intermediate_points_on_line (const Triangulation<2, 3>::line_iterator   &lin
   offset[1]=0;
 
   //Take care for periodic conditions & negative angles, see
-  //get_new_point_on_line() above. Because we dont have a symmetric
+  //get_new_point_on_line() above. Because we don't have a symmetric
   //interpolation (just the middle) we need to add 2*Pi to each almost zero
   //and negative angles.
   for (unsigned int i=0; i<2; i++)
@@ -1474,7 +1474,7 @@ get_intermediate_points_on_quad (const Triangulation< 2, 3 >::quad_iterator &qua
   offset[1]=0;
 
   //Take care for periodic conditions & negative angles, see
-  //get_new_point_on_line() above.  Because we dont have a symmetric
+  //get_new_point_on_line() above.  Because we don't have a symmetric
   //interpolation (just the middle) we need to add 2*Pi to each almost zero
   //and negative angles.
   for (unsigned int i=0; i<2; i++)
index 9cee6d4b1ecaceb06320d2c7390e6577b107787e..08ac98f6dfe3670fc3e3bb2242f3bca52e3c7ad9 100644 (file)
@@ -472,7 +472,7 @@ namespace PETScWrappers
       // have to count how many of the
       // entries in the sparsity pattern lie
       // in the column area we have locally,
-      // and how many arent. for this, we
+      // and how many aren't. for this, we
       // first have to know which areas are
       // ours
       size_type local_row_start = 0;
index a6363a9c61eda084ea2ea4079d77e047bda38ed4..0c60ecb0581dbfc60baa01e9a8114d5a1353080f 100644 (file)
@@ -766,7 +766,7 @@ namespace PETScWrappers
 
         /**
          * get the factored matrix F from the preconditioner context.  This
-         * routine is valid only for LU, ILU, Cholesky, and imcomplete
+         * routine is valid only for LU, ILU, Cholesky, and incomplete
          * Cholesky
          */
         ierr = PCFactorGetMatrix(solver_data->pc, &F);
index bd8eefe151e0d06c4a2c71051bfbf6daf364c918..4d8177c45067cfbff12a5ce298432dd850d1aa98 100644 (file)
@@ -720,7 +720,7 @@ namespace TrilinosWrappers
     // What follows just configures a dummy preconditioner that
     // sets up the domain and range maps, as well as the communicator.
     // It is never used as the vmult, Tvmult operations are
-    // given a custom defintion.
+    // given a custom definition.
     // Note: This is only required in order to wrap this
     // preconditioner in a LinearOperator without an exemplar
     // matrix.
index 3b7126442473eac95dde4450434f7dc4ece43197..44f22fd65cea10fa967f4be1a0db4b83f883df34 100644 (file)
@@ -2302,7 +2302,7 @@ namespace TrilinosWrappers
 
 
   // As of now, no particularly neat
-  // ouput is generated in case of
+  // output is generated in case of
   // multiple processors.
   void
   SparseMatrix::print (std::ostream &out,
index 51e788b246a041985e93625195f656491f5a7a48..7b5c3a432d09430ae0e0e07a54fbb3c7795e3bbe 100644 (file)
@@ -1006,7 +1006,7 @@ namespace TrilinosWrappers
 
 
   // As of now, no particularly neat
-  // ouput is generated in case of
+  // output is generated in case of
   // multiple processors.
   void
   SparsityPattern::print (std::ostream &out,
index 216c9eb45aeb2bedc41c251cd8a49325c1482646..6c1882c5b73a106258b7ee88ff6877fff4bd6b47 100644 (file)
@@ -319,7 +319,7 @@ namespace MGTools
     // We loop over cells and go from
     // cells to lower dimensional
     // objects. This is the only way to
-    // cope withthe fact, that an
+    // cope with the fact, that an
     // unknown number of cells may
     // share an object of dimension
     // smaller than dim-1.
index ceadc2cdb7dfd20143793f9248e9811429f13a06..fe5687f580afa327a07bffab150466e1cc115a98 100644 (file)
@@ -54,7 +54,7 @@ void concentric_disks(Triangulation<2>          &tria,
                      n_vert = (2 + nlay) * vlayer + 1,
                      n_cell = 3 + (1 + nlay) * lcells + 1; // 19
 
-  int fc = 4; // fv = 1,  f: fixed, displacement of index on the vertexes and
+  int fc = 4; // fv = 1,  f: fixed, displacement of index on the vertices and
   // cells ... inner objects
 
   // geometric information-----------------------

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.