]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Refer to namespaces as namespaces, not classes. 1637/head
authorDavid Wells <wellsd2@rpi.edu>
Fri, 18 Sep 2015 18:33:36 +0000 (14:33 -0400)
committerDavid Wells <wellsd2@rpi.edu>
Fri, 18 Sep 2015 18:33:36 +0000 (14:33 -0400)
In the past, MatrixCreator, MatrixTools, and VectorTools were classes,
not namespaces. This commit updates the documentation to correctly refer
to them as namespaces.

include/deal.II/numerics/matrix_tools.h
include/deal.II/numerics/vector_tools.h

index b2f29225acdc6ca78350723b976c0e6a6b2a7b63..e2ce2c844158c90df4b93ac8c3badd11134ccd63 100644 (file)
@@ -127,8 +127,8 @@ namespace TrilinosWrappers
  * together).
  *
  * If you want to use boundary conditions with the matrices generated by the
- * functions of this class in addition to the ones in a possible constraint
- * matrix, you have to use a function like
+ * functions of this namespace in addition to the ones in a possible
+ * constraint matrix, you have to use a function like
  * <tt>ProblemBase<>::apply_dirichlet_bc</tt> to matrix and right hand side.
  *
  *
@@ -230,7 +230,7 @@ namespace MatrixCreator
    * such matrices, for example in time dependent settings such as the main
    * loop of step-26.
    *
