]> https://gitweb.dealii.org/ - dealii.git/commitdiff
additional comments for Doxygen
authorGuido Kanschat <dr.guido.kanschat@gmail.com>
Sun, 13 Jul 2003 09:15:22 +0000 (09:15 +0000)
committerGuido Kanschat <dr.guido.kanschat@gmail.com>
Sun, 13 Jul 2003 09:15:22 +0000 (09:15 +0000)
git-svn-id: https://svn.dealii.org/trunk@7877 0785d39b-7218-0410-832d-ea1e28bc413d

38 files changed:
deal.II/lac/include/lac/block_matrix.h
deal.II/lac/include/lac/block_matrix_array.h
deal.II/lac/include/lac/block_sparse_matrix.h
deal.II/lac/include/lac/block_sparse_matrix_ez.h
deal.II/lac/include/lac/block_sparsity_pattern.h
deal.II/lac/include/lac/block_vector.h
deal.II/lac/include/lac/compressed_sparsity_pattern.h
deal.II/lac/include/lac/eigen.h
deal.II/lac/include/lac/filtered_matrix.h
deal.II/lac/include/lac/full_matrix.h
deal.II/lac/include/lac/matrix_lib.h
deal.II/lac/include/lac/matrix_out.h
deal.II/lac/include/lac/pointer_matrix.h
deal.II/lac/include/lac/precondition.h
deal.II/lac/include/lac/precondition_block.h
deal.II/lac/include/lac/precondition_selector.h
deal.II/lac/include/lac/schur_matrix.h
deal.II/lac/include/lac/shifted_matrix.h
deal.II/lac/include/lac/solver.h
deal.II/lac/include/lac/solver_bicgstab.h
deal.II/lac/include/lac/solver_cg.h
deal.II/lac/include/lac/solver_control.h
deal.II/lac/include/lac/solver_gmres.h
deal.II/lac/include/lac/solver_minres.h
deal.II/lac/include/lac/solver_qmrs.h
deal.II/lac/include/lac/solver_richardson.h
deal.II/lac/include/lac/solver_selector.h
deal.II/lac/include/lac/sparse_decomposition.h
deal.II/lac/include/lac/sparse_direct.h
deal.II/lac/include/lac/sparse_ilu.h
deal.II/lac/include/lac/sparse_matrix.h
deal.II/lac/include/lac/sparse_matrix_ez.h
deal.II/lac/include/lac/sparse_mic.h
deal.II/lac/include/lac/sparse_vanka.h
deal.II/lac/include/lac/sparsity_pattern.h
deal.II/lac/include/lac/swappable_vector.h
deal.II/lac/include/lac/vector.h
deal.II/lac/include/lac/vector_memory.h

index 9bd5bcecc6c7fc35ed6768e89a2a079d448b7ffc..47c43cda79107b824a2c565a4d71eb0504f30868 100644 (file)
 #include <base/smartpointer.h>
 #include <lac/block_vector.h>
 
+/*! @addtogroup Matrix2
+ *@{
+ */
+
 /**
  * A matrix with several copies of the same block on the diagonal.
  *
@@ -69,7 +73,7 @@ class BlockDiagonalMatrix : public Subscriptor
     SmartPointer<const MATRIX> matrix;
 };
 
-
+/*@}*/
 //----------------------------------------------------------------------//
 
 template <class MATRIX>
index c51fc9ef07786d38bcbe2251fe1cee3461b9cce4..2383ee10b077cc2b3a1d84c298d7e548f139ab51 100644 (file)
 template <typename> class BlockVector;
 template <typename> class Vector;
 
+/*! @addtogroup Matrix2
+ *@{
+ */
+
 
 /**
  * Block matrix composed of different single matrices.
@@ -203,6 +207,12 @@ class BlockMatrixArray : public Subscriptor
     unsigned int block_cols;
 };
 
+/*@}*/
+
+/*! @addtogroup Preconditioners
+ *@{
+ */
+
 
 /**
  * Inversion of a block-triangular matrix.
@@ -318,7 +328,7 @@ class BlockTrianglePrecondition : private BlockMatrixArray<MATRIX>
     bool backward;
 };
 
-
+/*@}*/
 //----------------------------------------------------------------------//
 
 template <class MATRIX>
