]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Prefer MatrixType to Matrix in the tutorials. 2213/head
authorDavid Wells <wellsd2@rpi.edu>
Sun, 21 Feb 2016 14:18:32 +0000 (09:18 -0500)
committerDavid Wells <wellsd2@rpi.edu>
Sun, 21 Feb 2016 14:18:32 +0000 (09:18 -0500)
examples/step-21/step-21.cc
examples/step-22/step-22.cc
examples/step-31/step-31.cc
examples/step-43/step-43.cc
examples/step-45/step-45.cc

index 3b821afd44bef1f6fd5a0da1f099a820680c574f..e5ecd5d9e6eb3c7218f731a5aba487f33bd006b1 100644 (file)
@@ -461,31 +461,31 @@ namespace Step21
   // converges in at most <code>src.size()</code> steps.) As a consequence, we
   // set the maximum number of iterations equal to the maximum of the size of
   // the linear system and 200.
-  template <class Matrix>
+  template <class MatrixType>
   class InverseMatrix : public Subscriptor
   {
   public:
-    InverseMatrix (const Matrix &m);
+    InverseMatrix (const MatrixType &m);
 
     void vmult (Vector<double>       &dst,
                 const Vector<double> &src) const;
 
   private:
-    const SmartPointer<const Matrix> matrix;
+    const SmartPointer<const MatrixType> matrix;
   };
 
 
-  template <class Matrix>
-  InverseMatrix<Matrix>::InverseMatrix (const Matrix &m)
+  template <class MatrixType>
+  InverseMatrix<MatrixType>::InverseMatrix (const MatrixType &m)
     :
     matrix (&m)
   {}
 
 
 
