]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
doxygen documentation
authorguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 30 Aug 2005 13:05:18 +0000 (13:05 +0000)
committerguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 30 Aug 2005 13:05:18 +0000 (13:05 +0000)
git-svn-id: https://svn.dealii.org/trunk@11343 0785d39b-7218-0410-832d-ea1e28bc413d

14 files changed:
deal.II/base/include/base/geometry_info.h
deal.II/base/include/base/path_search.h
deal.II/lac/include/lac/block_matrix_base.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/compressed_sparsity_pattern.h
deal.II/lac/include/lac/eigen.h
deal.II/lac/include/lac/filtered_matrix.h
deal.II/lac/include/lac/matrix_lib.h
deal.II/lac/include/lac/matrix_out.h
deal.II/lac/include/lac/petsc_block_sparse_matrix.h
deal.II/lac/include/lac/petsc_matrix_base.h
deal.II/lac/include/lac/petsc_parallel_block_sparse_matrix.h

index d9ee69a95f49780d6b07581f9a847a894e594c48..340e2e6c3900baea7a4f256f8d28c7544b30b29c 100644 (file)
@@ -32,7 +32,7 @@ template <int dim> class GeometryInfo;
  * This class contains as static members information on vertices and
  * faces of a @p dim-dimensional grid cell. The interface is the same
  * for all dimensions. If a value is of no use in a low dimensional
- * cell, it is (correctly) set to zero, e.g. @p subfaces_per_cell in
+ * cell, it is (correctly) set to zero, e.g. #subfaces_per_cell in
  * 1d.
  *
  * This information should always replace hard-coded numbers of
@@ -418,7 +418,7 @@ struct GeometryInfo
                                      * children, return any one of
                                      * their indices. The result is
                                      * always less than
-                                     * <tt>GeometryInfo<dimension>::children_per_cell</tt>.
+                                     * GeometryInfo<dimension>::children_per_cell.
                                      *
                                      * The order of child cells is
                                      * described the documentation of
index 3d3ca556b447bc037b3f2e380c1a814b7efd0fac..9bdc6137aba2232c0566af4e37e3675c9e95db92 100644 (file)
@@ -203,7 +203,7 @@ class PathSearch
                                     /**
                                      * Get path list for a certain
                                      * class. Used to set up
-                                     * @p my_path_list in constructor.
+                                     * #my_path_list in constructor.
                                      */
     static std::vector<std::string>& get_path_list(const std::string& cls);
     
index 9b77f141f744cb27ee3bb267a15d887fb6151955..f9d8ea21d50eab82b44cc01a27be5eff82e836bd 100644 (file)
@@ -259,16 +259,17 @@ namespace internal
  * this class.
  *
  * 
- * @ref Instantiations: some (<tt>@<float@> @<double@></tt>). Most of the
- * functions take a vector or block vector argument. These functions can, in
- * general, only successfully be compiled if the individual blocks of this
- * matrix implement the respective functions operating on the vector type in
- * question. For example, if you have a block sparse matrix over deal.II
- * SparseMatrix objects, then you will likely not be able to form the
- * matrix-vector multiplication with a block vector over
- * PETScWrappers::SparseMatrix objects. If you attempt anyway, you will likely
- * get a number of compiler errors.
+ * Most of the functions take a vector or block vector argument. These
+ * functions can, in general, only successfully be compiled if the
+ * individual blocks of this matrix implement the respective functions
+ * operating on the vector type in question. For example, if you have
+ * a block sparse matrix over deal.II SparseMatrix objects, then you
+ * will likely not be able to form the matrix-vector multiplication
+ * with a block vector over PETScWrappers::SparseMatrix objects. If
+ * you attempt anyway, you will likely get a number of compiler
+ * errors.
  *
+ * @ref Instantiations: some (<tt>@<float@> @<double@></tt>).
  * @author Wolfgang Bangerth, 2000, 2004
  */
 template <typename MatrixType>
index 6a6d1424c244ca5638bf3748cb687e2318b117fa..5a0e31aaadb8a5668cab77f20b3f4ec04fce7ed4 100644 (file)
@@ -417,7 +417,7 @@ class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix<number> >
                                      * matrix. In order to guarantee
                                      * that it is not deleted while
                                      * still in use, we subscribe to
-                                     * it using the @p SmartPointer
+                                     * it using the SmartPointer
                                      * class.
                                      */
     SmartPointer<const BlockSparsityPattern> sparsity_pattern;