index d68db16ec2c4330aee6a9f1c5379d8ff17f8de1b..af705f8eae3075d47c623936160925d4e0442a41 100644 (file)
 
 template <typename Number> class BlockVector;
 
+/*! @addtogroup Matrix1
+ *@{
+ */
+
 /**
  * Blocked sparse matrix. The behaviour of objects of this type is
  * almost as for the @p{SparseMatrix<...>} objects, with most of the
@@ -739,7 +743,7 @@ class BlockSparseMatrix : public Subscriptor
 
 
 
-
+/*@}*/
 /* ------------------------- Template functions ---------------------- */
 
 template <typename number>
index 2cff410b1787ded50f8194890910f76a2b13c351..d2e72be057aaab66f9f101d37c00d78f64fbfdad 100644 (file)
 
 template <typename Number> class BlockVector;
 
+/*! @addtogroup Matrix1
+ *@{
+ */
+
+
 /**
  * A block matrix consisting of blocks of type @p{SparseMatrixEZ}.
  *
@@ -292,7 +297,7 @@ class BlockSparseMatrixEZ : public Subscriptor
     Table<2, SparseMatrixEZ<Number> > blocks;
 };
 
-  
+/*@}*/  
 /*----------------------------------------------------------------------*/
 
 
index 527de59e91a6c0f03d3bb7f9c85ed78baad89eae..a0a1be0856b1a05fe5c8e50c49eb118b0ef609e6 100644 (file)
@@ -28,6 +28,10 @@ template <typename number> class BlockSparseMatrix;
 class BlockSparsityPattern;
 class CompressedBlockSparsityPattern;
 
+/*! @addtogroup Matrix1
+ *@{
+ */
+
 
 /**
  * This is the base class for block versions of the sparsity pattern
@@ -496,7 +500,7 @@ class CompressedBlockSparsityPattern : public BlockSparsityPatternBase<Compresse
 };
 
 
-
+/*@}*/
 /*---------------------- Template functions -----------------------------------*/
 
 
index 2da069eae754c9103431c77724b59beafacce791..03f3828bccbe6e14fa8cb4c6a8035cd6350c77f7 100644 (file)
@@ -28,6 +28,10 @@ template <typename Number>
 class BlockVector;
 
 
+/*! @addtogroup LAC
+ *@{
+ */
+
 namespace internal
 {
 
@@ -1238,7 +1242,7 @@ class BlockVector
     template <typename Number2> friend class BlockVector;
 };
 
-
+/*@}*/
 /*----------------------- Inline functions ----------------------------------*/
 
 
index e83e986bbb1b3d1102ab4056cdca54b4871b5fe3..83ee124b1968fc7e08fbed247863f5fba3f005e0 100644 (file)
@@ -23,6 +23,10 @@ template <typename number> class SparseMatrix;
 #include <vector>
 #include <set>
 
+/*! @addtogroup Matrix1
+ *@{
+ */
+
 
 /**
  * This class acts as an intermediate form of the
@@ -352,7 +356,7 @@ class CompressedSparsityPattern : public Subscriptor
     friend class SparsityPattern;
 };
 
-
+/*@}*/
 /*---------------------- Inline functions -----------------------------------*/
 
 
index cb979f41ecb9cb7f2a4a4cc0be40a14bc4eb6afa..49cc34c962705bed40397ae767a650087f68cf53 100644 (file)
 
 #include <cmath>
 
+/*!@addtogroup Solvers */
+/*@{*/
+
+//! Power method for eigenvalues.
 /**
  * Power method (von Mises).
  *
@@ -105,7 +109,7 @@ class EigenPower : private Solver<VECTOR>
     AdditionalData additional_data;
 };
 
-
+//! Inverse iteration for eigenvalues.
 /**
  * Inverse iteration (Wieland).
  *
@@ -209,6 +213,7 @@ class EigenInverse : private Solver<VECTOR>
     AdditionalData additional_data;
 };
 
+/*@}*/
 //----------------------------------------------------------------------
 
 
index d14f9f8e3f3f57925a07f3d6067d9af99a1f4534..548a87d74f3029d5cfa3513c6a1f2cf9d0f35833 100644 (file)
 template <typename number> class Vector;
 
 
