From: David Wells Date: Thu, 12 Nov 2015 19:49:29 +0000 (-0500) Subject: Prefer SolverType to SOLVER. X-Git-Tag: v8.4.0-rc2~230^2~4 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=67dee9909c94220c0fbae7949fbb632a81af2020;p=dealii.git Prefer SolverType to SOLVER. --- diff --git a/include/deal.II/multigrid/mg_coarse.h b/include/deal.II/multigrid/mg_coarse.h index 65a5eaffa5..628414b8cc 100644 --- a/include/deal.II/multigrid/mg_coarse.h +++ b/include/deal.II/multigrid/mg_coarse.h @@ -37,7 +37,7 @@ DEAL_II_NAMESPACE_OPEN * * @author Guido Kanschat, 1999, Ralf Hartmann, 2002. */ -template > +template > class MGCoarseGridLACIteration : public MGCoarseGridBase { public: @@ -51,7 +51,7 @@ public: * use. */ template - MGCoarseGridLACIteration (SOLVER &, + MGCoarseGridLACIteration (SolverType &, const MatrixType &, const PRECOND &); @@ -64,7 +64,7 @@ public: * Initialize new data. */ template - void initialize (SOLVER &, + void initialize (SolverType &, const MatrixType &, const PRECOND &); @@ -92,7 +92,7 @@ private: /** * Reference to the solver. */ - SmartPointer > solver; + SmartPointer > solver; /** * Reference to the matrix. @@ -187,8 +187,8 @@ private: /* ------------------ Functions for MGCoarseGridLACIteration ------------ */ -template -MGCoarseGridLACIteration +template +MGCoarseGridLACIteration ::MGCoarseGridLACIteration() : solver(0, typeid(*this).name()), @@ -197,10 +197,10 @@ MGCoarseGridLACIteration {} -template +template template -MGCoarseGridLACIteration -::MGCoarseGridLACIteration (SOLVER &s, +MGCoarseGridLACIteration +::MGCoarseGridLACIteration (SolverType &s, const MatrixType &m, const PRECOND &p) : @@ -211,19 +211,19 @@ MGCoarseGridLACIteration } -template -MGCoarseGridLACIteration +template +MGCoarseGridLACIteration ::~MGCoarseGridLACIteration() { clear(); } -template +template template void -MGCoarseGridLACIteration -::initialize (SOLVER &s, +MGCoarseGridLACIteration +::initialize (SolverType &s, const MatrixType &m, const PRECOND &p) { @@ -237,9 +237,9 @@ MGCoarseGridLACIteration } -template +template void -MGCoarseGridLACIteration +MGCoarseGridLACIteration ::clear() { solver = 0; @@ -252,9 +252,9 @@ MGCoarseGridLACIteration } -template +template void -MGCoarseGridLACIteration +MGCoarseGridLACIteration ::operator() (const unsigned int /* level */, VectorType &dst, const VectorType &src) const @@ -266,10 +266,10 @@ MGCoarseGridLACIteration } -template +template template void -MGCoarseGridLACIteration +MGCoarseGridLACIteration ::set_matrix(const MatrixType &m) { if (matrix) diff --git a/include/deal.II/numerics/dof_print_solver_step.h b/include/deal.II/numerics/dof_print_solver_step.h index 09f1001249..366cd60e1d 100644 --- a/include/deal.II/numerics/dof_print_solver_step.h +++ b/include/deal.II/numerics/dof_print_solver_step.h @@ -49,8 +49,8 @@ DEAL_II_NAMESPACE_OPEN * @ingroup output * @author Guido Kanschat, 2000 */ -template > -class DoFPrintSolverStep : public SOLVER +template > +class DoFPrintSolverStep : public SolverType { public: /** @@ -87,24 +87,24 @@ private: /* ----------------------- template functions --------------- */ -template -DoFPrintSolverStep::DoFPrintSolverStep +template +DoFPrintSolverStep::DoFPrintSolverStep (SolverControl &control, VectorMemory &mem, DataOut &data_out, const std::string &basename) - : SOLVER (control, mem), + : SolverType (control, mem), out (data_out), basename (basename) {} -template +template void -DoFPrintSolverStep::print_vectors (const unsigned int step, - const VectorType &x, - const VectorType &r, - const VectorType &d) const +DoFPrintSolverStep::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"); diff --git a/tests/bits/deal_solver_04.cc b/tests/bits/deal_solver_04.cc index c37e564262..0b85461237 100644 --- a/tests/bits/deal_solver_04.cc +++ b/tests/bits/deal_solver_04.cc @@ -37,9 +37,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/bits/deal_solver_05.cc b/tests/bits/deal_solver_05.cc index edfc14e2a2..242795d7bc 100644 --- a/tests/bits/deal_solver_05.cc +++ b/tests/bits/deal_solver_05.cc @@ -36,9 +36,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/lac/linear_operator_08.cc b/tests/lac/linear_operator_08.cc index 67214e7997..00afe7e226 100644 --- a/tests/lac/linear_operator_08.cc +++ b/tests/lac/linear_operator_08.cc @@ -129,7 +129,7 @@ test_preconditioner (const SparseMatrix &A, } } -template +template void test_solver (const SparseMatrix &A, const Vector &b) @@ -138,7 +138,7 @@ test_solver (const SparseMatrix &A, { deallog.push("Standard solver"); SolverControl solver_control (100, 1.0e-10); - SOLVER solver (solver_control); + SolverType solver (solver_control); PreconditionJacobi< SparseMatrix > preconditioner; preconditioner.initialize(A); @@ -156,7 +156,7 @@ test_solver (const SparseMatrix &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 > preconditioner; preconditioner.initialize(A); @@ -322,7 +322,7 @@ int main() } deallog.pop(); - // === SOLVERS === + // === SolverTypes === deallog << std::endl; deallog << "Solvers" << std::endl; deallog.push("Solvers"); diff --git a/tests/lac/solver.cc b/tests/lac/solver.cc index d6573c9ed0..d0bdea93b6 100644 --- a/tests/lac/solver.cc +++ b/tests/lac/solver.cc @@ -33,9 +33,9 @@ #include #include -template +template 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 +template void -check_Tsolve (SOLVER &solver, +check_Tsolve (SolverType &solver, const MatrixType &A, VectorType &u, VectorType &f, diff --git a/tests/lac/solver_02.cc b/tests/lac/solver_02.cc index 0f1a953a06..63c1f21644 100644 --- a/tests/lac/solver_02.cc +++ b/tests/lac/solver_02.cc @@ -32,7 +32,7 @@ #include #include -template +template 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); diff --git a/tests/lac/solver_memorytest.cc b/tests/lac/solver_memorytest.cc index d4898feddf..70901f9952 100644 --- a/tests/lac/solver_memorytest.cc +++ b/tests/lac/solver_memorytest.cc @@ -39,16 +39,16 @@ #include #include -template +template 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.; diff --git a/tests/lac/solver_monitor.cc b/tests/lac/solver_monitor.cc index 95117e362d..0bfce6f09f 100644 --- a/tests/lac/solver_monitor.cc +++ b/tests/lac/solver_monitor.cc @@ -56,9 +56,9 @@ SolverControl::State monitor_mean (const unsigned int iteration, -template +template void -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const MatrixType &A, VectorType &u, VectorType &f, diff --git a/tests/lac/solver_monitor_disconnect.cc b/tests/lac/solver_monitor_disconnect.cc index 5f24c537ef..347098f9be 100644 --- a/tests/lac/solver_monitor_disconnect.cc +++ b/tests/lac/solver_monitor_disconnect.cc @@ -57,9 +57,9 @@ SolverControl::State monitor_mean (const unsigned int iteration, -template +template void -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const MatrixType &A, VectorType &u, VectorType &f, diff --git a/tests/lac/solver_relaxation_01.cc b/tests/lac/solver_relaxation_01.cc index ed65e00f4a..78666d9852 100644 --- a/tests/lac/solver_relaxation_01.cc +++ b/tests/lac/solver_relaxation_01.cc @@ -31,9 +31,9 @@ #include #include -template +template double -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const MatrixType &A, VectorType &u, VectorType &f, diff --git a/tests/lac/solver_relaxation_02.cc b/tests/lac/solver_relaxation_02.cc index 6dc2f2488d..f4c12cbde4 100644 --- a/tests/lac/solver_relaxation_02.cc +++ b/tests/lac/solver_relaxation_02.cc @@ -32,9 +32,9 @@ #include #include -template +template double -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const MatrixType &A, VectorType &u, VectorType &f, diff --git a/tests/lac/solver_relaxation_03.cc b/tests/lac/solver_relaxation_03.cc index 732025f8cf..967cee9f57 100644 --- a/tests/lac/solver_relaxation_03.cc +++ b/tests/lac/solver_relaxation_03.cc @@ -33,9 +33,9 @@ #include #include -template +template double -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const MatrixType &A, VectorType &u, VectorType &f, diff --git a/tests/lac/solver_signals.cc b/tests/lac/solver_signals.cc index 0a3403d577..05624bd3b6 100644 --- a/tests/lac/solver_signals.cc +++ b/tests/lac/solver_signals.cc @@ -56,9 +56,9 @@ void output_eigenvalues(const std::vector &eigenvalues,const std::string deallog << std::endl; } -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const MatrixType &A, VectorType &u, VectorType &f, diff --git a/tests/lapack/solver_cg.cc b/tests/lapack/solver_cg.cc index 6fd86f7f8f..8bd1f669ef 100644 --- a/tests/lapack/solver_cg.cc +++ b/tests/lapack/solver_cg.cc @@ -31,9 +31,9 @@ #include #include -template +template 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 +template void -check_Tsolve (SOLVER &solver, +check_Tsolve (SolverType &solver, const MatrixType &A, VectorType &u, VectorType &f, diff --git a/tests/petsc/deal_solver_01.cc b/tests/petsc/deal_solver_01.cc index 9288c2ba7e..4d740080ad 100644 --- a/tests/petsc/deal_solver_01.cc +++ b/tests/petsc/deal_solver_01.cc @@ -36,9 +36,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/deal_solver_02.cc b/tests/petsc/deal_solver_02.cc index a14c05b22d..53f3e400af 100644 --- a/tests/petsc/deal_solver_02.cc +++ b/tests/petsc/deal_solver_02.cc @@ -38,9 +38,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/deal_solver_03.cc b/tests/petsc/deal_solver_03.cc index 135450af64..b931525d77 100644 --- a/tests/petsc/deal_solver_03.cc +++ b/tests/petsc/deal_solver_03.cc @@ -38,9 +38,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/deal_solver_04.cc b/tests/petsc/deal_solver_04.cc index e6445e3957..833ae67518 100644 --- a/tests/petsc/deal_solver_04.cc +++ b/tests/petsc/deal_solver_04.cc @@ -37,9 +37,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/deal_solver_05.cc b/tests/petsc/deal_solver_05.cc index 140c05d79f..9f32fa82fc 100644 --- a/tests/petsc/deal_solver_05.cc +++ b/tests/petsc/deal_solver_05.cc @@ -36,9 +36,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_01.cc b/tests/petsc/solver_01.cc index 9d73715061..f36956040c 100644 --- a/tests/petsc/solver_01.cc +++ b/tests/petsc/solver_01.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_02.cc b/tests/petsc/solver_02.cc index b6b5a3ea91..0bb8d4c2a4 100644 --- a/tests/petsc/solver_02.cc +++ b/tests/petsc/solver_02.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_03.cc b/tests/petsc/solver_03.cc index 1f59a77fd5..7afdd64a81 100644 --- a/tests/petsc/solver_03.cc +++ b/tests/petsc/solver_03.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_03_mf.cc b/tests/petsc/solver_03_mf.cc index 0d4830e4f8..6278a0e9e0 100644 --- a/tests/petsc/solver_03_mf.cc +++ b/tests/petsc/solver_03_mf.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_03_precondition_boomeramg.cc b/tests/petsc/solver_03_precondition_boomeramg.cc index b38ab3dc31..035474c58e 100644 --- a/tests/petsc/solver_03_precondition_boomeramg.cc +++ b/tests/petsc/solver_03_precondition_boomeramg.cc @@ -32,9 +32,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_03_precondition_boomeramg_symmetric.cc b/tests/petsc/solver_03_precondition_boomeramg_symmetric.cc index b8dc6220e6..54d393b642 100644 --- a/tests/petsc/solver_03_precondition_boomeramg_symmetric.cc +++ b/tests/petsc/solver_03_precondition_boomeramg_symmetric.cc @@ -33,9 +33,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_03_precondition_eisenstat.cc b/tests/petsc/solver_03_precondition_eisenstat.cc index 87e4a88c09..0a938359f7 100644 --- a/tests/petsc/solver_03_precondition_eisenstat.cc +++ b/tests/petsc/solver_03_precondition_eisenstat.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_03_precondition_icc.cc b/tests/petsc/solver_03_precondition_icc.cc index 928748450d..f0237facf0 100644 --- a/tests/petsc/solver_03_precondition_icc.cc +++ b/tests/petsc/solver_03_precondition_icc.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_03_precondition_ilu.cc b/tests/petsc/solver_03_precondition_ilu.cc index b2f88152af..2fb422214b 100644 --- a/tests/petsc/solver_03_precondition_ilu.cc +++ b/tests/petsc/solver_03_precondition_ilu.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_03_precondition_lu.cc b/tests/petsc/solver_03_precondition_lu.cc index bb5f490185..21c8b1853c 100644 --- a/tests/petsc/solver_03_precondition_lu.cc +++ b/tests/petsc/solver_03_precondition_lu.cc @@ -32,9 +32,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_03_precondition_parasails.cc b/tests/petsc/solver_03_precondition_parasails.cc index dc60da8119..f072bec184 100644 --- a/tests/petsc/solver_03_precondition_parasails.cc +++ b/tests/petsc/solver_03_precondition_parasails.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_03_precondition_sor.cc b/tests/petsc/solver_03_precondition_sor.cc index 6981a68093..0715195ff2 100644 --- a/tests/petsc/solver_03_precondition_sor.cc +++ b/tests/petsc/solver_03_precondition_sor.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_03_precondition_ssor.cc b/tests/petsc/solver_03_precondition_ssor.cc index 7c74c68ded..9d616c87d4 100644 --- a/tests/petsc/solver_03_precondition_ssor.cc +++ b/tests/petsc/solver_03_precondition_ssor.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_04.cc b/tests/petsc/solver_04.cc index 861040d33e..9251268537 100644 --- a/tests/petsc/solver_04.cc +++ b/tests/petsc/solver_04.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_05.cc b/tests/petsc/solver_05.cc index 4a545a36da..b04f04fdc5 100644 --- a/tests/petsc/solver_05.cc +++ b/tests/petsc/solver_05.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_06.cc b/tests/petsc/solver_06.cc index c2936fd25c..3b99571445 100644 --- a/tests/petsc/solver_06.cc +++ b/tests/petsc/solver_06.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_07.cc b/tests/petsc/solver_07.cc index f6ce5d2e74..729ab899cf 100644 --- a/tests/petsc/solver_07.cc +++ b/tests/petsc/solver_07.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_08.cc b/tests/petsc/solver_08.cc index be055d6900..cb8e37e89e 100644 --- a/tests/petsc/solver_08.cc +++ b/tests/petsc/solver_08.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_09.cc b/tests/petsc/solver_09.cc index 537c67ebef..0340633cf5 100644 --- a/tests/petsc/solver_09.cc +++ b/tests/petsc/solver_09.cc @@ -35,9 +35,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_10.cc b/tests/petsc/solver_10.cc index d81940bb01..5d05b2367e 100644 --- a/tests/petsc/solver_10.cc +++ b/tests/petsc/solver_10.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_11.cc b/tests/petsc/solver_11.cc index 4c4649b10a..891573671b 100644 --- a/tests/petsc/solver_11.cc +++ b/tests/petsc/solver_11.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_12.cc b/tests/petsc/solver_12.cc index 0c5d64f3b9..1e07758f7f 100644 --- a/tests/petsc/solver_12.cc +++ b/tests/petsc/solver_12.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/petsc/solver_13.cc b/tests/petsc/solver_13.cc index c1f17344c9..4964446ca4 100644 --- a/tests/petsc/solver_13.cc +++ b/tests/petsc/solver_13.cc @@ -31,9 +31,9 @@ #include #include -template +template void -check_solve(SOLVER &solver, +check_solve(SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/slepc/solve_01.cc b/tests/slepc/solve_01.cc index 278548a860..d04746bf91 100644 --- a/tests/slepc/solve_01.cc +++ b/tests/slepc/solve_01.cc @@ -35,9 +35,9 @@ #include #include -template +template void -check_solve( SOLVER &solver, +check_solve( SolverType &solver, const SolverControl &solver_control, const MatrixType &A, const MatrixType &B, std::vector &u, std::vector &v) diff --git a/tests/slepc/solve_04.cc b/tests/slepc/solve_04.cc index 5a15b3a1e7..a66ea08405 100644 --- a/tests/slepc/solve_04.cc +++ b/tests/slepc/solve_04.cc @@ -35,9 +35,9 @@ #include #include -template +template void -check_solve( SOLVER &solver, +check_solve( SolverType &solver, const SolverControl &solver_control, const MatrixType &A, std::vector &u, std::vector &v) diff --git a/tests/tests.h b/tests/tests.h index e86eeb3f06..d410715be9 100644 --- a/tests/tests.h +++ b/tests/tests.h @@ -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) \ diff --git a/tests/trilinos/deal_solver_01.cc b/tests/trilinos/deal_solver_01.cc index e2fa9b596d..6c66c8620f 100644 --- a/tests/trilinos/deal_solver_01.cc +++ b/tests/trilinos/deal_solver_01.cc @@ -37,9 +37,9 @@ #include #include -template +template void -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/trilinos/deal_solver_02.cc b/tests/trilinos/deal_solver_02.cc index e44aadc644..332be4b7aa 100644 --- a/tests/trilinos/deal_solver_02.cc +++ b/tests/trilinos/deal_solver_02.cc @@ -39,9 +39,9 @@ #include #include -template +template void -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/trilinos/deal_solver_03.cc b/tests/trilinos/deal_solver_03.cc index 29eaab2da0..b4ec15114a 100644 --- a/tests/trilinos/deal_solver_03.cc +++ b/tests/trilinos/deal_solver_03.cc @@ -39,9 +39,9 @@ #include #include -template +template void -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/trilinos/deal_solver_04.cc b/tests/trilinos/deal_solver_04.cc index 094f169c06..1bd3072a3a 100644 --- a/tests/trilinos/deal_solver_04.cc +++ b/tests/trilinos/deal_solver_04.cc @@ -38,9 +38,9 @@ #include #include -template +template void -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/trilinos/deal_solver_05.cc b/tests/trilinos/deal_solver_05.cc index a617559f35..1387ef1b59 100644 --- a/tests/trilinos/deal_solver_05.cc +++ b/tests/trilinos/deal_solver_05.cc @@ -37,9 +37,9 @@ #include #include -template +template void -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/trilinos/deal_solver_06.cc b/tests/trilinos/deal_solver_06.cc index 8bc5610389..ce10b27a84 100644 --- a/tests/trilinos/deal_solver_06.cc +++ b/tests/trilinos/deal_solver_06.cc @@ -37,9 +37,9 @@ #include #include -template +template void -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/trilinos/solver_03.cc b/tests/trilinos/solver_03.cc index b4c138fa66..e93bef6640 100644 --- a/tests/trilinos/solver_03.cc +++ b/tests/trilinos/solver_03.cc @@ -32,9 +32,9 @@ #include #include -template +template void -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/trilinos/solver_05.cc b/tests/trilinos/solver_05.cc index 17f1970d89..b7bb690683 100644 --- a/tests/trilinos/solver_05.cc +++ b/tests/trilinos/solver_05.cc @@ -32,9 +32,9 @@ #include #include -template +template void -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u, diff --git a/tests/trilinos/solver_07.cc b/tests/trilinos/solver_07.cc index 4777b9e381..2a376bf1fc 100644 --- a/tests/trilinos/solver_07.cc +++ b/tests/trilinos/solver_07.cc @@ -32,9 +32,9 @@ #include #include -template +template void -check_solve (SOLVER &solver, +check_solve (SolverType &solver, const SolverControl &solver_control, const MatrixType &A, VectorType &u,