]> https://gitweb.dealii.org/ - dealii.git/commitdiff
More VECTOR -> VectorType
authorDavid Wells <wellsd2@rpi.edu>
Fri, 30 Oct 2015 15:05:49 +0000 (11:05 -0400)
committerDavid Wells <wellsd2@rpi.edu>
Thu, 12 Nov 2015 19:26:42 +0000 (14:26 -0500)
40 files changed:
tests/bits/deal_solver_04.cc
tests/bits/deal_solver_05.cc
tests/gla/extract_subvector_to.cc
tests/matrix_free/inverse_mass_01.cc
tests/matrix_free/inverse_mass_02.cc
tests/matrix_free/inverse_mass_03.cc
tests/matrix_free/matrix_vector_15.cc
tests/matrix_free/matrix_vector_16.cc
tests/matrix_free/matrix_vector_18.cc
tests/matrix_free/matrix_vector_mf.h
tests/multigrid/cycles.cc
tests/multigrid/smoother_block.cc
tests/petsc/deal_solver_01.cc
tests/petsc/deal_solver_02.cc
tests/petsc/deal_solver_03.cc
tests/petsc/deal_solver_04.cc
tests/petsc/deal_solver_05.cc
tests/petsc/solver_01.cc
tests/petsc/solver_02.cc
tests/petsc/solver_03.cc
tests/petsc/solver_03_mf.cc
tests/petsc/solver_03_precondition_boomeramg.cc
tests/petsc/solver_03_precondition_boomeramg_symmetric.cc
tests/petsc/solver_03_precondition_eisenstat.cc
tests/petsc/solver_03_precondition_icc.cc
tests/petsc/solver_03_precondition_ilu.cc
tests/petsc/solver_03_precondition_lu.cc
tests/petsc/solver_03_precondition_parasails.cc
tests/petsc/solver_03_precondition_sor.cc
tests/petsc/solver_03_precondition_ssor.cc
tests/petsc/solver_04.cc
tests/petsc/solver_05.cc
tests/petsc/solver_06.cc
tests/petsc/solver_07.cc
tests/petsc/solver_08.cc
tests/petsc/solver_09.cc
tests/petsc/solver_10.cc
tests/petsc/solver_11.cc
tests/petsc/solver_12.cc
tests/petsc/solver_13.cc

index 40a1ad990fd52e0063f927758ec71b44af9d4a27..26e983ab81b153db0708bb49ced4a871385273f8 100644 (file)
 #include <deal.II/lac/precondition.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index eea0ad83f0d78342e050c58dc68ed917cba5c8fa..fda2642d8abe5e72a3c9431cefaa403f4b0a2f20 100644 (file)
 #include <deal.II/lac/precondition.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 743c15619892983985f3ed3ffac22db898c8d91b..18828a0efc00d1da2696b3db3cf4044dd60f9c56 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// test the various VECTOR::extract_subvector_to functions
+// test the various VectorType::extract_subvector_to functions
 
 #include "../tests.h"
 #include <deal.II/lac/generic_linear_algebra.h>
index bc00eaec2033e8988c4420e7f714ac4872479207..c0e99df1fed5524195ab3326163d2cf2a5184d90 100644 (file)
@@ -39,7 +39,7 @@ std::ofstream logfile("output");
 
 
 
-template <int dim, int fe_degree, typename Number, typename VECTOR=Vector<Number> >
+template <int dim, int fe_degree, typename Number, typename VectorType=Vector<Number> >
 class MatrixFreeTest
 {
 public:
@@ -49,9 +49,9 @@ public:
   {};
 
   void
-  local_mass_operator (const MatrixFree<dim,Number>  &data,
-                       VECTOR       &dst,
-                       const VECTOR &src,
+  local_mass_operator (const MatrixFree<dim,Number>               &data,
+                       VectorType                                 &dst,
+                       const VectorType                           &src,
                        const std::pair<unsigned int,unsigned int> &cell_range) const
   {
     FEEvaluation<dim,fe_degree,fe_degree+1,1,Number> fe_eval (data);
@@ -70,9 +70,9 @@ public:
   }
 
   void
-  local_inverse_mass_operator (const MatrixFree<dim,Number>  &data,
-                               VECTOR       &dst,
-                               const VECTOR &src,
+  local_inverse_mass_operator (const MatrixFree<dim,Number>               &data,
+                               VectorType                                 &dst,
+                               const VectorType                           &src,
                                const std::pair<unsigned int,unsigned int> &cell_range) const
   {
     FEEvaluation<dim,fe_degree,fe_degree+1,1,Number> fe_eval (data);
@@ -91,19 +91,19 @@ public:
       }
   }
 
-  void vmult (VECTOR       &dst,
-              const VECTOR &src) const
+  void vmult (VectorType       &dst,
+              const VectorType &src) const
   {
     dst = 0;
-    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VECTOR>::local_mass_operator,
+    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VectorType>::local_mass_operator,
                     this, dst, src);
   };
 
-  void apply_inverse (VECTOR       &dst,
-                      const VECTOR &src) const
+  void apply_inverse (VectorType       &dst,
+                      const VectorType &src) const
   {
     dst = 0;
-    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VECTOR>::local_inverse_mass_operator,
+    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VectorType>::local_inverse_mass_operator,
                     this, dst, src);
   };
 