+/*! @addtogroup Matrix2
+ *@{
+ */
+
 
 /**
  * This class is a wrapper for linear systems of equations with simple
@@ -567,7 +571,7 @@ class FilteredMatrix : public Subscriptor
                             const bool                   matrix_is_symmetric) const;
 };
 
-
+/*@}*/
 /*---------------------- Inline functions -----------------------------------*/
 
 
index 1c854d37e1ae7af5fe41be04fbff8f566f363e68..ad2f93748bc06505763e334a94fd1cdff8cb0fcc 100644 (file)
 template<typename number> class Vector;
 
 
+/*! @addtogroup Matrix1
+ *@{
+ */
+
 
 /**
  * Rectangular/quadratic full matrix.
@@ -746,7 +750,7 @@ class FullMatrix : public Table<2,number>
                    << " matrix dimension " << arg1);
 };
 
-
+/*@}*/
 /*-------------------------Inline functions -------------------------------*/
 
 
index 4aa5d48c10c55c96c6e2ab9fcc5e696d7d806752..04d48823c0c4c949afa65cbb2589e65af76a75c9 100644 (file)
 template<typename number> class Vector;
 template<typename number> class BlockVector;
 
+/*! @addtogroup Matrix2
+ *@{
+ */
+
+
 /**
  * Poor man's matrix product. Stores two matrices $m_1$ and $m_2$ and
  * implements matrix-vector multiplications for the product $m_1 m_2$
@@ -152,7 +157,7 @@ class MeanValueFilter : public Subscriptor
     unsigned int component;
 };
 
-
+/*@}*/
 //----------------------------------------------------------------------//
 
 template<class VECTOR>
index c6e686b29cbb864c1af555da51645fc6f5a5e9ca..3f10ce5ee11fbee67be326919b8fa8b315ce64b0 100644 (file)
 #include <lac/sparse_matrix.h>
 #include <lac/block_sparse_matrix.h>
 
+/*! @addtogroup LAC
+ *@{
+ */
+
 
 /**
  * Output a matrix in graphical form using the generic format
@@ -301,7 +305,7 @@ class MatrixOut : public DataOutInterface<2,2>
 };
 
 
-
+/*@}*/
 
 /* ---------------------- Template and inline functions ------------- */
 
index e659c9082cb41151229925c4498b472ebd7522de..04a46ef6a03a2d566f65481bf5ba13f5288e417a 100644 (file)
@@ -7,6 +7,10 @@
 #include <base/smartpointer.h>
 #include <lac/vector_memory.h>
 
+/*! @addtogroup Matrix2
+ *@{
+ */
+
 /**
  * Abstract class for use in iterations.  This class provides the
  * interface required by LAC solver classes. It allows to use
@@ -142,7 +146,7 @@ private:
   SmartPointer<const MATRIX> m;
 };
 
-
+/*@}*/
 //----------------------------------------------------------------------//
 
 template<class VECTOR>
index 7259f27fce28e484316b967cb404f6e3c962efd8..23b51700654f65bf87956d04c034caf3fa44c208 100644 (file)
 template <typename number> class Vector;
 template <typename number> class SparseMatrix;
 
+/*! @addtogroup Preconditioners
+ *@{
+ */
+
 
 /**
  * No preconditioning.  This class helps you, if you want to use a
@@ -597,7 +601,7 @@ class PreconditionedMatrix : public Subscriptor
 
 
     
-
+/*@}*/
 /* ---------------------------------- Inline functions ------------------- */
 
 template<class VECTOR>
index 7653360443b5bad45d7cf8a4384fd04db290186b..86fd63a54027d47265aa41f8f17791b2071fe38f 100644 (file)
 template <typename number> class FullMatrix;
 template <typename number> class Vector;
 
+/*! @addtogroup Preconditioners
+ *@{
+ */
+
 
 /**
  * Base class for @p{PreconditionBlockJacobi},
@@ -691,6 +695,7 @@ class PreconditionBlockSSOR : public virtual Subscriptor,
     void Tvmult (Vector<number2>&, const Vector<number2>&) const;
 };
 
+/*@}*/
 //----------------------------------------------------------------------//
 
 template<class MATRIX, typename inverse_type>
