]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Improve documentation about instantiations
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 22 Jan 2006 01:39:11 +0000 (01:39 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 22 Jan 2006 01:39:11 +0000 (01:39 +0000)
git-svn-id: https://svn.dealii.org/trunk@12115 0785d39b-7218-0410-832d-ea1e28bc413d

14 files changed:
deal.II/base/include/base/geometry_info.h
deal.II/base/include/base/quadrature.h
deal.II/deal.II/include/numerics/vectors.h
deal.II/lac/include/lac/block_matrix_base.h
deal.II/lac/include/lac/block_vector.h
deal.II/lac/include/lac/full_matrix.h
deal.II/lac/include/lac/householder.h
deal.II/lac/include/lac/matrix_lib.h
deal.II/lac/include/lac/precondition_block.h
deal.II/lac/include/lac/sparse_ilu.h
deal.II/lac/include/lac/sparse_matrix.h
deal.II/lac/include/lac/sparse_vanka.h
deal.II/lac/include/lac/swappable_vector.h
deal.II/lac/include/lac/vector.h

index b89b5970b910fb4e14127e12eeefc0c7c99354c1..06c70d0a754dee4a02f4f300f79590ed5ef8911b 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -191,8 +191,11 @@ struct GeometryInfo<0>
  * This template specifies the interface to all topological structure
  * of the mesh cells.
  *
+ * @note Instantiations for this template are provided for dimensions 1,2,3,4,
+ * and there is a specialization for dim=0 (see the section on @ref
+ * Instantiations in the manual).
+ *
  * @ingroup grid geomprimitives
- * @ref Instantiations few (dim = 1,2,3,4 and a specialization for dim=0)
  * @author Wolfgang Bangerth, 1998, Ralf Hartmann, 2005
  */
 template <int dim>
index 32e85823ff65df1b3f3218d5a15af65d6cfc47e4..ad317fe994bc848142d8fb71871af7a6c2d0b446 100644 (file)
@@ -73,7 +73,8 @@
  * necessary to provide a class Point@<0@> to make the compiler
  * happy. This class also does nothing.
  *
- * @ref Instantiations few
+ * @note Instantiations for this template are provided for dimensions 1, 2,
+ * and 3 (see the section on @ref Instantiations in the manual).
  *
  * @author Wolfgang Bangerth, Guido Kanschat, 1998, 1999, 2000, 2005
  */
index 2a9e1fd5d7fa32b5b58ed2bb09c53f1cd5a63431..c32620f264b08fa4b383fca55ed6037eb0e83441 100644 (file)
@@ -296,7 +296,11 @@ class ConstraintMatrix;
  * if access to an object describing the exact form of the boundary is needed, the
  * pointer stored within the triangulation object is accessed.
  *
- * @ref Instantiations : some (Vector<float>, Vector<double>, BlockVector<float>, BlockVector<double>, see also individual functions)
+ * @note Instantiations for this template are provided for some vector types,
+ * in particular <code>Vector&lt;float&gt;, Vector&lt;double&gt;,
+ * BlockVector&lt;float&gt;, BlockVector&lt;double&gt;</code>; others can be
+ * generated in application code (see the section on @ref Instantiations in
+ * the manual).
  *
  * @ingroup numerics
  * @author Wolfgang Bangerth, Ralf Hartmann, Guido Kanschat, 1998, 1999, 2000, 2001
@@ -440,14 +444,13 @@ class VectorTools
                                      * make the result continuous
                                      * again.
                                      *
-                                     * @ref Instantiations : some (the
-                                     * standard vector types
-                                     * mentioned in the class
-                                     * documentation are
-                                     * instantiated, but only the
-                                     * same vector for InVector and
-                                     * OutVector. Other combinations
-                                     * must be instantiated by hand.)
+                                     * @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.
                                      */
     template <int dim, class InVector, class OutVector>
     static void interpolate (const DoFHandler<dim>    &dof_1,
@@ -886,11 +889,13 @@ class VectorTools
                                      * See the general documentation of this
                                      * class for more information.
                                      *
-                                     * @ref Instantiations : some
-                                     * (InVectors as in the
-                                     * documentation of the class,
-                                     * OutVector only Vector<double>
-                                     * and Vector<float>)
+                                     * @note 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
+                                     * Vector<float>.
                                      */
     template <int dim, class InVector, class OutVector>
     static void integrate_difference (const Mapping<dim>    &mapping,
index 7be4baabe747878cbef6aeaebc7ab71f5e8f3c49..0eea778a9239e10f0028f71c99f3619aa3a49a24 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2004, 2005 by the deal.II authors
+//    Copyright (C) 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -274,7 +274,10 @@ namespace internal
  * you attempt anyway, you will likely get a number of compiler
  * errors.
  *
- * @ref Instantiations : some (<tt>@<float@> @<double@></tt>).
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
+ *
  * @author Wolfgang Bangerth, 2000, 2004
  */
 template <typename MatrixType>
index ca4dcfddcb0d650a4550f12c5d547463b1c66939..aaf5540745699c1d8afecf058496c8b128696483 100644 (file)
@@ -36,7 +36,9 @@
  * allocation of vectors and provides functions that are specific to the
  * underlying vector type.
  *
- * @ref Instantiations : some (<tt>@<float@> @<double@></tt>)
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
  *
  * @author Wolfgang Bangerth, Guido Kanschat, 1999, 2000, 2001, 2002, 2004
  */
index e525dadc30f0699ee1a5017807d54d0df279254f..c9c921db3c6f01427bfd177a87e4bbb93a6bd8f1 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -46,7 +46,9 @@ template<typename number> class Vector;
  * vector argument to functions. If there is no argument with a number
  * type, the matrix number type is used.
  *
- * @ref Instantiations : some (<tt>@<float@> @<double@></tt>)
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
  *
  * @author Guido Kanschat, Franz-Theo Suttmeier, Wolfgang Bangerth, 1993-2004
  */
index e8ea91230bd6d24dbc295e601478ae33dc3a6223..1ca3bd31710a63fc8ce1b0e9199b85fbba83cbb8 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2005 by the deal.II authors
+//    Copyright (C) 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -38,7 +38,9 @@ template<typename number> class Vector;
  * compute the vector <i>x</i> minimizing <i>||Ax-b||</i> for a given
  * vector <i>b</i>.
  *
- * @ref Instantiations : some (<tt>@<float@> @<double@></tt>)
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
  *
  * @author Guido Kanschat, 2005
  */
index 4b6c2dbb2f287b78d30e081bee0b165c90b9c58b..113fdbb4873239aca15671bd410c3f686025e4d0 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2002, 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -347,13 +347,14 @@ class MeanValueFilter : public Subscriptor
  * vmult_add() and Tvmult_add() start the iteration with a zero
  * vector.
  *
- * @ref Instantiations : some (Vector<float>, Vector<double>, BlockVector<float>, BlockVector<double>)
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
+ * 
  * @author Guido Kanschat, 2005
  */
 template<class VECTOR>
-class InverseMatrixRichardson
-  :
-  public Subscriptor
+class InverseMatrixRichardson : public Subscriptor
 {
   public:
                                     /**
index 5cbfef80ea31508636ebf0f5031615a2fff2d924..ea92018deed39baa45bf6edf7726754f42799d82 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -406,7 +406,10 @@ class PreconditionBlock : public virtual Subscriptor
  * Block Jacobi preconditioning.
  * See PreconditionBlock for requirements on the matrix.
  *
- * @ref Instantiations : some (SparseMatrix<double>, SparseMatrix<float>, <tt>double</tt>, <tt>float</tt>)
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
+ * 
  * @author Ralf Hartmann, Guido Kanschat, 1999, 2000, 2003
  */
 template<class MATRIX, typename inverse_type = typename MATRIX::value_type>
@@ -690,7 +693,11 @@ class PreconditionBlockJacobi : public virtual Subscriptor,
  * arbitrarily.
  *
  * See PreconditionBlock for requirements on the matrix.
- * @ref Instantiations : some (SparseMatrix<double>, SparseMatrix<float>, <tt>double</tt>, <tt>float</tt>)
+ * 
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
+ * 
  * @author Ralf Hartmann, Guido Kanschat, 1999, 2000, 2001, 2002, 2003
  */
 template<class MATRIX, typename inverse_type = typename MATRIX::value_type>
@@ -846,7 +853,11 @@ class PreconditionBlockSOR : public virtual Subscriptor,
  * class requires storage of the diagonal blocks and their inverses.
  *
  * See PreconditionBlock for requirements on the matrix.
- * @ref Instantiations : some (SparseMatrix<double>, SparseMatrix<float>, <tt>double</tt>, <tt>float</tt>)
+ * 
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
+ * 
  * @author Ralf Hartmann, Guido Kanschat, 1999, 2000
  */
 template<class MATRIX, typename inverse_type = typename MATRIX::value_type>
index 6743edabe3f6107e9d5dedf14f4d67fd80fda5e5..fb82c6e407f130aab0e204a77b44a2f693e52691 100644 (file)
@@ -1,5 +1,5 @@
 //---------------------------------------------------------------------------
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //    by the deal.II authors and Stephen "Cheffo" Kolaroff
 //
 //    This file is subject to QPL and may not be  distributed
  * Refer to SparseLUDecomposition documentation for suggested
  * usage and state management.
  *
- * @ref Instantiations : some (float, double)
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
+ * 
  * @author Wolfgang Bangerth, 1999, based on a similar implementation
  * by Malte Braack; unified interface: Ralf Hartmann
  */
index 7f8f547f6ec29464d029bb133198a043fdd686e6..c32dd0312fbab4b08894c788e8ab6f6a3b654389 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -446,9 +446,11 @@ namespace internals
  * importantly one can associate more than one matrix with the same
  * sparsity pattern.
  *
- * @ref Instantiations some
- * @author several, 1994-2004
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
+ *
+ * @author Essentially everyone who has ever worked on deal.II, 1994-2004
  */
 template <typename number>
 class SparseMatrix : public virtual Subscriptor
index ed9fdc348b36f16867c123ba6311fe27163744b1..541436c17c94aebad8a9f67f23a9b45c66fb09c5 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -118,7 +118,10 @@ template <typename number> class SparseBlockVanka;
  * whether this might pose some problems in the inversion of the local matrices.
  * Maybe someone would like to check this.
  *
- * @ref Instantiations : some (float, double)
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
+ * 
  * @author Guido Kanschat, Wolfgang Bangerth; 1999, 2000
  */
 template<typename number>
index dcb201827f0b03def57c4c0db8c86103ff2b6c04..7424c2ec3bfc87430239d7087bfbcc53ffa20c22 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
  * @p reload is called. If it is not available, @p reload waits until
  * the detached thread has loaded the data.
  *
- * @ref Instantiations : some (<tt>@<float@> @<double@></tt>)
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
+ * 
  * @author Wolfgang Bangerth, 1999, 2000
  */
 template <typename number>
index 630017866f75160e9f658121000f2162d9af6f79..e5214121410b4e1ae2ca415ffcbb87f0be6134a8 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -48,7 +48,10 @@ template<typename number> class LAPACKFullMatrix;
  * @p vector (with a lowercase "v"), this class implements an element
  * of a vector space suitable for numerical computations.
  *
- * @ref Instantiations : some (<tt>@<float@> @<double@></tt>)
+ * @note Instantiations for this template are provided for <tt>@<float@> and
+ * @<double@></tt>; others can be generated in application programs (see the
+ * section on @ref Instantiations in the manual).
+ * 
  * @author Guido Kanschat, Franz-Theo Suttmeier, Wolfgang Bangerth
  */
 template <typename Number>

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.