]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Prefer SolverType to SOLVER.
authorDavid Wells <wellsd2@rpi.edu>
Thu, 12 Nov 2015 19:49:29 +0000 (14:49 -0500)
committerDavid Wells <wellsd2@rpi.edu>
Thu, 12 Nov 2015 20:15:52 +0000 (15:15 -0500)
55 files changed:
include/deal.II/multigrid/mg_coarse.h
include/deal.II/numerics/dof_print_solver_step.h
tests/bits/deal_solver_04.cc
tests/bits/deal_solver_05.cc
tests/lac/linear_operator_08.cc
tests/lac/solver.cc
tests/lac/solver_02.cc
tests/lac/solver_memorytest.cc
tests/lac/solver_monitor.cc
tests/lac/solver_monitor_disconnect.cc
tests/lac/solver_relaxation_01.cc
tests/lac/solver_relaxation_02.cc
tests/lac/solver_relaxation_03.cc
tests/lac/solver_signals.cc
tests/lapack/solver_cg.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
tests/slepc/solve_01.cc
tests/slepc/solve_04.cc
tests/tests.h
tests/trilinos/deal_solver_01.cc
tests/trilinos/deal_solver_02.cc
tests/trilinos/deal_solver_03.cc
tests/trilinos/deal_solver_04.cc
tests/trilinos/deal_solver_05.cc
tests/trilinos/deal_solver_06.cc
tests/trilinos/solver_03.cc
tests/trilinos/solver_05.cc
tests/trilinos/solver_07.cc

index 65a5eaffa5e61c75199dbeaab9594e4f908c6329..628414b8cced86b22db5c0079b6a11a70a5ccd87 100644 (file)
@@ -37,7 +37,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @author Guido Kanschat, 1999, Ralf Hartmann, 2002.
  */