index 3e301092c75a325ccfa33e43dd7135a0710fcab5..ad675d6fd5196e3f7c1f1ba9240cb1a408ec0038 100644 (file)
@@ -22,6 +22,10 @@ template <class number> class Vector;
 template <class number> class SparseMatrix;
 
 
+/*! @addtogroup Preconditioners
+ *@{
+ */
+
 /**
  * Selects the preconditioner. The constructor of this class takes 
  * the name of the preconditioning and the damping parameter 
@@ -152,7 +156,7 @@ class PreconditionSelector : public Subscriptor
     const typename Vector::value_type omega;
 };
 
-
+/*@}*/
 /* --------------------- Inline and template functions ------------------- */
 
 
index eca0d80043be46d3d2737fe035afabbcc561c8a3..06c066690a6d04ce92f9c332bd8fd43337116c5e 100644 (file)
 
 
 
+/*! @addtogroup Matrix2
+ *@{
+ */
+
 /**
  * Schur complement of a block matrix.
  *
@@ -208,6 +212,9 @@ class SchurMatrix :
   unsigned int debug;
 };
 
+/*@}*/
+//----------------------------------------------------------------------//
+
 template <class MA_inverse, class MB, class MDt, class MC>
 SchurMatrix<MA_inverse, MB, MDt, MC>
 ::SchurMatrix(const MA_inverse& Ainv,
index 4f045ac4873a4db7ca7941ec6a5620d01ef1da5b..16535b84220e9fa2baabac9e2bf42acc9490ba5f 100644 (file)
 #include <base/config.h>
 #include <base/smartpointer.h>
 
+/*! @addtogroup Matrix2
+ *@{
+ */
+
 /**
  * Matrix with shifted diagonal values.
  *
@@ -138,7 +142,7 @@ class ShiftedMatrixGeneralized
 };
     
 
-
+/*@}*/
 //----------------------------------------------------------------------//
 
 template <class MATRIX>
index 9a1782175cae4999c865da4b32615591a2ec596d..71fdba9b180b7222bfc1ca614caac3ff5d9ed84b 100644 (file)
@@ -20,12 +20,13 @@ template <typename number> class Vector;
 template <class VECTOR>    class VectorMemory;
 class SolverControl;
 
+/*!@addtogroup Solvers */
+/*@{*/
 
+//! Base class for iterative solvers.
 /**
- * Base class for iterative solvers.  This class defines possible
- * return states of linear solvers and provides interfaces to a memory
- * pool and the control object.
- *
+ * This class defines possible return states of linear solvers and
+ * provides interfaces to a memory pool and the control object.
  *
  * @sect3{Requirements for template classes}
  *
@@ -174,7 +175,7 @@ class Solver : public Subscriptor
     VectorMemory<VECTOR> &memory;
 };
 
-
+/*@}*/
 /*-------------------------------- Inline functions ------------------------*/
 
 template <class VECTOR>
index 9a646c07a3458a1517aaa2e2978c4f51acd6670e..c117b202ec1c16f8e4c3f0a5cf2d59995633e054 100644 (file)
 #include <lac/solver_control.h>
 #include <cmath>
 #include <base/subscriptor.h>
+
+/*!@addtogroup Solvers */
+/*@{*/
+
+//! Iterative solver Bicg-stab.
 /**
  * Bicgstab algorithm by van der Vorst.
  *
@@ -226,6 +231,7 @@ class SolverBicgstab : public Solver<VECTOR>
   
 };
 
+/*@}*/
 /*-------------------------Inline functions -------------------------------*/
 
 template<class VECTOR>
index 9590545a12bed6940442b9ce17f1b708f80978eb..0ebee15b0f5562ddd01829eddf2c5826cdb216cb 100644 (file)
 #include <base/subscriptor.h>
 #include <cmath>
 
+/*!@addtogroup Solvers */
+/*@{*/
 
+//! Conjugate gradient method for symmetric positive definite matrices.
 /**
  * Preconditioned cg method.
  *
@@ -166,6 +169,7 @@ class SolverCG : public Solver<VECTOR>
     AdditionalData additional_data;
 };
 
+/*@}*/
 
 /*------------------------- Implementation ----------------------------*/
 
@@ -318,5 +322,4 @@ SolverCG<VECTOR>::solve (const MATRIX         &A,
                                   // otherwise exit as normal
 }
 
-
 #endif
index 12bfbf2d8e56bdd3a4aca8258701660c8912addd..1f70b3fc09f88087aeedd2f3ac8ee60c504b02ea 100644 (file)
 
 class ParameterHandler;
 
+/*!@addtogroup Solvers */
+/*@{*/
 
+//! Control of the stopping criterion for solvers
 /**
  * Control class for iterative solvers.
  *
@@ -356,7 +359,7 @@ class SolverControl : public Subscriptor
     bool         m_log_result;
 };
 
-
+//! Control of the stopping criterion depending on the initial residual.
 /**
  * Specialization of @p{SolverControl} which returns @p{success} if either
  * the specified tolerance is achieved or if the initial residual (or
@@ -448,6 +451,7 @@ class ReductionControl : public SolverControl
     double reduced_tol;
 };
 
+/*@}*/
 //------------------------------------------------------------//
 
 
index 3f189b14d1efa14fc7086c7ec3bdf2e17df1c087..ffa77bc04cb49c5b31100d10f70409b9c2dde82f 100644 (file)
@@ -26,6 +26,8 @@
 #include <vector>
 #include <cmath>
 
+/*!@addtogroup Solvers */
+/*@{*/
 
 namespace internal
 {
@@ -109,7 +111,7 @@ namespace internal
   }
 }
 