index ac7b949d1b0cb346d93f52ca2d6b372cb7a26e80..12517a8141c537f9111de4c6806cd1652437f8d4 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2002, 2003, 2004 by the deal.II authors
+//    Copyright (C) 2002, 2003, 2004, 2005 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -30,11 +30,11 @@ template <typename Number> class BlockVector;
 
 
 /**
- * A block matrix consisting of blocks of type @p SparseMatrixEZ.
+ * A block matrix consisting of blocks of type SparseMatrixEZ.
  *
  * Like the other Block-objects, this matrix can be used like a
- * @p SparseMatrixEZ, when it comes to access to entries. Then, there
- * are functions for the multiplication with @p BlockVector and
+ * SparseMatrixEZ, when it comes to access to entries. Then, there
+ * are functions for the multiplication with BlockVector and
  * access to the individual blocks.
  *
  * @author Guido Kanschat, 2002, 2003
@@ -251,7 +251,7 @@ class BlockSparseMatrixEZ : public Subscriptor
                                      * let $dst = M^T*src$ with $M$
                                      * being this matrix. This
                                      * function does the same as
-                                     * @p vmult but takes the
+                                     * vmult() but takes the
                                      * transposed matrix.
                                      */
     template <typename somenumber>
@@ -273,7 +273,7 @@ class BlockSparseMatrixEZ : public Subscriptor
                                      * multiplication. Add $M^T*src$
                                      * to $dst$ with $M$ being this
                                      * matrix. This function does the
-                                     * same as @p vmult_add but takes
+                                     * same as vmult_add() but takes
                                      * the transposed matrix.
                                      */
     template <typename somenumber>
index 31aca09eb711fa6249399e6a647b921d4ab0057a..f725f685707c82cdf46d851cba72b6e29cee7390 100644 (file)
@@ -77,7 +77,7 @@ class BlockSparsityPatternBase : public Subscriptor
                                      *
                                      * This value is only an alias to
                                      * the respective value of the
-                                     * @p SparsityPattern class.
+                                     * SparsityPattern class.
                                      */
     static const unsigned int invalid_entry = SparsityPattern::invalid_entry;
     
@@ -89,7 +89,7 @@ class BlockSparsityPatternBase : public Subscriptor
                                      * member variables in other
                                      * classes. You can make the
                                      * structure usable by calling
-                                     * the @p reinit function.
+                                     * the reinit() function.
                                      */
     BlockSparsityPatternBase ();
 
@@ -98,7 +98,7 @@ class BlockSparsityPatternBase : public Subscriptor
                                      * given number of block rows and
                                      * columns. The blocks themselves
                                      * are still empty, and you have
