From d007f0898575d18be497aa71ea07870e454e2594 Mon Sep 17 00:00:00 2001 From: wolf Date: Mon, 24 Sep 2001 08:15:00 +0000 Subject: [PATCH] Fix spelling. git-svn-id: https://svn.dealii.org/trunk@5031 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/base/include/base/memory_consumption.h | 4 ++-- deal.II/base/include/base/quadrature_lib.h | 4 ++-- deal.II/base/source/data_out_base.cc | 4 ++-- deal.II/base/source/quadrature_lib.cc | 2 +- deal.II/deal.II/include/dofs/dof_constraints.h | 6 +++--- deal.II/deal.II/include/dofs/dof_levels.h | 2 +- deal.II/deal.II/include/dofs/dof_tools.h | 2 +- deal.II/deal.II/include/fe/fe_base.h | 6 +++--- deal.II/deal.II/include/fe/fe_q.h | 2 +- deal.II/deal.II/include/fe/fe_values.h | 2 +- deal.II/deal.II/include/grid/grid_out.h | 10 +++++----- deal.II/deal.II/include/grid/intergrid_map.h | 2 +- deal.II/deal.II/include/grid/tria.h | 6 +++--- deal.II/deal.II/include/grid/tria_hex.h | 2 +- deal.II/deal.II/include/grid/tria_iterator.h | 2 +- deal.II/deal.II/include/grid/tria_levels.h | 2 +- deal.II/deal.II/include/grid/tria_line.h | 2 +- deal.II/deal.II/include/grid/tria_quad.h | 2 +- deal.II/deal.II/include/numerics/error_estimator.h | 2 +- deal.II/deal.II/include/numerics/time_dependent.h | 2 +- deal.II/deal.II/source/dofs/dof_tools.cc | 2 +- deal.II/deal.II/source/grid/tria.cc | 2 +- deal.II/deal.II/source/multigrid/mg_dof_handler.cc | 2 +- 23 files changed, 36 insertions(+), 36 deletions(-) diff --git a/deal.II/base/include/base/memory_consumption.h b/deal.II/base/include/base/memory_consumption.h index 9d6a7cbdb2..bf3df8b913 100644 --- a/deal.II/base/include/base/memory_consumption.h +++ b/deal.II/base/include/base/memory_consumption.h @@ -60,7 +60,7 @@ * if we call @p{memory_consumption(v)} on a vector @p{v} of type * @p{FullMatrix}, 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 diff --git a/deal.II/base/include/base/quadrature_lib.h b/deal.II/base/include/base/quadrature_lib.h index 1eaba9a371..caed94a754 100644 --- a/deal.II/base/include/base/quadrature_lib.h +++ b/deal.II/base/include/base/quadrature_lib.h @@ -105,7 +105,7 @@ class QGauss5 : public Quadrature /** * 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 /** * 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. diff --git a/deal.II/base/source/data_out_base.cc b/deal.II/base/source/data_out_base.cc index 7805e8f280..4552c8247d 100644 --- a/deal.II/base/source/data_out_base.cc +++ b/deal.II/base/source/data_out_base.cc @@ -1769,7 +1769,7 @@ void DataOutBase::write_gmv (const typename std::vector > &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 > &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 diff --git a/deal.II/base/source/quadrature_lib.cc b/deal.II/base/source/quadrature_lib.cc index 0ff5a169f2..4307396667 100644 --- a/deal.II/base/source/quadrature_lib.cc +++ b/deal.II/base/source/quadrature_lib.cc @@ -409,7 +409,7 @@ QWeddle::QWeddle () : Quadrature (QWeddle(), QWeddle<1>()){}; -// explicite specialization +// explicit specialization // note that 1d formulae are specialized by implementation above template class QGauss<2>; template class QGauss2<2>; diff --git a/deal.II/deal.II/include/dofs/dof_constraints.h b/deal.II/deal.II/include/dofs/dof_constraints.h index e125261517..39bf590468 100644 --- a/deal.II/deal.II/include/dofs/dof_constraints.h +++ b/deal.II/deal.II/include/dofs/dof_constraints.h @@ -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; diff --git a/deal.II/deal.II/include/dofs/dof_levels.h b/deal.II/deal.II/include/dofs/dof_levels.h index 1cb6c30f06..ce0fd43a79 100644 --- a/deal.II/deal.II/include/dofs/dof_levels.h +++ b/deal.II/deal.II/include/dofs/dof_levels.h @@ -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 */ diff --git a/deal.II/deal.II/include/dofs/dof_tools.h b/deal.II/deal.II/include/dofs/dof_tools.h index af78450873..1ff0234e7d 100644 --- a/deal.II/deal.II/include/dofs/dof_tools.h +++ b/deal.II/deal.II/include/dofs/dof_tools.h @@ -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 diff --git a/deal.II/deal.II/include/fe/fe_base.h b/deal.II/deal.II/include/fe/fe_base.h index aa533bd5b3..a507158cbb 100644 --- a/deal.II/deal.II/include/fe/fe_base.h +++ b/deal.II/deal.II/include/fe/fe_base.h @@ -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 &) 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} class which is explicitely + * into the @p{FiniteElementData} 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 &fe_data, diff --git a/deal.II/deal.II/include/fe/fe_q.h b/deal.II/deal.II/include/fe/fe_q.h index 02e892b418..1a2b78d769 100644 --- a/deal.II/deal.II/include/fe/fe_q.h +++ b/deal.II/deal.II/include/fe/fe_q.h @@ -70,7 +70,7 @@ template 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} diff --git a/deal.II/deal.II/include/fe/fe_values.h b/deal.II/deal.II/include/fe/fe_values.h index 643b65b243..b06266a74b 100644 --- a/deal.II/deal.II/include/fe/fe_values.h +++ b/deal.II/deal.II/include/fe/fe_values.h @@ -638,7 +638,7 @@ class FEValuesBase : protected FEValuesData * @p{MappingQ1} object. Needed * by constructors of derived * classes that uses - * @p{MappingQ1} implicitely. + * @p{MappingQ1} implicitly. */ static const Mapping &get_default_mapping(); }; diff --git a/deal.II/deal.II/include/grid/grid_out.h b/deal.II/deal.II/include/grid/grid_out.h index 13073c1bef..0bf691fd16 100644 --- a/deal.II/deal.II/include/grid/grid_out.h +++ b/deal.II/deal.II/include/grid/grid_out.h @@ -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 diff --git a/deal.II/deal.II/include/grid/intergrid_map.h b/deal.II/deal.II/include/grid/intergrid_map.h index fd9e166205..940b56ba4b 100644 --- a/deal.II/deal.II/include/grid/intergrid_map.h +++ b/deal.II/deal.II/include/grid/intergrid_map.h @@ -98,7 +98,7 @@ * @end{verbatim} * * Note that the template parameters to this class have to be given as - * @p{InterGridMap}, i.e. the dimension is given explicitely and + * @p{InterGridMap}, 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}). * diff --git a/deal.II/deal.II/include/grid/tria.h b/deal.II/deal.II/include/grid/tria.h index bd3c02d331..538b62eb08 100644 --- a/deal.II/deal.II/include/grid/tria.h +++ b/deal.II/deal.II/include/grid/tria.h @@ -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 diff --git a/deal.II/deal.II/include/grid/tria_hex.h b/deal.II/deal.II/include/grid/tria_hex.h index 887ff5799b..df8e4fbe25 100644 --- a/deal.II/deal.II/include/grid/tria_hex.h +++ b/deal.II/deal.II/include/grid/tria_hex.h @@ -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. * diff --git a/deal.II/deal.II/include/grid/tria_iterator.h b/deal.II/deal.II/include/grid/tria_iterator.h index 57e89eb0ae..664346c4dc 100644 --- a/deal.II/deal.II/include/grid/tria_iterator.h +++ b/deal.II/deal.II/include/grid/tria_iterator.h @@ -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 diff --git a/deal.II/deal.II/include/grid/tria_levels.h b/deal.II/deal.II/include/grid/tria_levels.h index 8ab682c267..4c3c454c47 100644 --- a/deal.II/deal.II/include/grid/tria_levels.h +++ b/deal.II/deal.II/include/grid/tria_levels.h @@ -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 diff --git a/deal.II/deal.II/include/grid/tria_line.h b/deal.II/deal.II/include/grid/tria_line.h index 732e1ecbf5..b83c1c2e34 100644 --- a/deal.II/deal.II/include/grid/tria_line.h +++ b/deal.II/deal.II/include/grid/tria_line.h @@ -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 diff --git a/deal.II/deal.II/include/grid/tria_quad.h b/deal.II/deal.II/include/grid/tria_quad.h index 9857c00d63..50760367af 100644 --- a/deal.II/deal.II/include/grid/tria_quad.h +++ b/deal.II/deal.II/include/grid/tria_quad.h @@ -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. * diff --git a/deal.II/deal.II/include/numerics/error_estimator.h b/deal.II/deal.II/include/numerics/error_estimator.h index b47832769f..90e5fd6994 100644 --- a/deal.II/deal.II/include/numerics/error_estimator.h +++ b/deal.II/deal.II/include/numerics/error_estimator.h @@ -174,7 +174,7 @@ template 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. * diff --git a/deal.II/deal.II/include/numerics/time_dependent.h b/deal.II/deal.II/include/numerics/time_dependent.h index 725ed2fe39..4f63701913 100644 --- a/deal.II/deal.II/include/numerics/time_dependent.h +++ b/deal.II/deal.II/include/numerics/time_dependent.h @@ -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. */ diff --git a/deal.II/deal.II/source/dofs/dof_tools.cc b/deal.II/deal.II/source/dofs/dof_tools.cc index b6850748c3..39714dfd4f 100644 --- a/deal.II/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/deal.II/source/dofs/dof_tools.cc @@ -1762,7 +1762,7 @@ DoFTools::compute_intergrid_weights_1 (const DoFHandler &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 diff --git a/deal.II/deal.II/source/grid/tria.cc b/deal.II/deal.II/source/grid/tria.cc index f1d2983dad..99f21cf5bc 100644 --- a/deal.II/deal.II/source/grid/tria.cc +++ b/deal.II/deal.II/source/grid/tria.cc @@ -6129,7 +6129,7 @@ void Triangulation::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 diff --git a/deal.II/deal.II/source/multigrid/mg_dof_handler.cc b/deal.II/deal.II/source/multigrid/mg_dof_handler.cc index 89c16a7837..d6fc4e1dc9 100644 --- a/deal.II/deal.II/source/multigrid/mg_dof_handler.cc +++ b/deal.II/deal.II/source/multigrid/mg_dof_handler.cc @@ -1762,5 +1762,5 @@ void MGDoFHandler<3>::reserve_space () { #endif -// explicite instantiations +// explicit instantiations template class MGDoFHandler; -- 2.39.5