-  template <class Matrix>
-  void InverseMatrix<Matrix>::vmult (Vector<double>       &dst,
-                                     const Vector<double> &src) const
+  template <class MatrixType>
+  void InverseMatrix<MatrixType>::vmult (Vector<double>       &dst,
+                                         const Vector<double> &src) const
   {
     SolverControl solver_control (std::max(src.size(), static_cast<std::size_t> (200)),
                                   1e-8*src.l2_norm());
index 1986daab7f99b951039b4c477a523e9842cdb9cc..b4ca614e5b91bcf8633235dd7518404789b19973 100644 (file)
@@ -264,25 +264,26 @@ namespace Step22
   // <code>InverseMatrix</code> object is created. The member function
   // <code>vmult</code> is, as in step-20, a multiplication with a vector,
   // obtained by solving a linear system:
-  template <class Matrix, class Preconditioner>
+  template <class MatrixType, class Preconditioner>
   class InverseMatrix : public Subscriptor
   {
   public:
-    InverseMatrix (const Matrix         &m,
+    InverseMatrix (const MatrixType     &m,
                    const Preconditioner &preconditioner);
 
     void vmult (Vector<double>       &dst,
                 const Vector<double> &src) const;
 
   private:
-    const SmartPointer<const Matrix> matrix;
+    const SmartPointer<const MatrixType> matrix;
     const SmartPointer<const Preconditioner> preconditioner;
   };
 
 
-  template <class Matrix, class Preconditioner>
-  InverseMatrix<Matrix,Preconditioner>::InverseMatrix (const Matrix &m,
-                                                       const Preconditioner &preconditioner)
+  template <class MatrixType, class Preconditioner>
+  InverseMatrix<MatrixType,Preconditioner>::InverseMatrix
+  (const MatrixType     &m,
+   const Preconditioner &preconditioner)
     :
     matrix (&m),
     preconditioner (&preconditioner)
@@ -299,9 +300,9 @@ namespace Step22
   // inverse of the Laplace matrix &ndash; which is hence directly responsible
   // for the accuracy of the solution itself, so we can't choose a too large
   // tolerance, either.
-  template <class Matrix, class Preconditioner>
-  void InverseMatrix<Matrix,Preconditioner>::vmult (Vector<double>       &dst,
-                                                    const Vector<double> &src) const
+  template <class MatrixType, class Preconditioner>
+  void InverseMatrix<MatrixType,Preconditioner>::vmult (Vector<double>       &dst,
+                                                        const Vector<double> &src) const
   {
     SolverControl solver_control (src.size(), 1e-6*src.l2_norm());
     SolverCG<>    cg (solver_control);
index 4a0bb5a6c02d4785779b60c9d95f1895cd18846c..83453cea5147a73b9a3cbe5345f50e1beecb7833 100644 (file)
@@ -266,11 +266,11 @@ namespace Step31
     // run-time exception into an assertion that fails and triggers a call to
     // <code>abort()</code>, allowing us to trace back in a debugger how we
     // got to the current place.
-    template <class Matrix, class Preconditioner>
+    template <class MatrixType, class Preconditioner>
     class InverseMatrix : public Subscriptor
     {
     public:
-      InverseMatrix (const Matrix         &m,
+      InverseMatrix (const MatrixType     &m,
                      const Preconditioner &preconditioner);
 
 
@@ -279,14 +279,14 @@ namespace Step31
                   const VectorType &src) const;
 
     private:
-      const SmartPointer<const Matrix> matrix;
+      const SmartPointer<const MatrixType> matrix;
       const Preconditioner &preconditioner;
     };
 
 
-    template <class Matrix, class Preconditioner>
-    InverseMatrix<Matrix,Preconditioner>::
-    InverseMatrix (const Matrix &m,
+    template <class MatrixType, class Preconditioner>
+    InverseMatrix<MatrixType,Preconditioner>::
+    InverseMatrix (const MatrixType     &m,
                    const Preconditioner &preconditioner)
       :
       matrix (&m),
@@ -295,10 +295,10 @@ namespace Step31
 
 
 
-    template <class Matrix, class Preconditioner>
+    template <class MatrixType, class Preconditioner>
     template <typename VectorType>
     void
-    InverseMatrix<Matrix,Preconditioner>::
+    InverseMatrix<MatrixType,Preconditioner>::
     vmult (VectorType       &dst,
            const VectorType &src) const
     {
index 89910f98f01dd06528df453c599f2661739449b5..c7b4e198e0b81b41923805ea4cc2c2b162f93d65 100644 (file)
@@ -361,11 +361,11 @@ namespace Step43
   // darcy_matrix to match our problem.
   namespace LinearSolvers
   {
-    template <class Matrix, class Preconditioner>
+    template <class MatrixType, class Preconditioner>
     class InverseMatrix : public Subscriptor
     {
     public:
-      InverseMatrix (const Matrix         &m,
+      InverseMatrix (const MatrixType     &m,
                      const Preconditioner &preconditioner);
 
 
@@ -374,14 +374,14 @@ namespace Step43
                   const VectorType &src) const;
 
     private:
-      const SmartPointer<const Matrix> matrix;
+      const SmartPointer<const MatrixType> matrix;
       const Preconditioner &preconditioner;
     };
 
 
-    template <class Matrix, class Preconditioner>
-    InverseMatrix<Matrix,Preconditioner>::
-    InverseMatrix (const Matrix &m,
+    template <class MatrixType, class Preconditioner>
+    InverseMatrix<MatrixType,Preconditioner>::
+    InverseMatrix (const MatrixType     &m,
                    const Preconditioner &preconditioner)
       :
       matrix (&m),
@@ -390,10 +390,10 @@ namespace Step43
 
 
 
-    template <class Matrix, class Preconditioner>
+    template <class MatrixType, class Preconditioner>
     template <typename VectorType>
     void
-    InverseMatrix<Matrix,Preconditioner>::
+    InverseMatrix<MatrixType,Preconditioner>::
     vmult (VectorType       &dst,
            const VectorType &src) const
     {
index f6b30e5949ed3dda6103dce88c5a911ca4aa1527..fb8aae047a20b19d989740ac72b6d934dc783b86 100644 (file)
@@ -182,11 +182,11 @@ namespace Step45
 
 
 
-  template <class Matrix, class Preconditioner>
+  template <class MatrixType, class Preconditioner>
   class InverseMatrix : public Subscriptor
   {
   public:
-    InverseMatrix (const Matrix         &m,
+    InverseMatrix (const MatrixType     &m,
                    const Preconditioner &preconditioner,
                    const IndexSet       &locally_owned,
                    const MPI_Comm       &mpi_communicator);
@@ -195,7 +195,7 @@ namespace Step45
                 const TrilinosWrappers::MPI::Vector &src) const;
 
   private:
-    const SmartPointer<const Matrix> matrix;
+    const SmartPointer<const MatrixType> matrix;
     const SmartPointer<const Preconditioner> preconditioner;
 
     const MPI_Comm *mpi_communicator;
@@ -204,9 +204,9 @@ namespace Step45
 
 
 
-  template <class Matrix, class Preconditioner>
-  InverseMatrix<Matrix,Preconditioner>::InverseMatrix
-  (const Matrix         &m,
+  template <class MatrixType, class Preconditioner>
+  InverseMatrix<MatrixType,Preconditioner>::InverseMatrix
+  (const MatrixType     &m,
    const Preconditioner &preconditioner,
    const IndexSet       &locally_owned,
    const MPI_Comm       &mpi_communicator)
@@ -219,8 +219,8 @@ namespace Step45
 
 
 
-  template <class Matrix, class Preconditioner>
-  void InverseMatrix<Matrix,Preconditioner>::vmult
+  template <class MatrixType, class Preconditioner>
+  void InverseMatrix<MatrixType,Preconditioner>::vmult
   (TrilinosWrappers::MPI::Vector       &dst,
    const TrilinosWrappers::MPI::Vector &src) const
   {

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.