-template<class SOLVER, class VectorType = Vector<double> >
+template<typename SolverType, class VectorType = Vector<double> >
 class MGCoarseGridLACIteration :  public MGCoarseGridBase<VectorType>
 {
 public:
@@ -51,7 +51,7 @@ public:
    * use.
    */
   template<typename MatrixType, class PRECOND>
-  MGCoarseGridLACIteration (SOLVER &,
+  MGCoarseGridLACIteration (SolverType &,
                             const MatrixType &,
                             const PRECOND &);
 
@@ -64,7 +64,7 @@ public:
    * Initialize new data.
    */
   template<typename MatrixType, class PRECOND>
-  void initialize (SOLVER &,
+  void initialize (SolverType &,
                    const MatrixType &,
                    const PRECOND &);
 
@@ -92,7 +92,7 @@ private:
   /**
    * Reference to the solver.
    */
-  SmartPointer<SOLVER,MGCoarseGridLACIteration<SOLVER,VectorType> > solver;
+  SmartPointer<SolverType,MGCoarseGridLACIteration<SolverType,VectorType> > solver;
 
   /**
    * Reference to the matrix.
@@ -187,8 +187,8 @@ private:
 /* ------------------ Functions for MGCoarseGridLACIteration ------------ */
 
 
-template<class SOLVER, class VectorType>
-MGCoarseGridLACIteration<SOLVER, VectorType>
+template<typename SolverType, class VectorType>
+MGCoarseGridLACIteration<SolverType, VectorType>
 ::MGCoarseGridLACIteration()
   :
   solver(0, typeid(*this).name()),
@@ -197,10 +197,10 @@ MGCoarseGridLACIteration<SOLVER, VectorType>
 {}
 
 
-template<class SOLVER, class VectorType>
+template<typename SolverType, class VectorType>
 template<typename MatrixType, class PRECOND>
-MGCoarseGridLACIteration<SOLVER, VectorType>
-::MGCoarseGridLACIteration (SOLVER           &s,
+MGCoarseGridLACIteration<SolverType, VectorType>
+::MGCoarseGridLACIteration (SolverType       &s,
                             const MatrixType &m,
                             const PRECOND    &p)
   :
@@ -211,19 +211,19 @@ MGCoarseGridLACIteration<SOLVER, VectorType>
 }
 
 
-template<class SOLVER, class VectorType>
-MGCoarseGridLACIteration<SOLVER, VectorType>
+template<typename SolverType, class VectorType>
+MGCoarseGridLACIteration<SolverType, VectorType>
 ::~MGCoarseGridLACIteration()
 {
   clear();
 }
 
 
-template<class SOLVER, class VectorType>
+template<typename SolverType, class VectorType>
 template<typename MatrixType, class PRECOND>
 void
-MGCoarseGridLACIteration<SOLVER, VectorType>
-::initialize (SOLVER           &s,
+MGCoarseGridLACIteration<SolverType, VectorType>
+::initialize (SolverType       &s,
               const MatrixType &m,
               const PRECOND    &p)
 {
@@ -237,9 +237,9 @@ MGCoarseGridLACIteration<SOLVER, VectorType>
 }
 
 
-template<class SOLVER, class VectorType>
+template<typename SolverType, class VectorType>
 void
-MGCoarseGridLACIteration<SOLVER, VectorType>
+MGCoarseGridLACIteration<SolverType, VectorType>
 ::clear()
 {
   solver = 0;
@@ -252,9 +252,9 @@ MGCoarseGridLACIteration<SOLVER, VectorType>
 }
 
 
-template<class SOLVER, class VectorType>
+template<typename SolverType, class VectorType>
 void
-MGCoarseGridLACIteration<SOLVER, VectorType>
+MGCoarseGridLACIteration<SolverType, VectorType>
 ::operator() (const unsigned int /* level */,
               VectorType         &dst,
               const VectorType   &src) const
@@ -266,10 +266,10 @@ MGCoarseGridLACIteration<SOLVER, VectorType>
 }
 
 
-template<class SOLVER, class VectorType>
+template<typename SolverType, class VectorType>
 template<typename MatrixType>
 void
-MGCoarseGridLACIteration<SOLVER, VectorType>
+MGCoarseGridLACIteration<SolverType, VectorType>
 ::set_matrix(const MatrixType &m)
 {
   if (matrix)
index 09f1001249fd034ed087aeec408228f749546a5f..366cd60e1d11131693f2c5ae5ded2d5dcedc815d 100644 (file)
@@ -49,8 +49,8 @@ DEAL_II_NAMESPACE_OPEN
  * @ingroup output
  * @author Guido Kanschat, 2000
  */
-template<int dim, class SOLVER, class VectorType = Vector<double> >
-class DoFPrintSolverStep : public SOLVER
+template<int dim, typename SolverType, class VectorType = Vector<double> >
+class DoFPrintSolverStep : public SolverType
 {
 public:
   /**
@@ -87,24 +87,24 @@ private:
 
 /* ----------------------- template functions --------------- */
 
-template<int dim, class SOLVER, class VectorType>
-DoFPrintSolverStep<dim, SOLVER, VectorType>::DoFPrintSolverStep
+template<int dim, typename SolverType, class VectorType>
+DoFPrintSolverStep<dim, SolverType, VectorType>::DoFPrintSolverStep
 (SolverControl            &control,
  VectorMemory<VectorType> &mem,
  DataOut<dim>             &data_out,
  const std::string        &basename)
-  : SOLVER (control, mem),
+  : SolverType (control, mem),
     out (data_out),
     basename (basename)
 {}
 
 
-template<int dim, class SOLVER, class VectorType>
+template<int dim, typename SolverType, class VectorType>
 void
-DoFPrintSolverStep<dim, SOLVER, VectorType>::print_vectors (const unsigned int step,
-                                                            const VectorType &x,
-                                                            const VectorType &r,
-                                                            const VectorType &d) const
+DoFPrintSolverStep<dim, SolverType, VectorType>::print_vectors (const unsigned int  step,
+                                                                const VectorType   &x,
+                                                                const VectorType   &r,
+                                                                const VectorType   &d) const
 {
   out.clear_data_vectors();
   out.add_data_vector(x, "solution");
index c37e56426234641fff16a7691acf60c4e17ed052..0b85461237878ed48062927d76140db06bbd4b15 100644 (file)
@@ -37,9 +37,9 @@
 #include <deal.II/lac/precondition.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index edfc14e2a2ab9f1e1418a4b8a5a78bb59c7bba06..242795d7bc04b6bc707a2734c3c7956e79fd534f 100644 (file)
@@ -36,9 +36,9 @@
 #include <deal.II/lac/precondition.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 67214e79976bf11eba03ae75bcef2fa20cec340d..00afe7e226526773d90b5520561d5d68007162c4 100644 (file)
@@ -129,7 +129,7 @@ test_preconditioner (const SparseMatrix<double> &A,
   }
 }
 
-template<class SOLVER>
+template<typename SolverType>
 void
 test_solver (const SparseMatrix<double> &A,
              const Vector<double> &b)
@@ -138,7 +138,7 @@ test_solver (const SparseMatrix<double> &A,
   {
     deallog.push("Standard solver");
     SolverControl solver_control (100, 1.0e-10);
-    SOLVER solver (solver_control);
+    SolverType solver (solver_control);
 
     PreconditionJacobi< SparseMatrix<double> > preconditioner;
     preconditioner.initialize(A);
@@ -156,7 +156,7 @@ test_solver (const SparseMatrix<double> &A,
     const auto lo_A = linear_operator(A);
 
     SolverControl solver_control (100, 1.0e-10);
-    SOLVER solver (solver_control);
+    SolverType solver (solver_control);
 
     PreconditionJacobi< SparseMatrix<double> > preconditioner;
     preconditioner.initialize(A);
@@ -322,7 +322,7 @@ int main()
     }
     deallog.pop();
 
-    // === SOLVERS ===
+    // === SolverTypes ===
     deallog << std::endl;
     deallog << "Solvers" << std::endl;
     deallog.push("Solvers");
index d6573c9ed0781acbb2f9988f39a4852abe864c56..d0bdea93b6b808b72f39189b32b2d358415bf03e 100644 (file)
@@ -33,9 +33,9 @@
 #include <deal.II/lac/solver_qmrs.h>
 #include <deal.II/lac/precondition.h>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER             &solver,
+check_solve (SolverType         &solver,
              const MatrixType   &A,
              VectorType         &u,
              VectorType         &f,
@@ -53,9 +53,9 @@ check_solve (SOLVER             &solver,
     }
 }
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_Tsolve (SOLVER             &solver,
+check_Tsolve (SolverType         &solver,
               const MatrixType   &A,
               VectorType         &u,
               VectorType         &f,
index 0f1a953a0676db84e25d642bb1862c557b236065..63c1f21644becbdecdbd6e243f10b1fe15282f41 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/lac/precondition.h>
 #include <deal.II/base/point.h>
 
-template<class SOLVER>
+template<typename SolverType>
 void test()
 {
   const unsigned int size = 3;
@@ -50,7 +50,7 @@ void test()
   rhs(size-1)=1.0;
 
   SolverControl solvctrl(1000, 1e-12, true);
-  SOLVER solver(solvctrl);
+  SolverType solver(solvctrl);
 
   PreconditionIdentity precond;
   solver.solve(mat, solvec, rhs, precond);
index d4898feddfa0a1e89574323dbd38a8eaaaf313a2..70901f995293599971af48ce0c08f0ccb606aaed 100644 (file)
 #include <deal.II/lac/solver_qmrs.h>
 #include <deal.II/lac/precondition.h>
 
-template<class SOLVER, typename MatrixType, typename VectorType>
+template<typename SolverType, typename MatrixType, typename VectorType>
 void
 check_solve (const MatrixType &A,
              VectorType       &u,
              VectorType       &f,
-             const typename SOLVER::AdditionalData &additional_data = typename SOLVER::AdditionalData())
+             const typename SolverType::AdditionalData &additional_data = typename SolverType::AdditionalData())
 {
   GrowingVectorMemory<> mem;
   SolverControl control(100, 1.e-3);
-  SOLVER solver(control, mem, additional_data);
+  SolverType solver(control, mem, additional_data);
   PreconditionIdentity prec_no;
   u = 0.;
   f = 0.;
index 95117e362d511de08c8684b95beb10838c354c4d..0bfce6f09f499b32b54c9e9fa72405317788ae64 100644 (file)
@@ -56,9 +56,9 @@ SolverControl::State monitor_mean (const unsigned int    iteration,
 
 
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER             &solver,
+check_solve (SolverType         &solver,
              const MatrixType   &A,
              VectorType         &u,
              VectorType         &f,
index 5f24c537ef045469ca41851bc30effa5d00e384a..347098f9beef8be38736eb90af9eba5daaf75688 100644 (file)
@@ -57,9 +57,9 @@ SolverControl::State monitor_mean (const unsigned int    iteration,
 
 
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER             &solver,
+check_solve (SolverType         &solver,
              const MatrixType   &A,
              VectorType         &u,
              VectorType         &f,
index ed65e00f4a6e6f57149f4e70827b442497dcc80c..78666d9852c28a0e75ac1aaccf99a7691ee4cb32 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/solver_relaxation.h>
 #include <deal.II/lac/precondition.h>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 double
-check_solve (SOLVER             &solver,
+check_solve (SolverType         &solver,
              const MatrixType   &A,
              VectorType         &u,
              VectorType         &f,
index 6dc2f2488d662f12c318313dcb25c1387fb42ed1..f4c12cbde47f1cb4d1a8c3ab54b147f893f69a7c 100644 (file)
@@ -32,9 +32,9 @@
 #include <deal.II/lac/precondition_block.h>
 #include <deal.II/lac/relaxation_block.h>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 double
-check_solve (SOLVER             &solver,
+check_solve (SolverType         &solver,
              const MatrixType   &A,
              VectorType         &u,
              VectorType         &f,
index 732025f8cf2fee034af114ed4274d0f7d57f6407..967cee9f577426c8f8b571943c5848b6d997fac6 100644 (file)
@@ -33,9 +33,9 @@
 #include <deal.II/lac/precondition_block.h>
 #include <deal.II/lac/relaxation_block.h>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 double
-check_solve (SOLVER             &solver,
+check_solve (SolverType         &solver,
              const MatrixType   &A,
              VectorType         &u,
              VectorType         &f,
index 0a3403d57703dddae7b7941d5453218c4bbe1c56..05624bd3b611fa0da21f1d107cd903b5b2e3c546 100644 (file)
@@ -56,9 +56,9 @@ void output_eigenvalues(const std::vector<NUMBER> &eigenvalues,const std::string
   deallog << std::endl;
 }
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER             &solver,
+check_solve(SolverType         &solver,
             const MatrixType   &A,
             VectorType         &u,
             VectorType         &f,
index 6fd86f7f8f253f5c9d0022e9d7cd06254e1d323d..8bd1f669ef08edcfb46e4562102964f93ba8b890 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/solver_cg.h>
 #include <deal.II/lac/precondition.h>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER             &solver,
+check_solve (SolverType         &solver,
              const MatrixType   &A,
              VectorType         &u,
              VectorType         &f,
@@ -51,9 +51,9 @@ check_solve (SOLVER             &solver,
     }
 }
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_Tsolve (SOLVER             &solver,
+check_Tsolve (SolverType         &solver,
               const MatrixType   &A,
               VectorType         &u,
               VectorType         &f,
index 9288c2ba7ebcb2b4077ecbc3792b3681b4524f8f..4d740080adaba096d29ed9fd01b7ce086fa6ee07 100644 (file)
@@ -36,9 +36,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index a14c05b22d90eaf678d7399e92350f78e4c56b0f..53f3e400af5be28fd042f7aa4e05ae93cec5b3a2 100644 (file)
@@ -38,9 +38,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 135450af6423e68f7d9601f4142d3a871f492e43..b931525d7702d7d9f4197b7fff2e59f6804e8e7c 100644 (file)
@@ -38,9 +38,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index e6445e3957a9f9cf856a2206f2d125e90f4a8eb5..833ae67518beebf774f57eab3d0713ec0eef0f8a 100644 (file)
@@ -37,9 +37,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 140c05d79f882aeedfa6b9876240fdc64305224d..9f32fa82fcbdd5ebfc085760793046ccd2b0fd03 100644 (file)
@@ -36,9 +36,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 9d737150617102723ffd2bb4bed984a06f8ad809..f36956040c25189027342faa351ead4ea02839fc 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index b6b5a3ea91e5c68138077f97ee911208c546806a..0bb8d4c2a41e7d03aa1970fe284b91a5efb6f28f 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 1f59a77fd564066090f860608c2180980665969b..7afdd64a81c4b9317e6f243f2ee93b6890451ca8 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 0d4830e4f84e020fc4f839fcef9f3130778d0161..6278a0e9e0eb8b6813c179877789e0c2cac753ee 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index b38ab3dc310896c1d948b42ba817e4895174b75e..035474c58e59277591e4305e9e9ddef587e9d4e1 100644 (file)
@@ -32,9 +32,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index b8dc6220e6450fc1bbea1b35c49b0c4f51f0c135..54d393b642db277b874b895a75c31861e8da9a65 100644 (file)
@@ -33,9 +33,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 87e4a88c0966cba8d4f1176a2c658687a9475ac5..0a938359f75ad80dadfa03e3595d9498d552a9ec 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 928748450deee9ae07372b0f189568db66848798..f0237facf0368e6948c99dc05d0c2bffb7833450 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index b2f88152afb94f821a04aae58e41e39a1b786c8c..2fb422214bc82f148ea0b98a2976f07867fa3ab5 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index bb5f490185fc7d5248a4bae0675f4c9f2b170e87..21c8b1853c20deb4e3c5939832f22109a5840da5 100644 (file)
@@ -32,9 +32,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index dc60da81192cb6786cb13e484a8437febd879639..f072bec1841e91450639d3cdb9a6f329d1868a7f 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 6981a6809390a2fe2e8b859bcdc689b9769a3c98..0715195ff293c8b7d8fe7774f12e6e38886de9d4 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 7c74c68ded3c9189f2b0b658c56880fe499a5ce7..9d616c87d4d503cc7ecfdc675db7a34838f39950 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 861040d33e1d4ab41fc0c448d50645bbaef721ef..925126853741db5688bfb2e97ad101f896fabe6f 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 4a545a36dad40a7b45f908b254f4606acd11a7a9..b04f04fdc5e8404ebbd0c6f23e4b19d6fc1a9d8e 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index c2936fd25c21f0365716d8bc55af743cee0c07ba..3b995714454c03ecfc176a3e9d8dc733b47ee97b 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index f6ce5d2e741cfeabc5016998f03ad2687adfbaa3..729ab899cfa1e8e0d965b56aff6de42ab8315731 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index be055d6900af1c606ae9e53cae83030f049c5f43..cb8e37e89ee11a298b6e674ea979867a9f3131dc 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 537c67ebefc04f655f2dec540db99227564edef2..0340633cf5b8a422761ededa1b2a0b5400e4db3c 100644 (file)
@@ -35,9 +35,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index d81940bb01a4fa4e01fe468acd865e86251df9a9..5d05b2367ecae632b070fb9397a67bab4e1aed07 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 4c4649b10a0068ad10a20acb48cf87ac68194299..891573671b21d251eb437f8049b41d070f110e93 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 0c5d64f3b96b378b58d160f26823086152f5d351..1e07758f7f08f9a719e3580087962496d2c55aaf 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index c1f17344c9f321a9d8d3e803ebc770b7334e5f76..4964446ca4d1be2f067d37a098e055e76d485a8f 100644 (file)
@@ -31,9 +31,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve(SOLVER              &solver,
+check_solve(SolverType          &solver,
             const SolverControl &solver_control,
             const MatrixType    &A,
             VectorType          &u,
index 278548a86094c8c9980b9c4a5f7d14cac7a12fed..d04746bf91dd8021a14292dad6b6eb1f0650d69a 100644 (file)
@@ -35,9 +35,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType>
+template<typename SolverType, typename MatrixType, typename VectorType>
 void
-check_solve( SOLVER &solver,
+check_solve( SolverType &solver,
              const SolverControl &solver_control,
              const MatrixType &A, const MatrixType &B,
              std::vector<VectorType> &u, std::vector<PetscScalar > &v)
index 5a15b3a1e74941b50aa6652b2d1caf06f67d1ce5..a66ea084050c17e041ad8a522982418880ce4d00 100644 (file)
@@ -35,9 +35,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType>
+template<typename SolverType, typename MatrixType, typename VectorType>
 void
-check_solve( SOLVER &solver,
+check_solve( SolverType &solver,
              const SolverControl &solver_control,
              const MatrixType &A,
              std::vector<VectorType> &u, std::vector<PetscScalar > &v)
index e86eeb3f065f4095660a24895da7d7571737b6b1..d410715be9af33c6b4e324b11187785682197f36 100644 (file)
@@ -162,16 +162,16 @@ std::string unify_pretty_function (const std::string &text)
 /*
  * Test that a solver converged within a certain range of iteration steps.
  *
- * SOLVER_COMMAND is the command to issue, CONTROL_COMMAND a function call
+ * SolverType_COMMAND is the command to issue, CONTROL_COMMAND a function call
  * that returns the number of iterations (castable to unsigned int), and
  * MIN_ALLOWED, MAX_ALLOWED is the inclusive range of allowed iteration
  * steps.
  */
 
-#define check_solver_within_range(SOLVER_COMMAND, CONTROL_COMMAND, MIN_ALLOWED, MAX_ALLOWED) \
+#define check_solver_within_range(SolverType_COMMAND, CONTROL_COMMAND, MIN_ALLOWED, MAX_ALLOWED) \
   {                                                                              \
     const unsigned int previous_depth = deallog.depth_file(0);                   \
-    SOLVER_COMMAND;                                                              \
+    SolverType_COMMAND;                                                              \
     deallog.depth_file(previous_depth);                                          \
     const unsigned int steps = CONTROL_COMMAND;                                  \
     if (steps >= MIN_ALLOWED && steps <= MAX_ALLOWED)                            \
index e2fa9b596d445acf71bd2c764f2dbe386f439a95..6c66c8620f78e11e892781464982437b66d6bc24 100644 (file)
@@ -37,9 +37,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER              &solver,
+check_solve (SolverType          &solver,
              const SolverControl &solver_control,
              const MatrixType    &A,
              VectorType          &u,
index e44aadc644364d738136fa535914c0323bd12e18..332be4b7aa9e8b2311f09b7b13d5ce14a0d61da3 100644 (file)
@@ -39,9 +39,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER              &solver,
+check_solve (SolverType          &solver,
              const SolverControl &solver_control,
              const MatrixType    &A,
              VectorType          &u,
index 29eaab2da0ffdd0b5fba1ca702def38ae95e2ce0..b4ec15114a0c8881ac5951a9bac3dc8e8b45d8a3 100644 (file)
@@ -39,9 +39,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER              &solver,
+check_solve (SolverType          &solver,
              const SolverControl &solver_control,
              const MatrixType    &A,
              VectorType          &u,
index 094f169c06ca40a70b39d1c68530e4da6ecf999b..1bd3072a3a9a4e4bafc41890246a7ad9f0d6cb7d 100644 (file)
@@ -38,9 +38,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER              &solver,
+check_solve (SolverType          &solver,
              const SolverControl &solver_control,
              const MatrixType    &A,
              VectorType          &u,
index a617559f351df731a28207423d4aa4f5eb5160da..1387ef1b59a56e28dd5229b8ac0c692f5a896370 100644 (file)
@@ -37,9 +37,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER              &solver,
+check_solve (SolverType          &solver,
              const SolverControl &solver_control,
              const MatrixType    &A,
              VectorType          &u,
index 8bc5610389c0efe5acb62089767c2b513c580e89..ce10b27a8406d3cc436a4b1800515ccdac271b07 100644 (file)
@@ -37,9 +37,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER              &solver,
+check_solve (SolverType          &solver,
              const SolverControl &solver_control,
              const MatrixType    &A,
              VectorType          &u,
index b4c138fa66df8e077edca3e98f6e9a84f09a0d02..e93bef66409a4b29c7684d0b6b98ff78dfd678f5 100644 (file)
@@ -32,9 +32,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER              &solver,
+check_solve (SolverType          &solver,
              const SolverControl &solver_control,
              const MatrixType    &A,
              VectorType          &u,
index 17f1970d892cdb4c8ecffc467fdb5c9c73f6aced..b7bb690683c65dede5a575ecbd78c810a209ec3c 100644 (file)
@@ -32,9 +32,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER              &solver,
+check_solve (SolverType          &solver,
              const SolverControl &solver_control,
              const MatrixType    &A,
              VectorType          &u,
index 4777b9e381bcb5f7f09fc0854d42932c8122b358..2a376bf1fce0f2828a5b4220eee858b42defd592 100644 (file)
@@ -32,9 +32,9 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
+template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
-check_solve (SOLVER              &solver,
+check_solve (SolverType          &solver,
              const SolverControl &solver_control,
              const MatrixType    &A,
              VectorType          &u,

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.