// $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
* 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>
* 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
*/
* 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<float>, Vector<double>,
+ * BlockVector<float>, BlockVector<double></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
* 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,
* 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,
// $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
* 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>
* 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
*/
// $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
* 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
*/
// $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
* 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
*/
// $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
* 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:
/**
// $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
* 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>
* 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>
* 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>
//---------------------------------------------------------------------------
-// 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
*/
// $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
* 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
// $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
* 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>
// $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>
// $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
* @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>