index 744c42f87bccb0db201611aad4cd4feda9d363d5..f1cd6b03d76fb5945796414d27f2fba16da8f1d7 100644 (file)
@@ -39,7 +39,7 @@ std::ofstream logfile("output");
 
 
 
-template <int dim, int fe_degree, typename Number, typename VECTOR=Vector<Number> >
+template <int dim, int fe_degree, typename Number, typename VectorType=Vector<Number> >
 class MatrixFreeTest
 {
 public:
@@ -49,9 +49,9 @@ public:
   {};
 
   void
-  local_mass_operator (const MatrixFree<dim,Number>  &data,
-                       VECTOR       &dst,
-                       const VECTOR &src,
+  local_mass_operator (const MatrixFree<dim,Number>               &data,
+                       VectorType                                 &dst,
+                       const VectorType                           &src,
                        const std::pair<unsigned int,unsigned int> &cell_range) const
   {
     FEEvaluation<dim,fe_degree,fe_degree+1,dim,Number> fe_eval (data);
@@ -70,9 +70,9 @@ public:
   }
 
   void
-  local_inverse_mass_operator (const MatrixFree<dim,Number>  &data,
-                               VECTOR       &dst,
-                               const VECTOR &src,
+  local_inverse_mass_operator (const MatrixFree<dim,Number>               &data,
+                               VectorType                                 &dst,
+                               const VectorType                           &src,
                                const std::pair<unsigned int,unsigned int> &cell_range) const
   {
     FEEvaluation<dim,fe_degree,fe_degree+1,dim,Number> fe_eval (data);
@@ -91,19 +91,19 @@ public:
       }
   }
 
-  void vmult (VECTOR       &dst,
-              const VECTOR &src) const
+  void vmult (VectorType   &dst,
+              const VectorType &src) const
   {
     dst = 0;
-    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VECTOR>::local_mass_operator,
+    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VectorType>::local_mass_operator,
                     this, dst, src);
   };
 
-  void apply_inverse (VECTOR       &dst,
-                      const VECTOR &src) const
+  void apply_inverse (VectorType   &dst,
+                      const VectorType &src) const
   {
     dst = 0;
-    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VECTOR>::local_inverse_mass_operator,
+    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VectorType>::local_inverse_mass_operator,
                     this, dst, src);
   };
 
index 2b2b01f4783eb9328de3b234e15e712dcb2f3683..708a17ef3c240a0507c47960f3054ec0ff2f3d5f 100644 (file)
@@ -40,7 +40,7 @@ std::ofstream logfile("output");
 
 
 