-
+//! Generalized minimal residual method.
 /**
  * Implementation of the Restarted Preconditioned Direct Generalized
  * Minimal Residual Method. The stopping criterion is the norm of the
@@ -287,7 +289,7 @@ class SolverGMRES : public Solver<VECTOR>
     SolverGMRES (const SolverGMRES<VECTOR>&);
 };
 
-
+//! Generalized minimal residual method with flexible preconditioning.
 /**
  * Flexible GMRES.
  *
@@ -367,6 +369,7 @@ class SolverFGMRES : public Solver<VECTOR>
     FullMatrix<double> H1;
 };
 
+/*@}*/
 /* --------------------- Inline and template functions ------------------- */
 
 
index 5dc2e8308318b6a2a9b34205156581d2d58171c3..c590b7b4eb51584d0dd6aaa9a9894be998336a9f 100644 (file)
 #include <cmath>
 #include <base/subscriptor.h>
 
+/*!@addtogroup Solvers */
+/*@{*/
 
+//! Minimal residual method for symmetric matrices.
 /**
  * Preconditioned MinRes method.
  *
@@ -137,7 +140,7 @@ class SolverMinRes : public Solver<VECTOR>
     double res2;
 };
 
-
+/*@}*/
 /*------------------------- Implementation ----------------------------*/
 
 
index 9f0de9433647ce5f41e8e77d056bf0f81515079c..0ade9497c837a96c81294573fa071b533f4302b9 100644 (file)
 
 #include <cmath>
 
+/*!@addtogroup Solvers */
+/*@{*/
 
+//! Quasi-minimal residual method for symmetric matrices.
 /**
  * QMRS method.
  *
@@ -191,7 +194,7 @@ class SolverQMRS : public Solver<VECTOR>
     unsigned int step;
 };
 
-
+/*@}*/
 /*------------------------- Implementation ----------------------------*/
 
 
index 794cffa84d5fc30ada740f2fb8d6375a81045f41..603ebf47160fc3a9eb6605cf0f7a9f4080a2a016 100644 (file)
 #include <lac/solver_control.h>
 #include <base/subscriptor.h>
 
+/*!@addtogroup Solvers */
+/*@{*/
+
+//! Richardson's or stationary iteration.
 /**
  * Implementation of the richardson iteration method. The stopping criterion
  * is the norm of the residual.
@@ -162,7 +166,7 @@ class SolverRichardson : public Solver<VECTOR>
     typename VECTOR::value_type res;
 };
 
-
+/*@}*/
 /*----------------- Implementation of the Richardson Method ------------------*/
 
 
