From: Wolfgang Bangerth Date: Sun, 22 Jan 2006 01:39:11 +0000 (+0000) Subject: Improve documentation about instantiations X-Git-Tag: v8.0.0~12560 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=0cc93a310aa53eb12199b8e03300a9a84b7b68cb;p=dealii.git Improve documentation about instantiations git-svn-id: https://svn.dealii.org/trunk@12115 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/base/include/base/geometry_info.h b/deal.II/base/include/base/geometry_info.h index b89b5970b9..06c70d0a75 100644 --- a/deal.II/base/include/base/geometry_info.h +++ b/deal.II/base/include/base/geometry_info.h @@ -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 diff --git a/deal.II/base/include/base/quadrature.h b/deal.II/base/include/base/quadrature.h index 32e85823ff..ad317fe994 100644 --- a/deal.II/base/include/base/quadrature.h +++ b/deal.II/base/include/base/quadrature.h @@ -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 */ diff --git a/deal.II/deal.II/include/numerics/vectors.h b/deal.II/deal.II/include/numerics/vectors.h index 2a9e1fd5d7..c32620f264 100644 --- a/deal.II/deal.II/include/numerics/vectors.h +++ b/deal.II/deal.II/include/numerics/vectors.h @@ -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, Vector, BlockVector, BlockVector, see also individual functions) + * @note Instantiations for this template are provided for some vector types, + * in particular Vector<float>, Vector<double>, + * BlockVector<float>, BlockVector<double>; 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 static void interpolate (const DoFHandler &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 - * and Vector) + * @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 and + * Vector. */ template static void integrate_difference (const Mapping &mapping, diff --git a/deal.II/lac/include/lac/block_matrix_base.h b/deal.II/lac/include/lac/block_matrix_base.h index 7be4baabe7..0eea778a92 100644 --- a/deal.II/lac/include/lac/block_matrix_base.h +++ b/deal.II/lac/include/lac/block_matrix_base.h @@ -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 (@ @). + * @note Instantiations for this template are provided for @ and + * @; others can be generated in application programs (see the + * section on @ref Instantiations in the manual). + * * @author Wolfgang Bangerth, 2000, 2004 */ template diff --git a/deal.II/lac/include/lac/block_vector.h b/deal.II/lac/include/lac/block_vector.h index ca4dcfddcb..aaf5540745 100644 --- a/deal.II/lac/include/lac/block_vector.h +++ b/deal.II/lac/include/lac/block_vector.h @@ -36,7 +36,9 @@ * allocation of vectors and provides functions that are specific to the * underlying vector type. * - * @ref Instantiations : some (@ @) + * @note Instantiations for this template are provided for @ and + * @; 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 */ diff --git a/deal.II/lac/include/lac/full_matrix.h b/deal.II/lac/include/lac/full_matrix.h index e525dadc30..c9c921db3c 100644 --- a/deal.II/lac/include/lac/full_matrix.h +++ b/deal.II/lac/include/lac/full_matrix.h @@ -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 class Vector; * vector argument to functions. If there is no argument with a number * type, the matrix number type is used. * - * @ref Instantiations : some (@ @) + * @note Instantiations for this template are provided for @ and + * @; 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 */ diff --git a/deal.II/lac/include/lac/householder.h b/deal.II/lac/include/lac/householder.h index e8ea91230b..1ca3bd3171 100644 --- a/deal.II/lac/include/lac/householder.h +++ b/deal.II/lac/include/lac/householder.h @@ -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 class Vector; * compute the vector x minimizing ||Ax-b|| for a given * vector b. * - * @ref Instantiations : some (@ @) + * @note Instantiations for this template are provided for @ and + * @; others can be generated in application programs (see the + * section on @ref Instantiations in the manual). * * @author Guido Kanschat, 2005 */ diff --git a/deal.II/lac/include/lac/matrix_lib.h b/deal.II/lac/include/lac/matrix_lib.h index 4b6c2dbb2f..113fdbb487 100644 --- a/deal.II/lac/include/lac/matrix_lib.h +++ b/deal.II/lac/include/lac/matrix_lib.h @@ -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, Vector, BlockVector, BlockVector) + * @note Instantiations for this template are provided for @ and + * @; others can be generated in application programs (see the + * section on @ref Instantiations in the manual). + * * @author Guido Kanschat, 2005 */ template -class InverseMatrixRichardson - : - public Subscriptor +class InverseMatrixRichardson : public Subscriptor { public: /** diff --git a/deal.II/lac/include/lac/precondition_block.h b/deal.II/lac/include/lac/precondition_block.h index 5cbfef80ea..ea92018dee 100644 --- a/deal.II/lac/include/lac/precondition_block.h +++ b/deal.II/lac/include/lac/precondition_block.h @@ -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, SparseMatrix, double, float) + * @note Instantiations for this template are provided for @ and + * @; 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 @@ -690,7 +693,11 @@ class PreconditionBlockJacobi : public virtual Subscriptor, * arbitrarily. * * See PreconditionBlock for requirements on the matrix. - * @ref Instantiations : some (SparseMatrix, SparseMatrix, double, float) + * + * @note Instantiations for this template are provided for @ and + * @; 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 @@ -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, SparseMatrix, double, float) + * + * @note Instantiations for this template are provided for @ and + * @; others can be generated in application programs (see the + * section on @ref Instantiations in the manual). + * * @author Ralf Hartmann, Guido Kanschat, 1999, 2000 */ template diff --git a/deal.II/lac/include/lac/sparse_ilu.h b/deal.II/lac/include/lac/sparse_ilu.h index 6743edabe3..fb82c6e407 100644 --- a/deal.II/lac/include/lac/sparse_ilu.h +++ b/deal.II/lac/include/lac/sparse_ilu.h @@ -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 @@ -51,7 +51,10 @@ * Refer to SparseLUDecomposition documentation for suggested * usage and state management. * - * @ref Instantiations : some (float, double) + * @note Instantiations for this template are provided for @ and + * @; 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 */ diff --git a/deal.II/lac/include/lac/sparse_matrix.h b/deal.II/lac/include/lac/sparse_matrix.h index 7f8f547f6e..c32dd0312f 100644 --- a/deal.II/lac/include/lac/sparse_matrix.h +++ b/deal.II/lac/include/lac/sparse_matrix.h @@ -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 @ and + * @; 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 class SparseMatrix : public virtual Subscriptor diff --git a/deal.II/lac/include/lac/sparse_vanka.h b/deal.II/lac/include/lac/sparse_vanka.h index ed9fdc348b..541436c17c 100644 --- a/deal.II/lac/include/lac/sparse_vanka.h +++ b/deal.II/lac/include/lac/sparse_vanka.h @@ -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 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 @ and + * @; others can be generated in application programs (see the + * section on @ref Instantiations in the manual). + * * @author Guido Kanschat, Wolfgang Bangerth; 1999, 2000 */ template diff --git a/deal.II/lac/include/lac/swappable_vector.h b/deal.II/lac/include/lac/swappable_vector.h index dcb201827f..7424c2ec3b 100644 --- a/deal.II/lac/include/lac/swappable_vector.h +++ b/deal.II/lac/include/lac/swappable_vector.h @@ -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 @@ -41,7 +41,10 @@ * @p reload is called. If it is not available, @p reload waits until * the detached thread has loaded the data. * - * @ref Instantiations : some (@ @) + * @note Instantiations for this template are provided for @ and + * @; others can be generated in application programs (see the + * section on @ref Instantiations in the manual). + * * @author Wolfgang Bangerth, 1999, 2000 */ template diff --git a/deal.II/lac/include/lac/vector.h b/deal.II/lac/include/lac/vector.h index 630017866f..e521412141 100644 --- a/deal.II/lac/include/lac/vector.h +++ b/deal.II/lac/include/lac/vector.h @@ -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 class LAPACKFullMatrix; * @p vector (with a lowercase "v"), this class implements an element * of a vector space suitable for numerical computations. * - * @ref Instantiations : some (@ @) + * @note Instantiations for this template are provided for @ and + * @; 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