-                                     * to call @p collect_sizes after
+                                     * to call collect_sizes() after
                                      * you assign them sizes.
                                      */
     BlockSparsityPatternBase (const unsigned int n_block_rows,
@@ -112,7 +112,7 @@ class BlockSparsityPatternBase : public Subscriptor
                                      * are no block allocated at
                                      * present. This is for the same
                                      * reason as for the
-                                     * @p SparsityPattern, see there
+                                     * SparsityPattern, see there
                                      * for the details.
                                      */
     BlockSparsityPatternBase (const BlockSparsityPatternBase &bsp);
@@ -130,10 +130,10 @@ class BlockSparsityPatternBase : public Subscriptor
                                      * unitialized ones, i.e. ones
                                      * for which also the sizes are
                                      * not yet set. You have to do
-                                     * that by calling the @p reinit
+                                     * that by calling the reinit()
                                      * functions of the blocks
                                      * themselves. Do not forget to
-                                     * call @p collect_sizes after
+                                     * call collect_sizes() after
                                      * that on this object.
                                      *
                                      * The reason that you have to
@@ -143,7 +143,7 @@ class BlockSparsityPatternBase : public Subscriptor
                                      * of elements per row may be
                                      * varying, etc. It is simpler
                                      * not to reproduce the interface
-                                     * of the @p SparsityPattern
+                                     * of the SparsityPattern
                                      * class here but rather let the
                                      * user call whatever function
                                      * she desires.
@@ -393,8 +393,8 @@ class BlockSparsityPatternBase : public Subscriptor
                                     /**
                                      * Make the block sparse matrix a
                                      * friend, so that it can use our
-                                     * @p row_indices and
-                                     * @p column_indices objects.
+                                     * #row_indices and
+                                     * #column_indices objects.
                                      */
     template <typename number>
     friend class BlockSparseMatrix;
@@ -422,7 +422,7 @@ class BlockSparsityPattern : public BlockSparsityPatternBase<SparsityPattern>
                                      * member variables in other
                                      * classes. You can make the
                                      * structure usable by calling
-                                     * the @p reinit function.
+                                     * the reinit() function.
                                      */
     BlockSparsityPattern ();
 
@@ -431,7 +431,7 @@ class BlockSparsityPattern : public BlockSparsityPatternBase<SparsityPattern>
                                      * given number of block rows and
                                      * columns. The blocks themselves
                                      * are still empty, and you have
-                                     * to call @p collect_sizes after
+                                     * to call collect_sizes() after
                                      * you assign them sizes.
                                      */
     BlockSparsityPattern (const unsigned int n_rows,
@@ -491,7 +491,7 @@ class CompressedBlockSparsityPattern : public BlockSparsityPatternBase<Compresse
                                      * member variables in other
                                      * classes. You can make the
                                      * structure usable by calling
-                                     * the @p reinit function.
+                                     * the reinit() function.
                                      */
     CompressedBlockSparsityPattern ();
 
@@ -500,7 +500,7 @@ class CompressedBlockSparsityPattern : public BlockSparsityPatternBase<Compresse
                                      * given number of block rows and
                                      * columns. The blocks themselves
                                      * are still empty, and you have
-                                     * to call @p collect_sizes after
+                                     * to call collect_sizes() after
                                      * you assign them sizes.
                                      */
     CompressedBlockSparsityPattern (const unsigned int n_rows,
index 26acdcd5a01fbc16480fe8f7e7fc22fab01bd294..1e39105964ca5b19a96f669a695de2d15b54df90 100644 (file)
@@ -52,18 +52,19 @@ template <typename number> class SparseMatrix;
  * first have to provide an empty sparsity pattern object with a fixed
  * maximal number of entries per row. To find out about this maximal
  * row length, one usually calls the function
- * DoFHandler@p ::max_couplings_per_dof which returns an
- * estimate for that quantity. While this estimate is usually quite
- * good in 2d and exact in 1d, it is often significantly too large in
- * 3d and especially for higher order elements. Furthermore, normally
- * only a small fraction of the rows of a matrix will end up having
- * the maximal number of nonzero entries per row (usually those nodes
- * adjacent to hanging nodes), most have much less. In effect, the
- * empty SparsityPattern object has allocated much too much
+ * DoFHandler::max_couplings_between_dofs() which returns an estimate for
+ * that quantity or DoFTools::compute_row_length_vector(), which gives
+ * a better estimate for each row. While this estimate is usually
+ * quite good in 2d and exact in 1d, it is often significantly too
+ * large in 3d and especially for higher order elements. Furthermore,
+ * normally only a small fraction of the rows of a matrix will end up
+ * having the maximal number of nonzero entries per row (usually those
+ * nodes adjacent to hanging nodes), most have much less. In effect,
+ * the empty SparsityPattern object has allocated much too much
  * memory. Although this unnecessarily allocated memory is later freed
- * when SparsityPattern@p ::compress is called, this
- * overallocation has, with higher order elements and in 3d, sometimes
- * been so large that the program aborted due to lack of memory.
+ * when SparsityPattern::compress() is called, this overallocation
+ * has, with higher order elements and in 3d, sometimes been so large
+ * that the program aborted due to lack of memory.
  *
  * This class therefore provides an alternative representation of a
  * sparsity pattern: we don't specify a maximal row length initially,
@@ -116,7 +117,7 @@ class CompressedSparsityPattern : public Subscriptor
                                      * member variables in other
                                      * classes. You can make the
                                      * structure usable by calling
-                                     * the @p reinit function.
+                                     * the reinit() function.
                                      */
     CompressedSparsityPattern ();
     
@@ -179,7 +180,7 @@ class CompressedSparsityPattern : public Subscriptor
                                      * data structures for a new
                                      * matrix with @p m rows and
                                      * @p n columns, with at most
-                                     * @p max_per_row nonzero
+                                     * max_entries_per_row() nonzero
                                      * entries per row.
                                      */
     void reinit (const unsigned int m,
@@ -336,7 +337,7 @@ class CompressedSparsityPattern : public Subscriptor
                                       * describing which entries of this row
                                       * are nonzero. Data is organized as
                                       * follows: if an entry is added to a
-                                      * row, it is first added to the @p cache
+                                      * row, it is first added to the #cache
                                       * variable, irrespective of whether an
                                       * entry with same column number has
                                       * already been added. Only if the cache
@@ -363,7 +364,7 @@ class CompressedSparsityPattern : public Subscriptor
                                       * Since some functions that are @p const
                                       * need to access the data of this
                                       * object, but need to flush caches
-                                      * before, the @p flush_cache function is
+                                      * before, the flush_cache() function is
                                       * marked const, and the data members are
                                       * marked @p mutable.
                                       *
@@ -399,7 +400,7 @@ class CompressedSparsityPattern : public Subscriptor
         
                                          /**
                                           * Cache of entries that have not yet
-                                          * been written to @p entries;
+                                          * been written to #entries;
                                           */
         mutable unsigned int cache[cache_size];
 
@@ -421,7 +422,7 @@ class CompressedSparsityPattern : public Subscriptor
 
                                          /**
                                           * Flush the cache my merging it with
-                                          * the @p entries array.
+                                          * the #entries array.
                                           */
         void flush_cache () const;
     };
index 9a9ff50718edad0e4b65f6ede66a6bd61037f988..d02dce016ef048d6fb94c0ea33810156c7f29469 100644 (file)
@@ -119,17 +119,17 @@ class EigenPower : private Solver<VECTOR>
  * norm of the residual $A x - l x$ is computed. Since this might not
  * converge to zero for non-symmetric matrices with non-trivial Jordan
  * blocks, it can be replaced by checking the difference of successive
- * eigenvalues. Use @p AdditionalData::use_residual for switching
+ * eigenvalues. Use AdditionalData::use_residual for switching
  * this option.
  *
  * Usually, the initial guess entering this method is updated after
  * each step, replacing it with the new approximation of the
- * eigenvalue. Using a parameter @p AdditionalData::relaxation
+ * eigenvalue. Using a parameter AdditionalData::relaxation
  * between 0 and 1, this update can be damped. With relaxation
  * parameter 0, no update is performed. This damping allows for slower
  * adaption of the shift value to make sure that the method converges
  * to the eigenvalue closest to the initial guess. This can be aided
- * by the parameter @p AdditionalData::start_adaption, which
+ * by the parameter AdditionalData::start_adaption, which
  * indicates the first iteration step in which the shift value should
  * be adapted.
  *
index b3bb4f7450c42520e2c354762c48d87d537636c3..85085f8699b1eabb82e9fcd066b4be116711b7ff 100644 (file)
@@ -101,11 +101,11 @@ template <typename number> class Vector;
  *
  * <h3>Connection to other classes</h3>
  *
- * The function @p MatrixTools::apply_boundary_values does exactly
+ * The function MatrixTools::apply_boundary_values() does exactly
  * the same that this class does, except for the fact that that
  * function actually modifies the matrix. Due to this, it is only
  * possible to solve with a matrix onto which
- * @p MatrixTools::apply_boundary_values was applied for one right
+ * MatrixTools::apply_boundary_values() was applied for one right
  * hand side and one set of boundary values since the modification of
  * the right hand side depends on the original matrix.
  *
@@ -214,9 +214,8 @@ class FilteredMatrix : public Subscriptor
                                     /**
                                      * Default constructor. You will
                                      * have to set the matrix to be
-                                     * used later using the
-                                     * @p set_referenced_matrix
-                                     * function.
+                                     * used later using
+                                     * set_referenced_matrix().
                                      */
     FilteredMatrix ();
 
@@ -348,7 +347,7 @@ class FilteredMatrix : public Subscriptor
                                      * let $dst = M^T*src$ with $M$
                                      * being this matrix. This
                                      * function does the same as
-                                     * @p vmult but takes the
+                                     * vmult() but takes the
                                      * transposed matrix. (This
                                      * matrix is the filtered one to
                                      * which we store a reference.)
@@ -483,7 +482,7 @@ class FilteredMatrix : public Subscriptor
                                      * matrix. In order to guarantee
                                      * that it is not deleted while
                                      * still in use, we subscribe to
-                                     * it using the @p SmartPointer
+                                     * it using the SmartPointer
                                      * class.
                                      */
     SmartPointer<const MATRIX> matrix;
index 02d7e4bdcae9edeefcd03a7c8fa4f3b9c8efaa54..d0bfbd7a5a9260b24bb7d9387161aa3d4234b60a 100644 (file)
@@ -211,9 +211,9 @@ class ProductSparseMatrix : public PointerMatrixBase<Vector<vector_number> >
 
 
 /**
- * Mean value filter.  The @p vmult functions of this matrix filter
+ * Mean value filter.  The vmult() functions of this matrix filter
  * out mean values of the vector.  If the vector is of type
- * @p BlockVector, then an additional parameter selects a single
+ * BlockVector, then an additional parameter selects a single
  * component for this operation.
  *
  * @author Guido Kanschat, 2002, 2003
index f3f165f4157af88432e527d6efa449a46fdcc12a..7e209cd22235dfb5457aa45502b24b0db435e17f 100644 (file)
@@ -48,7 +48,7 @@
  * FullMatrix, as long as it satisfies a number of requirements,
  * stated with the member functions of this class.
  *
- * The generation of patches through the @p build_patches function
+ * The generation of patches through the build_patches() function
  * can be modified by giving it an object holding certain flags. See
  * the documentation of the members of the Options class for a
  * description of these flags.
@@ -81,7 +81,7 @@
  *    D d;
  * @endverbatim 
  *
- *
+ * @ingroup IO
  * @author Wolfgang Bangerth, 2001
  */
 class MatrixOut : public DataOutInterface<2,2>
@@ -171,7 +171,7 @@ class MatrixOut : public DataOutInterface<2,2>
                                      * requires that we can extract
                                      * elements of the matrix, which
                                      * is done using the
-                                     * @p get_element function
+                                     * get_element() function
                                      * declared below. By adding
                                      * specializations, you can
                                      * extend this class to other
@@ -195,21 +195,21 @@ class MatrixOut : public DataOutInterface<2,2>
     
                                     /**
                                      * Abbreviate the somewhat
-                                     * lengthy name for the @p Patch
+                                     * lengthy name for the ::DataOutBase::Patch
                                      * class.
                                      *
                                      * Note that we have to indicate
                                      * the global scope using the
                                      * @p :: in front of
-                                     * @p DataOutBase, since
+                                     * DataOutBase, since
                                      * otherwise the C++ rules
                                      * specify that this here
-                                     * indicates the @p DataOutBase
+                                     * indicates the DataOutBase
                                      * base class of this
                                      * class. Since that is a private
                                      * base class, we cannot access
                                      * its members, and so access to
-                                     * the local @p Patch type would
+                                     * the local Patch type would
                                      * be forbidden.
                                      */
     typedef ::DataOutBase::Patch<2,2> Patch;
@@ -217,7 +217,7 @@ class MatrixOut : public DataOutInterface<2,2>
                                     /**
                                      * This is a list of patches that
                                      * is created each time
-                                     * @p build_patches is
+                                     * build_patches() is
                                      * called. These patches are used
                                      * in the output routines of the
                                      * base classes.
index c153754b048a06c1e3cf5a47ffcd4e71f6ab518e..5f0bb2f2d390b6026eab435cfd80ab16a41ec129 100644 (file)
@@ -148,7 +148,7 @@ namespace PETScWrappers
                                         * that by calling the @p reinit
                                         * functions of the blocks
                                         * themselves. Do not forget to
-                                        * call @p collect_sizes after
+                                        * call collect_sizes() after
                                         * that on this object.
                                         *
                                         * The reason that you have to
index c2ba92bff44424ef00e7579d88ebfb0a90f7826b..85aef06ff0cd3602db4c65681fca185e8b7fcedd 100644 (file)
@@ -258,7 +258,7 @@ namespace PETScWrappers
  * functions, and is often exchangable. However, since PETSc only supports a
  * single scalar type (either double, float, or a complex data type), it is
  * not templated, and only works with whatever your PETSc installation has
- * defined the data type @p PetscScalar to.
+ * defined the data type PetscScalar to.
  *
  * Note that PETSc only guarantees that operations do what you expect if the
  * functions @p MatAssemblyBegin and @p MatAssemblyEnd have been called
index f9f4029987594d02d42bea782be8c7894258355f..bb0226c544c2f29f2d9512ecff249ac9fc411f02 100644 (file)
@@ -150,7 +150,7 @@ namespace PETScWrappers
                                           * that by calling the @p reinit
                                           * functions of the blocks
                                           * themselves. Do not forget to
-                                          * call @p collect_sizes after
+                                          * call collect_sizes() after
                                           * that on this object.
                                           *
                                           * The reason that you have to
@@ -160,7 +160,7 @@ namespace PETScWrappers
                                           * of elements per row may be
                                           * varying, etc. It is simpler
                                           * not to reproduce the interface
-                                          * of the @p SparsityPattern
+                                          * of the SparsityPattern
                                           * class here but rather let the
                                           * user call whatever function
                                           * she desires.

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.