index 34663e639e50b2039f67b49d47eeb336fc0d5dbd..298b4c0dc3a06bbb53ef58369fc8594cee95d2bc 100644 (file)
 #include <lac/precondition.h>
 
 
+/*!@addtogroup Solvers */
+/*@{*/
+
+//! Selects a solver by changing a parameter.
 /**
  * By calling the @p{solve} function of this @p{SolverSelector}, it selects
  * the @p{solve} function of that @p{Solver} that was specified in the constructor
@@ -200,7 +204,7 @@ class SolverSelector : public Subscriptor
     typename SolverGMRES<VECTOR>::AdditionalData gmres_data;
 };
 
-
+/*@}*/
 /* --------------------- Inline and template functions ------------------- */
 
 
index 86224dbb88105af80b8406b031f070ef8470d878..fbccde398c0e1b743ffa6310dcfba54cd0a13253 100644 (file)
@@ -1,5 +1,5 @@
 //----------------------  sparse_decomposition.h  ---------------------------
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003
 //    by the deal.II authors and Stephen "Cheffo" Kolaroff
 //
 //    This file is subject to QPL and may not be  distributed
 
 #include <cmath>
 
+/*! @addtogroup LAC
+ *@{
+ */
+
 /**
  * Abstract base class for sparse LU decompositions of a sparse matrix
  * into another sparse matrix.
@@ -435,7 +439,8 @@ class SparseLUDecomposition : protected SparseMatrix<number>,
     SparsityPattern *own_sparsity;
 };
 
-
+/*@}*/
+//----------------------------------------------------------------------//
 
 template <typename number>
 inline number
index f49e88472834c6c625b1ae893ef0e05ef827efb6..7c743e5fbab63c5a31a92ca7e0b79a5553d41dca 100644 (file)
 
 
 
+/*! @addtogroup LAC
+ *@{
+ */
+
 /**
  * This class provides an interface to the sparse direct solver MA27
  * from the Harwell Subroutine Library. MA27 is a direct solver
@@ -972,7 +976,7 @@ class SparseDirectMA47 : public Subscriptor
                       const unsigned int *ICNTL);
 };
 
-
+/*@}*/
 
 
 #endif
index 78fc47993c15b325d754663a50f4b12ffa6bace0..a5aef6f077134db0d8142a9c539458837ab9df45 100644 (file)
@@ -1,5 +1,5 @@
 //----------------------------  sparse_ilu.h  ---------------------------
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003
 //    by the deal.II authors and Stephen "Cheffo" Kolaroff
 //
 //    This file is subject to QPL and may not be  distributed
 #include <lac/sparse_decomposition.h>
 
 
+/*! @addtogroup LAC
+ *@{
+ */
+
 /**
  * Incomplete LU decomposition of a sparse matrix into another sparse matrix.
  * A given matrix is decomposed into a incomplete LU factorization, where
@@ -188,7 +192,8 @@ class SparseILU : public SparseLUDecomposition<number>
                    << " is not greater or equal than zero!");
 };
 
-
+/*@}*/
+//----------------------------------------------------------------------//
 
 template <typename number>
 template <typename somenumber>
index 24f4408e7d8fbc8b0b7849e35aa835ab1cb0c462..88bff5170241664710060f62db4b51b73fb509c0 100644 (file)
 template<typename number> class Vector;
 template<typename number> class FullMatrix;
 
+/*! @addtogroup Matrix1
+ *@{
+ */
+
 /**
  * Sparse matrix.
  *
@@ -1200,7 +1204,7 @@ class SparseMatrix : public virtual Subscriptor
     template <typename somenumber> friend class SparseMatrix;
 };
 
-
+/*@}*/
 /*---------------------- Inline functions -----------------------------------*/
 
 
index f363bb356046b46ea7e0f1f94dbd19bd73469a7a..a5a456116504e0e98eeeaa2fbdebc872122d2301 100644 (file)
 template<typename number> class Vector;
 template<typename number> class FullMatrix;
 
+/*! @addtogroup Matrix1
+ *@{
+ */
+
 /**
  * Sparse matrix without sparsity pattern.
  *
@@ -1091,7 +1095,7 @@ class SparseMatrixEZ : public Subscriptor
 #endif
 };
 
-
+/*@}*/
 /*---------------------- Inline functions -----------------------------------*/
 
 template <typename number>
