]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Fix spelling.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 24 Sep 2001 08:15:00 +0000 (08:15 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 24 Sep 2001 08:15:00 +0000 (08:15 +0000)
git-svn-id: https://svn.dealii.org/trunk@5031 0785d39b-7218-0410-832d-ea1e28bc413d

23 files changed:
deal.II/base/include/base/memory_consumption.h
deal.II/base/include/base/quadrature_lib.h
deal.II/base/source/data_out_base.cc
deal.II/base/source/quadrature_lib.cc
deal.II/deal.II/include/dofs/dof_constraints.h
deal.II/deal.II/include/dofs/dof_levels.h
deal.II/deal.II/include/dofs/dof_tools.h
deal.II/deal.II/include/fe/fe_base.h
deal.II/deal.II/include/fe/fe_q.h
deal.II/deal.II/include/fe/fe_values.h
deal.II/deal.II/include/grid/grid_out.h
deal.II/deal.II/include/grid/intergrid_map.h
deal.II/deal.II/include/grid/tria.h
deal.II/deal.II/include/grid/tria_hex.h
deal.II/deal.II/include/grid/tria_iterator.h
deal.II/deal.II/include/grid/tria_levels.h
deal.II/deal.II/include/grid/tria_line.h
deal.II/deal.II/include/grid/tria_quad.h
deal.II/deal.II/include/numerics/error_estimator.h
deal.II/deal.II/include/numerics/time_dependent.h
deal.II/deal.II/source/dofs/dof_tools.cc
deal.II/deal.II/source/grid/tria.cc
deal.II/deal.II/source/multigrid/mg_dof_handler.cc

index 9d6a7cbdb2f08e59532c31bb1f7ffb826cdffa6c..bf3df8b9133ae5a26f39f1f521314ef9609439d5 100644 (file)
@@ -60,7 +60,7 @@
  * if we call @p{memory_consumption(v)} on a vector @p{v} of type
  * @p{FullMatrix<double>}, we first reduce this to a loop in which we
  * call @p{memory_consumption(v[i])}, and because there is no such
- * function handling this explicitely, we try to call
+ * function handling this explicitly, we try to call
  * @p{v[i].memory_consumption()}.
  *
  *
@@ -346,7 +346,7 @@ namespace MemoryConsumption
     
                                   /**
                                    * For all other types which are
-                                   * not explicitely listed: try if
+                                   * not explicitly listed: try if
                                    * there is a member function
                                    * called
                                    * @p{memory_consumption}. If
index 1eaba9a3717116c6830777de8bb3c7c735495dd1..caed94a754890555033875dc088d90f40f8928c4 100644 (file)
@@ -105,7 +105,7 @@ class QGauss5 : public Quadrature<dim>
 
 /**
  *  6-Point-Gauss quadrature formula, exact for polynomials of degree 11.
- *  I have not found explicite
+ *  We have not found explicit
  *  representations of the zeros of the Legendre functions of sixth
  *  and higher degree. If anyone finds them, please replace the existing
  *  numbers by these expressions.
@@ -125,7 +125,7 @@ class QGauss6 : public Quadrature<dim>
 
 /**
  *  7-Point-Gauss quadrature formula, exact for polynomials of degree 13.
- *  I have not found explicite
+ *  We have not found explicit
  *  representations of the zeros of the Legendre functions of sixth
  *  and higher degree. If anyone finds them, please replace the existing
  *  numbers by these expressions.
index 7805e8f28022debad62c09cb17ac3e3a4fd61ddb..4552c8247de26445b6be6919ee80169055129ab6 100644 (file)
@@ -1769,7 +1769,7 @@ void DataOutBase::write_gmv (const typename std::vector<Patch<dim,spacedim> > &p
                                   // then write data.
                                   // the '1' means: node data (as opposed
                                   // to cell data, which we do not
-                                  // support explicitely here)
+                                  // support explicitly here)
   for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
     {
       out << data_names[data_set] << " 1" << std::endl;
@@ -2099,7 +2099,7 @@ void DataOutBase::write_vtk (const typename std::vector<Patch<dim,spacedim> > &p
                                   // then write data.  the
                                   // 'POINTD_DATA' means: node data
                                   // (as opposed to cell data, which
-                                  // we do not support explicitely
+                                  // we do not support explicitly
                                   // here). all following data sets
                                   // are point data
   out << "POINT_DATA " << n_nodes
index 0ff5a169f268b3a4aede197830856bfe613eb248..4307396667c992184b09c14aebe5bda2dde081d3 100644 (file)
@@ -409,7 +409,7 @@ QWeddle<dim>::QWeddle () :
                Quadrature<dim> (QWeddle<dim-1>(), QWeddle<1>()){};
 
 
-// explicite specialization
+// explicit specialization
 // note that 1d formulae are specialized by implementation above
 template class QGauss<2>;
 template class QGauss2<2>;
index e1252615173f9d9c7aa5a30c20f4383e06bc3617..39bf590468884ab73418bc4e9a5167f5a8ce655e 100644 (file)
@@ -34,7 +34,7 @@ class BlockIndices;
  *
  * The matrix is organized in lines (rows), but only those lines are stored
  * where constraints are present. Lines where only one entry (identity) is
- * present are not stored if not explicitely inserted.
+ * present are not stored if not explicitly inserted.
  *
  * Constraint matrices are used to handle hanging nodes and other constrained
  * degrees of freedom. When building the global system matrix and the right
@@ -85,7 +85,7 @@ class BlockIndices;
  *   with zeroes in the lines subject to constraints. Additionally, the vector
  *   size is larger than in the first possibility, resulting in more memory
  *   consumption for those iterative solution methods using a larger number of
- *   auxiliary vectors (e.g. methods using explicite orthogonalization
+ *   auxiliary vectors (e.g. methods using explicit orthogonalization
  *   procedures).
  * @end{itemize}
  *
@@ -619,7 +619,7 @@ class ConstraintMatrix : public Subscriptor
                                          * Number of this line. Since only very
                                          * few lines are stored, we can not
                                          * assume a specific order and have
-                                         * to store the line number explicitely.
+                                         * to store the line number explicitly.
                                          */
        unsigned int line;
 
index 1cb6c30f063d0c1788564bcdcc0e87625e623a5c..ce0fd43a79abb78495aeafb564a8f23209fb2c36 100644 (file)
@@ -20,7 +20,7 @@
 /**
  * Store the indices of the degrees of freedom which are located on the lines.
  * Declare it to have a template parameter, but do not actually declare
- * other types than those explicitely instantiated.
+ * other types than those explicitly instantiated.
  *
  * @author Wolfgang Bangerth, 1998
  */
index af78450873379b9775a2e12626c1fc240ae6b09b..1ff0234e7d546814708d41766cf2ddf730f6a407 100644 (file)
@@ -1063,7 +1063,7 @@ class DoFTools
                                      * order in the space of points
                                      * (except for the 1d case), you
                                      * have to provide a map with an
-                                     * explicitely specified
+                                     * explicitly specified
                                      * comparator object. This
                                      * function is therefore
                                      * templetized on the comparator
index aa533bd5b3d97a628b8ae0ffa41c0b867525c4f8..a507158cbbf8631de10cb07fe9395d3d50994f30 100644 (file)
@@ -180,7 +180,7 @@ class FiniteElementData
                                     /**
                                      * Comparison operator. It is not clear to
                                      * me (WB) why we have to declare and implement
-                                     * this one explicitely.
+                                     * this one explicitly.
                                      */
 //TODO:[WB] (compiler) remove operator and let the compiler generate it as soon as it is willing to do so    
     bool operator == (const FiniteElementData<dim> &) const;
@@ -206,7 +206,7 @@ class FiniteElementData
  * The implementation of this base class is split into two parts:
  * those fields which are not common to all dimensions
  * (@p{dofs_per_quad} for example are only useful for @p{dim>=2}) are put
- * into the @p{FiniteElementData<dim>} class which is explicitely
+ * into the @p{FiniteElementData<dim>} class which is explicitly
  * specialized for all used dimensions, while those fields which may
  * be formulated in a dimension-independent way are put into the
  * present class.
@@ -402,7 +402,7 @@ class FiniteElementBase : public Subscriptor,
                                     /**
                                      * Construct an object of this type.
                                      * You have to set the
-                                     * matrices explicitely after calling
+                                     * matrices explicitly after calling
                                      * this base class' constructor.
                                      */
     FiniteElementBase (const FiniteElementData<dim> &fe_data,
index 02e892b418462421ef57c6c66f67dc23c7b49ae5..1a2b78d769c0bd4b5572431eb033855dfb8551ce 100644 (file)
@@ -70,7 +70,7 @@ template <int dim> class MappingQ;
  * numbering. However, the shape functions on a cell are renumbered
  * beginning with the shape functions whose support points are at the
  * vertices, then on the line, on the quads, and finally (for 3d) on
- * the hexes. To be explicite, these numberings are listed in the
+ * the hexes. To be explicit, these numberings are listed in the
  * following:
  *
  * @sect4{Q1 elements}
index 643b65b24368d6ba2dd943d49758bc38b579f646..b06266a74b2209a06daec71364d18059562c4e91 100644 (file)
@@ -638,7 +638,7 @@ class FEValuesBase : protected FEValuesData<dim>
                                      * @p{MappingQ1} object. Needed
                                      * by constructors of derived
                                      * classes that uses
-                                     * @p{MappingQ1} implicitely.
+                                     * @p{MappingQ1} implicitly.
                                      */
     static const Mapping<dim> &get_default_mapping();
 };
index 13073c1bef45b5615fc5f3a7a0fb1c69e647627d..0bf691fd16a44acd20c612ac79bc6104f3637594 100644 (file)
@@ -55,7 +55,7 @@ namespace GridOutFlags
       
                                       /**
                                        * When writing a mesh, write boundary
-                                       * faces explicitely if their boundary
+                                       * faces explicitly if their boundary
                                        * indicator is not the default
                                        * boundary indicator, which is zero.
                                        * This is necessary if you later
@@ -201,7 +201,7 @@ namespace GridOutFlags
                                   /**
                                    * Flags describing the details of
                                    * output for encapsulated postscript
-                                   * for all dimensions not explicitely
+                                   * for all dimensions not explicitly
                                    * specialized below. Some flags that
                                    * are common to all dimensions are
                                    * listed in the base class.
@@ -476,7 +476,7 @@ class GridOut
                                      * whether boundary faces with
                                      * non-zero boundary indicator
                                      * shall be written to the file
-                                     * explicitely. This is useful,
+                                     * explicitly. This is useful,
                                      * if you want to re-read the
                                      * grid later on, since
                                      * @p{deal.II} sets the boundary
@@ -485,7 +485,7 @@ class GridOut
                                      * same triangulation as before,
                                      * you have to specify faces
                                      * with differing boundary
-                                     * indicators explicitely, which
+                                     * indicators explicitly, which
                                      * is done by this flag.
                                      *
                                      * Names and values of further
@@ -755,7 +755,7 @@ class GridOut
                                      * Return the number of faces in the
                                      * triangulation which have a boundary
                                      * indicator not equal to zero. Only
-                                     * these faces are explicitely printed
+                                     * these faces are explicitly printed
                                      * in the @p{write_*} functions;
                                      * all faces with indicator 255 are
                                      * interior ones and an indicator with
index fd9e166205319fdefa8c46e1990a129956903f69..940b56ba4bc49440e018e8691dab7de8c85997b4 100644 (file)
@@ -98,7 +98,7 @@
  * @end{verbatim}
  *
  * Note that the template parameters to this class have to be given as
- * @p{InterGridMap<DoFHandler,2>}, i.e. the dimension is given explicitely and
+ * @p{InterGridMap<DoFHandler,2>}, i.e. the dimension is given explicitly and
  * no dimension is attributed to the first parameter, which here is
  * @ref{DoFHandler} (and could equally well be @ref{Triangulation} or @ref{MGDoFHandler}).
  *
index bd3c02d33152f2a3d532542bbcaf41449d9a0987..538b62eb08051aa2d5bf84cc8b7961127eb7e58d 100644 (file)
@@ -149,7 +149,7 @@ struct SubCellData
  *  This class implements some types which differ between the
  *  dimensions.  Declare it to have a template parameter, but do not
  *  actually declare anything concrete apart from the other classes
- *  which are explicitely instantiated ones with the same name.
+ *  which are explicitly instantiated ones with the same name.
  *
  * @author Wolfgang Bangerth, 1998
  */
@@ -779,7 +779,7 @@ struct TriaNumberCache<3> : public TriaNumberCache<2>
  *   etc.) denote all cells the material id zero. You may change that afterwards,
  *   but you should not use the material id 255. When reading a triangulation,
  *   the material id must be specified in the input file (UCD format) or is