-template <int dim, int fe_degree, typename Number, typename VECTOR=Vector<Number> >
+template <int dim, int fe_degree, typename Number, typename VectorType=Vector<Number> >
 class MatrixFreeTest
 {
 public:
@@ -50,9 +50,9 @@ public:
   {};
 
   void
-  local_mass_operator (const MatrixFree<dim,Number>  &data,
-                       VECTOR       &dst,
-                       const VECTOR &src,
+  local_mass_operator (const MatrixFree<dim,Number>               &data,
+                       VectorType                                 &dst,
+                       const VectorType                           &src,
                        const std::pair<unsigned int,unsigned int> &cell_range) const
   {
     FEEvaluation<dim,fe_degree,fe_degree+1,3,Number> fe_eval (data);
@@ -77,9 +77,9 @@ public:
   }
 
   void
-  local_inverse_mass_operator (const MatrixFree<dim,Number>  &data,
-                               VECTOR       &dst,
-                               const VECTOR &src,
+  local_inverse_mass_operator (const MatrixFree<dim,Number>               &data,
+                               VectorType                                 &dst,
+                               const VectorType                           &src,
                                const std::pair<unsigned int,unsigned int> &cell_range) const
   {
     FEEvaluation<dim,fe_degree,fe_degree+1,3,Number> fe_eval (data);
@@ -104,19 +104,19 @@ public:
       }
   }
 
-  void vmult (VECTOR       &dst,
-              const VECTOR &src) const
+  void vmult (VectorType   &dst,
+              const VectorType &src) const
   {
     dst = 0;
-    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VECTOR>::local_mass_operator,
+    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VectorType>::local_mass_operator,
                     this, dst, src);
   };
 
-  void apply_inverse (VECTOR       &dst,
-                      const VECTOR &src) const
+  void apply_inverse (VectorType   &dst,
+                      const VectorType &src) const
   {
     dst = 0;
-    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VECTOR>::local_inverse_mass_operator,
+    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VectorType>::local_inverse_mass_operator,
                     this, dst, src);
   };
 
index 9d12f576d4bd06e8f5f426bae387124a91b8c6ce..850fc18bb9056122344fa8fdcae984c9a4dd9dfd 100644 (file)
@@ -41,21 +41,21 @@ std::ofstream logfile("output");
 
 
 