index f5b7c345880c9805f140b9e5737d4bd29acda29e..20f51f8e291bb92ed242931442ea742f8110f374 100644 (file)
@@ -1,5 +1,5 @@
 //----------------------------  sparse_mic.h  ---------------------------
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003
 //    by the deal.II authors and Stephen "Cheffo" Kolaroff
 //
 //    This file is subject to QPL and may not be  distributed
 #include <lac/sparse_decomposition.h>
 
 
+/*! @addtogroup Preconditioners
+ *@{
+ */
+
 /**
  * Modified incomplete Cholesky (MIC(0)) preconditioner.  This class
  * conforms to the state and usage specification in
@@ -183,6 +187,6 @@ class SparseMIC : public SparseLUDecomposition<number>
     number get_rowsum (const unsigned int row) const;
 };
 
-
+/*@}*/
 
 #endif  // __deal2__
index 88b797d0d802dcf9b9ac26d53d97de95e2a6ecdb..9bfd1d648f7e1473e3fee0eb2f8ff6da062be1f6 100644 (file)
@@ -29,6 +29,10 @@ template <typename number> class Vector;
 template <typename number> class SparseVanka;
 template <typename number> class SparseBlockVanka;
 
+/*! @addtogroup Preconditioners
+ *@{
+ */
+
 /**
  * Point-wise Vanka preconditioning.
  * This class does Vanka preconditioning  on a point-wise base.
@@ -594,5 +598,5 @@ class SparseBlockVanka : public SparseVanka<number>
                            const BlockingStrategy      blocking_strategy);
 };
 
-
+/*@}*/
 #endif
index 69ceeddf9637e320f67851fd72173e9ddcf9f13e..93ae1522f5d9a5ede0035a9aa73a65902e88a822 100644 (file)
@@ -28,6 +28,10 @@ class CompressedSparsityPattern;
 
 
 
+/*! @addtogroup Matrix1
+ *@{
+ */
+
 /**
  * Structure representing the sparsity pattern of a sparse matrix.
  * 
@@ -1039,6 +1043,7 @@ class SparsityPattern : public Subscriptor
 };
 
 
+/*@}*/
 /*---------------------- Inline functions -----------------------------------*/
 
 
index 7f4cf9687fe9ca511dd0e605ba18f55e97a25bec..f05c00140928c8f19c4eb0f7f59577cb46e0e356 100644 (file)
 #include <string>
 
 
+/*! @addtogroup LAC
+ *@{
+ */
+
 
 /**
  * This class is a wrapper to the @p{Vector} class which allows to swap
@@ -306,7 +310,7 @@ class SwappableVector : public Vector<number>
     void reload_vector (const bool set_flag);
 };
 
-
+/*@}*/
 
 /*----------------------------   swappable_vector.h     ---------------------------*/
 /* end of #ifndef __deal2__swappable_vector_h */
index ba8b2e142059d3d2699cdb1d6b96c98f10ed3f3d..c590befaad8055e7336aa82b60ea5d1317076130 100644 (file)
 #include <cstdio>
 
 
+/*! @addtogroup LAC
+ *@{
+ */
+
 /**
  * Numerical vector of data.  For this class there are different types
  * of functions available. The first type of function mesures the norm
@@ -580,7 +584,7 @@ class Vector
     template <typename Number2> friend class Vector;    
 };
 
-
+/*@}*/
 /*----------------------- Inline functions ----------------------------------*/
 
 
index 4f117b7ed9df4063cde5636796a2c49cfef79ca7..7a6f4a4f7af366663fae4d9b21dff58129053d9c 100644 (file)
 #include <vector>
 
 
+/*! @addtogroup LAC
+ *@{
+ */
+
 /**
  * Memory management for vectors. This class is used by all
  * iterative methods to allocate space for auxilliary
@@ -176,7 +180,7 @@ class GrowingVectorMemory : public VectorMemory<Vector>
 };
 
 
-
+/*@}*/
 /* --------------------- inline functions ---------------------- */
 
 

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.