- *   otherwise set to zero. When creating explicitely, the material id must
+ *   otherwise set to zero. When creating explicitly, the material id must
  *   be given to the creation function.
  *
  *   Regarding the boundary indicator for lines in two dimensions and quads
@@ -790,7 +790,7 @@ struct TriaNumberCache<3> : public TriaNumberCache<2>
  *   different boundary indicators to the triangulation creation function.
  *   The standard domain functions assume all faces to have boundary indicator
  *   zero, which you may change manually afterwards. When reading from a file,
- *   you have to give boundary indicators other than zero explicitely, e.g. in
+ *   you have to give boundary indicators other than zero explicitly, e.g. in
  *   UCD format by giving a list of lines with material id in the input file.
  *
  *   Lines in two dimensions and quads in three dimensions inherit their
index 887ff5799bc5c1b13a661d08ae3c511896cb6557..df8e4fbe25afedc55247188929e427338af72081 100644 (file)
@@ -23,7 +23,7 @@
  *
  *   A heaxhedron itself has one index, as far as the topological part handled in
  *   the triangulation is concerned: the index in the level
- *   it belongs to. The level index is implicitely given by the position
+ *   it belongs to. The level index is implicitly given by the position
  *   in the @p{hexes.hexes} list attached to the information of each level
  *   of the triangulation.
  *