-template <int dim, int fe_degree, typename Number, typename VECTOR=Vector<Number> >
+template <int dim, int fe_degree, typename Number, typename VectorType=Vector<Number> >
 class MatrixFreeTest
 {
 public:
-  MatrixFreeTest(const DoFHandler<dim> &dof_handler,
+  MatrixFreeTest(const DoFHandler<dim>  &dof_handler,
                  const ConstraintMatrix &constraints)
     :
     dof_handler (dof_handler),
     constraints (constraints)
   {}
 
-  void vmult (VECTOR       &dst,
-              const VECTOR &src) const
+  void vmult (VectorType       &dst,
+              const VectorType &src) const
   {
-    VECTOR src_cpy = src;
+    VectorType src_cpy = src;
     constraints.distribute(src_cpy);
     FEEvaluation<dim,fe_degree,fe_degree+1,1,Number>
     fe_eval(dof_handler.get_fe(), QGauss<1>(fe_degree+1),
index 8f619c10c05a3da2827481c4d594ef23d4e5fc39..6f1872032adba65d8ef2c01c98fc9e859945a24a 100644 (file)
@@ -41,21 +41,21 @@ std::ofstream logfile("output");
 
 
 
-template <int dim, int fe_degree, typename Number, typename VECTOR=Vector<Number> >
+template <int dim, int fe_degree, typename Number, typename VectorType=Vector<Number> >
 class MatrixFreeTest
 {
 public:
-  MatrixFreeTest(const DoFHandler<dim> &dof_handler,
-                 const ConstraintMatrix &constraints)
+  MatrixFreeTest (const DoFHandler<dim>  &dof_handler,
+                  const ConstraintMatrix &constraints)
     :
     dof_handler (dof_handler),
     constraints (constraints)
   {}
 
-  void vmult (VECTOR       &dst,
-              const VECTOR &src) const
+  void vmult (VectorType       &dst,
+              const VectorType &src) const
   {
-    VECTOR src_cpy = src;
+    VectorType src_cpy = src;
     constraints.distribute(src_cpy);
     FEEvaluation<dim,fe_degree,fe_degree+1,dim,Number> fe_eval
     (dof_handler.get_fe(), QGauss<1>(fe_degree+1),
index f3c5e596c050ccfbac840fdb8c3eca6bfa7c676f..f6f0d10c574a6e04daafe5ccb36def2dfb90b324 100644 (file)
@@ -42,7 +42,7 @@
 
 
 
-template <int dim, int fe_degree, typename Number, typename VECTOR=Vector<Number> >
+template <int dim, int fe_degree, typename Number, typename VectorType=Vector<Number> >
 class MatrixFreeTest
 {
 public:
@@ -50,20 +50,20 @@ public:
     data (data_in)
   {};
 
-  void vmult (VECTOR       &dst,
-              const VECTOR &src) const
+  void vmult (VectorType       &dst,
+              const VectorType &src) const
   {
     dst = 0;
-    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VECTOR>::local_operation,
+    data.cell_loop (&MatrixFreeTest<dim,fe_degree,Number,VectorType>::local_operation,
                     this, dst, src);
   };
 
 private:
   const MatrixFree<dim,Number> &data;
 
-  void local_operation (const MatrixFree<dim,Number> &data,
-                        VECTOR &out,
-                        const VECTOR &in,
+  void local_operation (const MatrixFree<dim,Number>               &data,
+                        VectorType                                 &out,
+                        const VectorType                           &in,
                         const std::pair<unsigned int,unsigned int> &cell_range) const
   {
     FEEvaluation<dim,fe_degree,fe_degree+1,1,Number> fe_eval (data);
index f55fcc88aee160ae17afe978b9da51b46c4db133..c6318cdf376ca024ed16fd074469992ce507b164 100644 (file)
 #include <deal.II/lac/parallel_vector.h>
 
 
-template <int dim, int fe_degree, typename VECTOR>
+template <int dim, int fe_degree, typename VectorType>
 void
-helmholtz_operator (const MatrixFree<dim,typename VECTOR::value_type>  &data,
-                    VECTOR       &dst,
-                    const VECTOR &src,
-                    const std::pair<unsigned int,unsigned int> &cell_range)
+helmholtz_operator (const MatrixFree<dim,typename VectorType::value_type> &data,
+                    VectorType                                            &dst,
+                    const VectorType                                      &src,
+                    const std::pair<unsigned int,unsigned int>            &cell_range)
 {
-  typedef typename VECTOR::value_type Number;
+  typedef typename VectorType::value_type Number;
   FEEvaluation<dim,fe_degree,fe_degree+1,1,Number> fe_eval (data);
   const unsigned int n_q_points = fe_eval.n_q_points;
 
@@ -46,7 +46,7 @@ helmholtz_operator (const MatrixFree<dim,typename VECTOR::value_type>  &data,
 
 
 
-template <int dim, int fe_degree, typename Number, typename VECTOR=Vector<Number> >
+template <int dim, int fe_degree, typename Number, typename VectorType=Vector<Number> >
 class MatrixFreeTest
 {
 public:
@@ -56,15 +56,15 @@ public:
     data (data_in)
   {};
 
-  void vmult (VECTOR       &dst,
-              const VECTOR &src) const
+  void vmult (VectorType       &dst,
+              const VectorType &src) const
   {
     dst = 0;
-    const std_cxx11::function<void(const MatrixFree<dim,typename VECTOR::value_type> &,
-                                   VECTOR &,
-                                   const VECTOR &,
+    const std_cxx11::function<void(const MatrixFree<dim,typename VectorType::value_type> &,
+                                   VectorType &,
+                                   const VectorType &,
                                    const std::pair<unsigned int,unsigned int> &)>
-    wrap = helmholtz_operator<dim,fe_degree,VECTOR>;
+    wrap = helmholtz_operator<dim,fe_degree,VectorType>;
     data.cell_loop (wrap, dst, src);
   };
 
index 0e2812ab97ba5e05e5cb025f72b9d83a117da0f2..eb2026e42fd71cd601de9e092f02464045f9f572 100644 (file)
 #include <fstream>
 
 #define N 3
-typedef Vector<double> VECTOR;
+typedef Vector<double> VectorType;
 
 class MGAll
   :
-  public MGSmootherBase<VECTOR>,
-  public MGTransferBase<VECTOR>,
-  public MGCoarseGridBase<VECTOR>
+  public MGSmootherBase<VectorType>,
+  public MGTransferBase<VectorType>,
+  public MGCoarseGridBase<VectorType>
 {
 public:
   virtual ~MGAll()
   {}
 
   virtual void smooth (const unsigned int,
-                       VECTOR &, const VECTOR &) const
+                       VectorType &, const VectorType &) const
   {}
 
   virtual void prolongate (const unsigned int,
-                           VECTOR &, const VECTOR &) const
+                           VectorType &, const VectorType &) const
   {}
 
   virtual void restrict_and_add (const unsigned int,
-                                 VECTOR &, const VECTOR &) const
+                                 VectorType &, const VectorType &) const
   {}
 
   virtual void clear ()
   {}
 
   virtual void operator() (const unsigned int,
-                           VECTOR &, const VECTOR &) const
+                           VectorType &, const VectorType &) const
   {}
 };
 
@@ -70,21 +70,21 @@ void test_cycles(unsigned int minlevel, unsigned int maxlevel)
   MGLevelObject<FullMatrix<double> > level_matrices(0, maxlevel);
   for (unsigned int i=0; i<=maxlevel; ++i)
     level_matrices[i].reinit(N, N);
-  mg::Matrix<VECTOR> mgmatrix(level_matrices);
+  mg::Matrix<VectorType> mgmatrix(level_matrices);
 
-  Multigrid<VECTOR> mg1(minlevel, maxlevel, mgmatrix, all, all, all, all,
-                        Multigrid<VECTOR>::v_cycle);
+  Multigrid<VectorType> mg1(minlevel, maxlevel, mgmatrix, all, all, all, all,
+                        Multigrid<VectorType>::v_cycle);
   mg1.set_debug(3);
   for (unsigned int i=minlevel; i<=maxlevel; ++i)
     mg1.defect[i].reinit(N);
   mg1.cycle();
   deallog << std::endl;
 
-  mg1.set_cycle(Multigrid<VECTOR>::w_cycle);
+  mg1.set_cycle(Multigrid<VectorType>::w_cycle);
   mg1.cycle();
   deallog << std::endl;
 
-  mg1.set_cycle(Multigrid<VECTOR>::f_cycle);
+  mg1.set_cycle(Multigrid<VectorType>::f_cycle);
   mg1.cycle();
 }
 
index 1371545f3c0d285fcef7b9ece6fd102b864d4f82..f8056188b8bf05beb80fb5ee9e9a8b813ee6baa4 100644 (file)
@@ -43,8 +43,8 @@ public:
   /**
   * Apply preconditioner.
   */
-  template<class VECTOR>
-  void vmult (VECTOR &, const VECTOR &) const;
+  template<typename VectorType>
+  void vmult (VectorType &, const VectorType &) const;
 
   /**
    * Apply transpose
@@ -53,13 +53,13 @@ public:
    * the same as
    * vmult().
    */
-  template<class VECTOR>
-  void Tvmult (VECTOR &, const VECTOR &) const;
+  template<typename VectorType>
+  void Tvmult (VectorType &, const VectorType &) const;
   /**
    * Apply preconditioner, adding to the previous value.
    */
-  template<class VECTOR>
-  void vmult_add (VECTOR &, const VECTOR &) const;
+  template<typename VectorType>
+  void vmult_add (VectorType &, const VectorType &) const;
 
   /**
    * Apply transpose
@@ -68,8 +68,8 @@ public:
    * the same as
    * vmult_add().
    */
-  template<class VECTOR>
-  void Tvmult_add (VECTOR &, const VECTOR &) const;
+  template<typename VectorType>
+  void Tvmult_add (VectorType &, const VectorType &) const;
 
 private:
   number factor;
@@ -86,25 +86,25 @@ ScalingMatrix<number>::ScalingMatrix(number factor)
 
 
 template<typename number>
-template<class VECTOR>
+template<typename VectorType>
 inline void
-ScalingMatrix<number>::vmult (VECTOR &dst, const VECTOR &src) const
+ScalingMatrix<number>::vmult (VectorType &dst, const VectorType &src) const
 {
   dst.equ(factor, src);
 }
 
 template<typename number>
-template<class VECTOR>
+template<typename VectorType>
 inline void
-ScalingMatrix<number>::Tvmult (VECTOR &dst, const VECTOR &src) const
+ScalingMatrix<number>::Tvmult (VectorType &dst, const VectorType &src) const
 {
   dst.equ(factor, src);
 }
 
 template<typename number>
-template<class VECTOR>
+template<typename VectorType>
 inline void
-ScalingMatrix<number>::vmult_add (VECTOR &dst, const VECTOR &src) const
+ScalingMatrix<number>::vmult_add (VectorType &dst, const VectorType &src) const
 {
   dst.add(factor, src);
 }
@@ -112,9 +112,9 @@ ScalingMatrix<number>::vmult_add (VECTOR &dst, const VECTOR &src) const
 
 
 template<typename number>
-template<class VECTOR>
+template<typename VectorType>
 inline void
-ScalingMatrix<number>::Tvmult_add (VECTOR &dst, const VECTOR &src) const
+ScalingMatrix<number>::Tvmult_add (VectorType &dst, const VectorType &src) const
 {
   dst.add(factor, src);
 }
index 8aef923f4c71b24d396388fd86f27d571ab8aef8..e16bdf2fa12f6bb1528a3d9ac82139f1e94d43cd 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 5b9df1e086ef67f2550a1379e156b6b87ee3a617..07e6f9792938ed43f438be7e6a07d95084d7a5eb 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 5b0a4509a70518e680ccca21f17389deeb860bb9..da4cb38357246182d71e0cb6e4861a85138a8c1b 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 7e232a3601325746d65cc05bd05edc10d37d2def..9299c375456ec7c342e80690c297e5a7aa703837 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 0e8027b7493d9bc3a05b199ce148c3a871a07cc9..8af9ebbc44cce4f59bce43dca8d8ed98dfc7a955 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 32229e25550cae3bbd44217eb7beedbc7549c7a8..339d58d460175e5d7756a401bbd09ef778bd7f87 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 1d8bd425ff74e5dd58d653ebc88418fec634a424..41ba75be176a48b8ae0f6164d4b9b5694206460f 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index c5a05717872349e96ea99c53de07b5f9d1395a36..1c525a7577d3a634c63bbe2b7a72e1eda6a0a1cf 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 6b9f6b2fa38ed8ade8351d8a1aa75bb2d9820c1b..e912f89f3ef5290a91644d0a7f40200365d435c8 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 8861d2b025468b93efd1b51e0dfdeef4cd30bc12..526a0dec7dec25496f806a129d2458c88ddd9021 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index b4e092ec2c850abe8e62246c8abbe820ea165c52..7e7b64b510f1cc3c1c72faa79debee503ad97161 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index e6a7392fa179b5a859ae5097fec0c61db4e30c55..842fb95649c0c154f4bab77d87f0e53b0704e55f 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 2a7f10876a1e51eaf73a19e65ed35a95fcacbe24..a59ea2055aef75eeddb7c0b46a7cf95508a5ba25 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 18f382071efc96542d44e813c2e8071b64402bbd..f1b4e263877ef5410ae7511493178ffdd6b3ba06 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 57a821f8e12ba14fcef2a647f32b86411263fd86..f9fa7f582d2c1c52afddae0f6f5512656e9a6563 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 7a79ae0f9ddf422eaf1425f3eb59d80c031f5ef6..8e5dc6d212e6977ed1400dd9bd404e5fe4eba8fe 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index fa9f2e292c09551d7ff240aa3ae6744f5a0366b3..027ce627ff9c7b2d0a3b76df4aeeaa2900183409 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 90ad0826b3bb5c0bc09fdd69906b876608f1f4e0..0206677e6eb0352603640ca6bf9b015001355b4b 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 78b11c2ff9e12cd39882d6b9057dbfea34fec816..3a7be18369a0cbb6994f5524d542b79dac8f286a 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 327a465118eeecf248dff7de8a5a1c606a004e41..9b876fc291232fb4f9bb14aeed3bdcc72b62798a 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index dd9795c462310a6138b8aadb67b976abf5689596..443df43616e718e647c865dfcf97e748f6c8f351 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index b93e99cec504c6eefd9dbc0708c3757633da6f35..efb516b7f3eb13d67d95fde9b016cabe41f9bd62 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index ec6268a11aadfbb8a224259d76e5e63ed6f393f0..1ae58cff996447a3ab8d3c0657685283e02747d6 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index b7421238dc1de97c22a289f2a4a854d2d6e724df..8d4f080a4891935739c27165592b024d9dacafb6 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 0086dc0d589d4921e34d8594883b2165583c9a43..ce2b743424985f645160383b17e7f62fcc250d48 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index e088e3ec1f3277bcd24b481121dee7155c7a6f9d..95b238247c7fb7e745253ea1339252417c5615e7 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index a24a04e4e2cb76a0214060f45c3b0d9098fc30e1..c145d4a248f796a5308b5695fb29c2a758edfc6f 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
+check_solve(SOLVER               &solver,
              const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+             const MATRIX        &A,
+             VectorType          &u,
+             VectorType          &f,
+             const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 
index 12e3415b6a1e1ee2f9cc5a8410966ca0d6335c0c..e481a3299ea8b141ada56c93ecc399a1de961c07 100644 (file)
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
 void
-check_solve( SOLVER &solver,
-             const SolverControl &solver_control,
-             const MATRIX &A,
-             VECTOR &u, VECTOR &f, const PRECONDITION &P)
+check_solve(SOLVER              &solver,
+            const SolverControl &solver_control,
+            const MATRIX        &A,
+            VectorType          &u,
+            VectorType          &f,
+            const PRECONDITION  &P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
 

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.