-   * See the general doc of this class for more information.
+   * See the general documentation of this namespace for more information.
    */
   template <int dim, typename number, int spacedim>
   void create_mass_matrix (const Mapping<dim, spacedim>       &mapping,
@@ -265,7 +265,7 @@ namespace MatrixCreator
    * such matrices, for example in time dependent settings such as the main
    * loop of step-26.
    *
-   * See the general doc of this class for more information.
+   * See the general documentation of this namespace for more information.
    */
   template <int dim, typename number, int spacedim>
   void create_mass_matrix (const Mapping<dim, spacedim>   &mapping,
@@ -426,7 +426,7 @@ namespace MatrixCreator
    * such matrices, for example in time dependent settings such as the main
    * loop of step-26.
    *
-   * See the general doc of this class for more information.
+   * See the general documentation of this namespace for more information.
    */
   template <int dim, int spacedim>
   void create_laplace_matrix (const Mapping<dim, spacedim>   &mapping,
@@ -460,7 +460,7 @@ namespace MatrixCreator
    * such matrices, for example in time dependent settings such as the main
    * loop of step-26.
    *
-   * See the general doc of this class for more information.
+   * See the general documentation of this namespace for more information.
    */
   template <int dim, int spacedim>
   void create_laplace_matrix (const Mapping<dim, spacedim>   &mapping,
@@ -589,8 +589,8 @@ namespace MatrixCreator
  * the given degree of freedom and thus eliminating all coupling between this
  * degree of freedom and others. Now the respective column also consists only
  * of zeroes, apart from the main diagonal entry. Alternatively, the functions
- * in this class take a boolean parameter that allows to omit this last step,
- * if symmetry of the resulting linear system is not required. Note that
+ * in this namespace take a boolean parameter that allows to omit this last
+ * step, if symmetry of the resulting linear system is not required. Note that
  * usually even CG can cope with a non-symmetric linear system with this
  * particular structure.
  *
@@ -792,7 +792,7 @@ namespace MatrixTools
    * where the action indicated by the default value of the last argument is
    * actually not implemented; that argument has <code>true</code> as its
    * default value to stay consistent with the other functions of same name in
-   * this class.)
+   * this namespace.)
    *
    * This function is used in step-17 and step-18.
    */
@@ -867,7 +867,7 @@ namespace MatrixTools
    * situation where the action indicated by the default value of the last
    * argument is actually not implemented; that argument has <code>true</code>
    * as its default value to stay consistent with the other functions of same
-   * name in this class.)
+   * name in this namespace.)
    */
   void
   apply_boundary_values (const std::map<types::global_dof_index,double> &boundary_values,
@@ -939,7 +939,7 @@ namespace MatrixTools
    * or if access to the sparse matrix is expensive (e.g. for block sparse
    * matrices, or for PETSc or Trilinos matrices). However, it doesn't work as
    * expected if there are also hanging nodes to be considered. More caveats
-   * are listed in the general documentation of this class.
+   * are listed in the general documentation of this namespace.
    *
    * @dealiiVideoLecture{21.6,21.65}
    */
index f6377c6d0f1c9917da91907ccd9bae3df2cc97b2..5385fbfd2e4d76a40caee05d6166d8f9f98febee 100644 (file)
@@ -323,7 +323,7 @@ namespace VectorTools
 {
   /**
    * Denote which norm/integral is to be computed by the
-   * integrate_difference() function of this class. The following
+   * integrate_difference() function of this namespace. The following
    * possibilities are implemented:
    */
   enum NormType
@@ -400,7 +400,7 @@ namespace VectorTools
    * The template argument <code>DH</code> may either be of type DoFHandler or
    * hp::DoFHandler.
    *
-   * See the general documentation of this class for further information.
+   * See the general documentation of this namespace for further information.
    *
    * @todo The @p mapping argument should be replaced by a
    * hp::MappingCollection in case of a hp::DoFHandler.
@@ -432,9 +432,9 @@ namespace VectorTools
    * continuous again.
    *
    * @note Instantiations for this template are provided for some vector types
-   * (see the general documentation of the class), but only the same vector
-   * for InVector and OutVector. Other combinations must be instantiated by
-   * hand.
+   * (see the general documentation of the namespace), but only the same
+   * vector for InVector and OutVector. Other combinations must be
+   * instantiated by hand.
    */
   template <int dim, class InVector, class OutVector, int spacedim>
   void interpolate (const DoFHandler<dim,spacedim>    &dof_1,
@@ -585,7 +585,7 @@ namespace VectorTools
    * sure that the given quadrature formula is also sufficient for the
    * integration of the mass matrix.
    *
-   * See the general documentation of this class for further information.
+   * See the general documentation of this namespace for further information.
    *
    * In 1d, the default value of the boundary quadrature formula is an invalid
    * object since integration on the boundary doesn't happen in 1d.
@@ -699,7 +699,7 @@ namespace VectorTools
    * Thus, the elements in the component mask corresponding to the components
    * of these non-primitive shape functions must be @p false.
    *
-   * See the general documentation of this class for more information.
+   * See the general documentation of this namespace for more information.
    */
   template <class DH>
   void
@@ -828,7 +828,7 @@ namespace VectorTools
    * Thus, the elements in the component mask corresponding to the components
    * of these non-primitive shape functions must be @p false.
    *
-   * See the general documentation of this class for more information.
+   * See the general documentation of this namespace for more information.
    *
    * @ingroup constraints
    */
@@ -1593,7 +1593,7 @@ namespace VectorTools
    * Create a right hand side vector. Prior content of the given @p rhs_vector
    * vector is deleted.
    *
-   * See the general documentation of this class for further information.
+   * See the general documentation of this namespace for further information.
    */
   template <int dim, int spacedim>
   void create_right_hand_side (const Mapping<dim, spacedim>    &mapping,
@@ -1637,7 +1637,7 @@ namespace VectorTools
    * \delta(x-p) \phi_i(x) dx$. Prior content of the given @p rhs_vector
    * vector is deleted.
    *
-   * See the general documentation of this class for further information.
+   * See the general documentation of this namespace for further information.
    */
   template <int dim, int spacedim>
   void create_point_source_vector(const Mapping<dim,spacedim>    &mapping,
@@ -1689,7 +1689,7 @@ namespace VectorTools
    *
    * Prior content of the given @p rhs_vector vector is deleted.
    *
-   * See the general documentation of this class for further information.
+   * See the general documentation of this namespace for further information.
    */
   template <int dim, int spacedim>
   void create_point_source_vector(const Mapping<dim,spacedim>    &mapping,
@@ -1734,7 +1734,7 @@ namespace VectorTools
    * Create a right hand side vector from boundary forces. Prior content of
    * the given @p rhs_vector vector is deleted.
    *
-   * See the general documentation of this class for further information.
+   * See the general documentation of this namespace for further information.
    *
    * @see
    * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
@@ -1853,7 +1853,7 @@ namespace VectorTools
    * than NormType::Lp_norm or NormType::W1p_norm is chosen.
    *
    *
-   * See the general documentation of this class for more information.
+   * See the general documentation of this namespace for more information.
    *
    * @note If the integration here happens over the cells of a
    * parallel::distribute::Triangulation object, then this function computes
@@ -1899,8 +1899,8 @@ namespace VectorTools
    * norm of the error.
    *
    * Instantiations for this template are provided for some vector types (see
-   * the general documentation of the class), but only for InVectors as in the
-   * documentation of the class, OutVector only Vector<double> and
+   * the general documentation of the namespace), but only for InVectors as in
+   * the documentation of the namespace, OutVector only Vector<double> and
    * Vector<float>.
    */
   template <int dim, class InVector, class OutVector, int spacedim>

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.