index 57e89eb0ae00b7086ca444028b9c5f93a2799d61..664346c4dc319249a01fd3e72c9ef7db217022ea 100644 (file)
@@ -312,7 +312,7 @@ class TriaRawIterator :
                                      *  Usage is thus like @p{(*i).index ();}
                                      *
                                      *  This function has to be specialized
-                                     *  explicitely for the different
+                                     *  explicitly for the different
                                      *  @p{Pointee}s, to allow an
                                      *  @p{iterator<1,TriangulationLevel<1>::LinesData>}
                                      *  to point to @p{tria->lines.lines[index]} while
index 8ab682c267e1a96290ebbd499be4f9200497d72c..4c3c454c477bf77bd95aa32b39ac62a79b2f4838 100644 (file)
@@ -306,7 +306,7 @@ class TriangulationLevel<1> : public TriangulationLevel<0>
                                      *  append the needed elements.
                                      *  There are pendants for higher
                                      *  dimensions, which you have to call
-                                     *  explicitely (they can't hand down the
+                                     *  explicitly (they can't hand down the
                                      *  call because there is no easy relation
                                      *  between the number of new quads and
                                      *  the number of new lines, etc.). Also
index 732e1ecbf518c34e109d0dfd452f6ebb0dd52be7..b83c1c2e3449b21d740b483574a74c4457bdc41b 100644 (file)
@@ -23,7 +23,7 @@
  *
  *   A line itself has one index, as far as the topological part handled in
  *   the triangulation is concerned: the index in the level
- *   it belongs to. The level index is implicitely given by the position
+ *   it belongs to. The level index is implicitly given by the position
  *   in the @p{lines.lines} list attached to the information of each level.
  *
  *   @author Wolfgang Bangerth, 1998
index 9857c00d63eeac476df8b98853f03a3ae5ca8dbe..50760367af7c69b923a760eac8a4406e05810bfc 100644 (file)
@@ -24,7 +24,7 @@
  *
  *   A quad itself has one index, as far as the topological part handled in
  *   the triangulation is concerned: the index in the level
- *   it belongs to. The level index is implicitely given by the position
+ *   it belongs to. The level index is implicitly given by the position
  *   in the @p{quads.quads} list attached to the information of each level
  *   of the triangulation.
  *
index b47832769fda4447649ff40fcd93a03cebb5b3ac..90e5fd6994957b3ee83c4377066eea2bc6a6a653 100644 (file)
@@ -174,7 +174,7 @@ template <int dim> class FESubfaceValues;
  *  abovementioned map of integrals as well. This consumes some memory more
  *  than needed, but makes the summing up of the face contributions to the
  *  cells easier, since then we have the information from all faces of all
- *  cells at hand and need not think about explicitely determining whether
+ *  cells at hand and need not think about explicitly determining whether
  *  a face was refined or not. The same applies for boundary faces, see
  *  above.
  *
index 725ed2fe3905942c66b039aea10c1b128ee6d4a1..4f6370191364825167be3b546c623ff956d3c329 100644 (file)
@@ -594,7 +594,7 @@ class TimeDependent
                                      * function call teh given function with
                                      * the specified parameter. Note that you
                                      * need to bind the second parameter since
-                                     * the first one implicitely contains
+                                     * the first one implicitly contains
                                      * the object which the function is to
                                      * be called for.
                                      */
index b6850748c338bce3b3c6ad58da9ba680c51b9df6..39714dfd4fbcdb7e341853f3227fe92b33ba8c0c 100644 (file)
@@ -1762,7 +1762,7 @@ DoFTools::compute_intergrid_weights_1 (const DoFHandler<dim>              &coars
                                   // respective dofs of the other
                                   // components have sum of weights
                                   // zero, of course. we do not
-                                  // explicitely ask which component
+                                  // explicitly ask which component
                                   // a dof belongs to, but this at
                                   // least tests some errors
 #ifdef DEBUG
index f1d2983dad0f81e45a45fad5b6a74aa0ec958fae..99f21cf5bc895e51aa35ba40e778a418c3bcc68d 100644 (file)
@@ -6129,7 +6129,7 @@ void Triangulation<dim>::fix_coarsen_flags () {
                                   // coarsening is possible or deleted
                                   // otherwise. Coarsen flags of cells with
                                   // no mother cell, i.e. on the
-                                  // coarsest level are deleted explicitely.
+                                  // coarsest level are deleted explicitly.
   clear_user_flags ();
                                   // number of active children of @p{cell}.
                                   // number of children of @p{cell} which are
index 89c16a78378a13ed817f452c9829cd1ee6bc724c..d6fc4e1dc94f145687bdb4bee2c49cd577555933 100644 (file)
@@ -1762,5 +1762,5 @@ void MGDoFHandler<3>::reserve_space () {
 #endif
 
 
-// explicite instantiations
+// explicit instantiations
 template class MGDoFHandler<deal_II_dimension>;

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.