]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Fix to places where @p was not used with {...}.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 26 Jun 2000 08:35:22 +0000 (08:35 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 26 Jun 2000 08:35:22 +0000 (08:35 +0000)
git-svn-id: https://svn.dealii.org/trunk@3067 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/lac/include/lac/precondition.h

index 78389b5ad5e21c9569477ace1544fb5671802c25..a12d0783a5b84e7d0235f9c5bc9cfe07c8cb27b3 100644 (file)
@@ -38,6 +38,7 @@ class PreconditionIdentity
                                      */
     template<class VECTOR>
     void vmult (VECTOR&, const VECTOR&) const;
+
                                     /**
                                      * Apply transpose
                                      * preconditioner. Since this is
@@ -50,6 +51,7 @@ class PreconditionIdentity
 };
 
 
+
 /**
  * Preconditioner using a matrix-builtin function.
  * This class forms a preconditioner suitable for the LAC solver
@@ -137,6 +139,7 @@ class PreconditionUseMatrix
 };
 
 
+
 /**
  * Base class for other preconditioners.
  * Here, only some common features Jacobi, SOR and SSOR preconditioners
@@ -159,17 +162,21 @@ class PreconditionRelaxation
                                      * reasons. It defaults to 1.
                                      */
     void initialize (const MATRIX& A, const double omega = 1.);
+    
   protected:
                                     /**
                                      * Pointer to the matrix object.
                                      */
     SmartPointer<const MATRIX> A;
+
                                     /**
                                      * Relaxation parameter.
                                      */
     double omega;
 };
 
+
+
 /**
  * Jacobi preconditioner using matrix built-in function.  The MATRIX
  * class used is required to have a function
@@ -215,6 +222,7 @@ class PreconditionSOR : public PreconditionRelaxation<MATRIX>
                                      */
     template<class VECTOR>
     void vmult (VECTOR&, const VECTOR&) const;
+
                                     /**
                                      * Apply transpose
                                      * preconditioner.
@@ -224,6 +232,7 @@ class PreconditionSOR : public PreconditionRelaxation<MATRIX>
 };
 
 
+
 /**
  * SSOR preconditioner using matrix built-in function.  The MATRIX
  * class used is required to have a function
@@ -240,6 +249,7 @@ class PreconditionSSOR : public PreconditionRelaxation<MATRIX>
                                      */
     template<class VECTOR>
     void vmult (VECTOR&, const VECTOR&) const;
+
                                     /**
                                      * Apply transpose
                                      * preconditioner. Since this is
@@ -263,7 +273,7 @@ class PreconditionSSOR : public PreconditionRelaxation<MATRIX>
  *
  * @author Guido Kanschat, 1999
  */
-template<class SOLVER, class MATRIX       = SparseMatrix<double>, class PRECONDITION = PreconditionIdentity>
+template<class SOLVER, class MATRIX = SparseMatrix<double>, class PRECONDITION = PreconditionIdentity>
 class PreconditionLACSolver
 {
   public:
@@ -275,6 +285,7 @@ class PreconditionLACSolver
     PreconditionLACSolver(SOLVER&,
                          const MATRIX&,
                          const PRECONDITION&);
+    
                                     /**
                                      * Execute preconditioning.
                                      */
@@ -286,10 +297,12 @@ class PreconditionLACSolver
                                      * The solver class to use.
                                      */
     SOLVER& solver;
+
                                     /**
                                      * The matrix in use.
                                      */
     const MATRIX& matrix;
+    
                                     /**
                                      * The preconditioner to use.
                                      */
@@ -297,14 +310,15 @@ class PreconditionLACSolver
 };
 
 
+
 /**
  * Matrix with preconditioner.
  * Given a matrix $A$ and a preconditioner $P$, this class implements a new matrix
  * with the matrix-vector product $PA$. It needs an auxiliary vector for that.
  *
  * By this time, this is considered a temporary object to be plugged
- * into eigenvalue solvers. Therefore, no @p SmartPointer is used for
- * @p A and @p P.
+ * into eigenvalue solvers. Therefore, no @p{SmartPointer} is used for
+ * @p{A} and @p{P}.
  *
  * @author Guido Kanschat, 2000
  */
@@ -366,6 +380,8 @@ PreconditionIdentity::vmult (VECTOR& dst, const VECTOR& src) const
   dst = src;
 }
 
+
+
 template<class VECTOR>
 inline void
 PreconditionIdentity::Tvmult (VECTOR& dst, const VECTOR& src) const
@@ -395,6 +411,7 @@ PreconditionJacobi<MATRIX>::vmult (VECTOR& dst, const VECTOR& src) const
 }
 
 
+
 template <class MATRIX>
 template<class VECTOR>
 inline void
@@ -417,6 +434,7 @@ PreconditionSOR<MATRIX>::vmult (VECTOR& dst, const VECTOR& src) const
 }
 
 
+
 template <class MATRIX>
 template<class VECTOR>
 inline void
@@ -439,6 +457,7 @@ PreconditionSSOR<MATRIX>::vmult (VECTOR& dst, const VECTOR& src) const
 }
 
 
+
 template <class MATRIX>
 template<class VECTOR>
 inline void
@@ -460,6 +479,7 @@ PreconditionUseMatrix<MATRIX,VECTOR>::PreconditionUseMatrix(const MATRIX& M,
 {}
 
 
+
 template<class MATRIX, class VECTOR>
 void
 PreconditionUseMatrix<MATRIX,VECTOR>::vmult (VECTOR& dst,
@@ -479,6 +499,8 @@ PreconditionLACSolver<SOLVER,MATRIX,PRECONDITION>
                solver(solver), matrix(matrix), precondition(precondition)
 {}
 
+
+
 template<class SOLVER, class MATRIX, class PRECONDITION>
 template<class VECTOR>
 void
@@ -515,6 +537,7 @@ PreconditionedMatrix<MATRIX, PRECOND, VECTOR>
 }
 
 
+
 template<class MATRIX, class PRECOND, class VECTOR>
 inline void
 PreconditionedMatrix<MATRIX, PRECOND, VECTOR>
@@ -529,6 +552,7 @@ PreconditionedMatrix<MATRIX, PRECOND, VECTOR>
 }
 
 
+
 template<class MATRIX, class PRECOND, class VECTOR>
 inline double
 PreconditionedMatrix<MATRIX, PRECOND, VECTOR>

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.