From: David Wells Date: Fri, 30 Oct 2015 15:05:49 +0000 (-0400) Subject: More VECTOR -> VectorType X-Git-Tag: v8.4.0-rc2~230^2~13 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=33f5ef96b7765724211b39fcce16867698ab5a2f;p=dealii.git More VECTOR -> VectorType --- diff --git a/tests/bits/deal_solver_04.cc b/tests/bits/deal_solver_04.cc index 40a1ad990f..26e983ab81 100644 --- a/tests/bits/deal_solver_04.cc +++ b/tests/bits/deal_solver_04.cc @@ -37,12 +37,14 @@ #include #include -template +template 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; diff --git a/tests/bits/deal_solver_05.cc b/tests/bits/deal_solver_05.cc index eea0ad83f0..fda2642d8a 100644 --- a/tests/bits/deal_solver_05.cc +++ b/tests/bits/deal_solver_05.cc @@ -36,12 +36,14 @@ #include #include -template +template 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; diff --git a/tests/gla/extract_subvector_to.cc b/tests/gla/extract_subvector_to.cc index 743c156198..18828a0efc 100644 --- a/tests/gla/extract_subvector_to.cc +++ b/tests/gla/extract_subvector_to.cc @@ -15,7 +15,7 @@ -// test the various VECTOR::extract_subvector_to functions +// test the various VectorType::extract_subvector_to functions #include "../tests.h" #include diff --git a/tests/matrix_free/inverse_mass_01.cc b/tests/matrix_free/inverse_mass_01.cc index bc00eaec20..c0e99df1fe 100644 --- a/tests/matrix_free/inverse_mass_01.cc +++ b/tests/matrix_free/inverse_mass_01.cc @@ -39,7 +39,7 @@ std::ofstream logfile("output"); -template > +template > class MatrixFreeTest { public: @@ -49,9 +49,9 @@ public: {}; void - local_mass_operator (const MatrixFree &data, - VECTOR &dst, - const VECTOR &src, + local_mass_operator (const MatrixFree &data, + VectorType &dst, + const VectorType &src, const std::pair &cell_range) const { FEEvaluation fe_eval (data); @@ -70,9 +70,9 @@ public: } void - local_inverse_mass_operator (const MatrixFree &data, - VECTOR &dst, - const VECTOR &src, + local_inverse_mass_operator (const MatrixFree &data, + VectorType &dst, + const VectorType &src, const std::pair &cell_range) const { FEEvaluation 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::local_mass_operator, + data.cell_loop (&MatrixFreeTest::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::local_inverse_mass_operator, + data.cell_loop (&MatrixFreeTest::local_inverse_mass_operator, this, dst, src); }; diff --git a/tests/matrix_free/inverse_mass_02.cc b/tests/matrix_free/inverse_mass_02.cc index 744c42f87b..f1cd6b03d7 100644 --- a/tests/matrix_free/inverse_mass_02.cc +++ b/tests/matrix_free/inverse_mass_02.cc @@ -39,7 +39,7 @@ std::ofstream logfile("output"); -template > +template > class MatrixFreeTest { public: @@ -49,9 +49,9 @@ public: {}; void - local_mass_operator (const MatrixFree &data, - VECTOR &dst, - const VECTOR &src, + local_mass_operator (const MatrixFree &data, + VectorType &dst, + const VectorType &src, const std::pair &cell_range) const { FEEvaluation fe_eval (data); @@ -70,9 +70,9 @@ public: } void - local_inverse_mass_operator (const MatrixFree &data, - VECTOR &dst, - const VECTOR &src, + local_inverse_mass_operator (const MatrixFree &data, + VectorType &dst, + const VectorType &src, const std::pair &cell_range) const { FEEvaluation 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::local_mass_operator, + data.cell_loop (&MatrixFreeTest::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::local_inverse_mass_operator, + data.cell_loop (&MatrixFreeTest::local_inverse_mass_operator, this, dst, src); }; diff --git a/tests/matrix_free/inverse_mass_03.cc b/tests/matrix_free/inverse_mass_03.cc index 2b2b01f478..708a17ef3c 100644 --- a/tests/matrix_free/inverse_mass_03.cc +++ b/tests/matrix_free/inverse_mass_03.cc @@ -40,7 +40,7 @@ std::ofstream logfile("output"); -template > +template > class MatrixFreeTest { public: @@ -50,9 +50,9 @@ public: {}; void - local_mass_operator (const MatrixFree &data, - VECTOR &dst, - const VECTOR &src, + local_mass_operator (const MatrixFree &data, + VectorType &dst, + const VectorType &src, const std::pair &cell_range) const { FEEvaluation fe_eval (data); @@ -77,9 +77,9 @@ public: } void - local_inverse_mass_operator (const MatrixFree &data, - VECTOR &dst, - const VECTOR &src, + local_inverse_mass_operator (const MatrixFree &data, + VectorType &dst, + const VectorType &src, const std::pair &cell_range) const { FEEvaluation 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::local_mass_operator, + data.cell_loop (&MatrixFreeTest::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::local_inverse_mass_operator, + data.cell_loop (&MatrixFreeTest::local_inverse_mass_operator, this, dst, src); }; diff --git a/tests/matrix_free/matrix_vector_15.cc b/tests/matrix_free/matrix_vector_15.cc index 9d12f576d4..850fc18bb9 100644 --- a/tests/matrix_free/matrix_vector_15.cc +++ b/tests/matrix_free/matrix_vector_15.cc @@ -41,21 +41,21 @@ std::ofstream logfile("output"); -template > +template > class MatrixFreeTest { public: - MatrixFreeTest(const DoFHandler &dof_handler, + MatrixFreeTest(const DoFHandler &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 fe_eval(dof_handler.get_fe(), QGauss<1>(fe_degree+1), diff --git a/tests/matrix_free/matrix_vector_16.cc b/tests/matrix_free/matrix_vector_16.cc index 8f619c10c0..6f1872032a 100644 --- a/tests/matrix_free/matrix_vector_16.cc +++ b/tests/matrix_free/matrix_vector_16.cc @@ -41,21 +41,21 @@ std::ofstream logfile("output"); -template > +template > class MatrixFreeTest { public: - MatrixFreeTest(const DoFHandler &dof_handler, - const ConstraintMatrix &constraints) + MatrixFreeTest (const DoFHandler &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 fe_eval (dof_handler.get_fe(), QGauss<1>(fe_degree+1), diff --git a/tests/matrix_free/matrix_vector_18.cc b/tests/matrix_free/matrix_vector_18.cc index f3c5e596c0..f6f0d10c57 100644 --- a/tests/matrix_free/matrix_vector_18.cc +++ b/tests/matrix_free/matrix_vector_18.cc @@ -42,7 +42,7 @@ -template > +template > 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::local_operation, + data.cell_loop (&MatrixFreeTest::local_operation, this, dst, src); }; private: const MatrixFree &data; - void local_operation (const MatrixFree &data, - VECTOR &out, - const VECTOR &in, + void local_operation (const MatrixFree &data, + VectorType &out, + const VectorType &in, const std::pair &cell_range) const { FEEvaluation fe_eval (data); diff --git a/tests/matrix_free/matrix_vector_mf.h b/tests/matrix_free/matrix_vector_mf.h index f55fcc88ae..c6318cdf37 100644 --- a/tests/matrix_free/matrix_vector_mf.h +++ b/tests/matrix_free/matrix_vector_mf.h @@ -18,14 +18,14 @@ #include -template +template void -helmholtz_operator (const MatrixFree &data, - VECTOR &dst, - const VECTOR &src, - const std::pair &cell_range) +helmholtz_operator (const MatrixFree &data, + VectorType &dst, + const VectorType &src, + const std::pair &cell_range) { - typedef typename VECTOR::value_type Number; + typedef typename VectorType::value_type Number; FEEvaluation fe_eval (data); const unsigned int n_q_points = fe_eval.n_q_points; @@ -46,7 +46,7 @@ helmholtz_operator (const MatrixFree &data, -template > +template > 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 &, - VECTOR &, - const VECTOR &, + const std_cxx11::function &, + VectorType &, + const VectorType &, const std::pair &)> - wrap = helmholtz_operator; + wrap = helmholtz_operator; data.cell_loop (wrap, dst, src); }; diff --git a/tests/multigrid/cycles.cc b/tests/multigrid/cycles.cc index 0e2812ab97..eb2026e42f 100644 --- a/tests/multigrid/cycles.cc +++ b/tests/multigrid/cycles.cc @@ -32,35 +32,35 @@ #include #define N 3 -typedef Vector VECTOR; +typedef Vector VectorType; class MGAll : - public MGSmootherBase, - public MGTransferBase, - public MGCoarseGridBase + public MGSmootherBase, + public MGTransferBase, + public MGCoarseGridBase { 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 > level_matrices(0, maxlevel); for (unsigned int i=0; i<=maxlevel; ++i) level_matrices[i].reinit(N, N); - mg::Matrix mgmatrix(level_matrices); + mg::Matrix mgmatrix(level_matrices); - Multigrid mg1(minlevel, maxlevel, mgmatrix, all, all, all, all, - Multigrid::v_cycle); + Multigrid mg1(minlevel, maxlevel, mgmatrix, all, all, all, all, + Multigrid::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::w_cycle); + mg1.set_cycle(Multigrid::w_cycle); mg1.cycle(); deallog << std::endl; - mg1.set_cycle(Multigrid::f_cycle); + mg1.set_cycle(Multigrid::f_cycle); mg1.cycle(); } diff --git a/tests/multigrid/smoother_block.cc b/tests/multigrid/smoother_block.cc index 1371545f3c..f8056188b8 100644 --- a/tests/multigrid/smoother_block.cc +++ b/tests/multigrid/smoother_block.cc @@ -43,8 +43,8 @@ public: /** * Apply preconditioner. */ - template - void vmult (VECTOR &, const VECTOR &) const; + template + void vmult (VectorType &, const VectorType &) const; /** * Apply transpose @@ -53,13 +53,13 @@ public: * the same as * vmult(). */ - template - void Tvmult (VECTOR &, const VECTOR &) const; + template + void Tvmult (VectorType &, const VectorType &) const; /** * Apply preconditioner, adding to the previous value. */ - template - void vmult_add (VECTOR &, const VECTOR &) const; + template + void vmult_add (VectorType &, const VectorType &) const; /** * Apply transpose @@ -68,8 +68,8 @@ public: * the same as * vmult_add(). */ - template - void Tvmult_add (VECTOR &, const VECTOR &) const; + template + void Tvmult_add (VectorType &, const VectorType &) const; private: number factor; @@ -86,25 +86,25 @@ ScalingMatrix::ScalingMatrix(number factor) template -template +template inline void -ScalingMatrix::vmult (VECTOR &dst, const VECTOR &src) const +ScalingMatrix::vmult (VectorType &dst, const VectorType &src) const { dst.equ(factor, src); } template -template +template inline void -ScalingMatrix::Tvmult (VECTOR &dst, const VECTOR &src) const +ScalingMatrix::Tvmult (VectorType &dst, const VectorType &src) const { dst.equ(factor, src); } template -template +template inline void -ScalingMatrix::vmult_add (VECTOR &dst, const VECTOR &src) const +ScalingMatrix::vmult_add (VectorType &dst, const VectorType &src) const { dst.add(factor, src); } @@ -112,9 +112,9 @@ ScalingMatrix::vmult_add (VECTOR &dst, const VECTOR &src) const template -template +template inline void -ScalingMatrix::Tvmult_add (VECTOR &dst, const VECTOR &src) const +ScalingMatrix::Tvmult_add (VectorType &dst, const VectorType &src) const { dst.add(factor, src); } diff --git a/tests/petsc/deal_solver_01.cc b/tests/petsc/deal_solver_01.cc index 8aef923f4c..e16bdf2fa1 100644 --- a/tests/petsc/deal_solver_01.cc +++ b/tests/petsc/deal_solver_01.cc @@ -36,12 +36,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/deal_solver_02.cc b/tests/petsc/deal_solver_02.cc index 5b9df1e086..07e6f97929 100644 --- a/tests/petsc/deal_solver_02.cc +++ b/tests/petsc/deal_solver_02.cc @@ -38,12 +38,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/deal_solver_03.cc b/tests/petsc/deal_solver_03.cc index 5b0a4509a7..da4cb38357 100644 --- a/tests/petsc/deal_solver_03.cc +++ b/tests/petsc/deal_solver_03.cc @@ -38,12 +38,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/deal_solver_04.cc b/tests/petsc/deal_solver_04.cc index 7e232a3601..9299c37545 100644 --- a/tests/petsc/deal_solver_04.cc +++ b/tests/petsc/deal_solver_04.cc @@ -37,12 +37,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/deal_solver_05.cc b/tests/petsc/deal_solver_05.cc index 0e8027b749..8af9ebbc44 100644 --- a/tests/petsc/deal_solver_05.cc +++ b/tests/petsc/deal_solver_05.cc @@ -36,12 +36,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_01.cc b/tests/petsc/solver_01.cc index 32229e2555..339d58d460 100644 --- a/tests/petsc/solver_01.cc +++ b/tests/petsc/solver_01.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_02.cc b/tests/petsc/solver_02.cc index 1d8bd425ff..41ba75be17 100644 --- a/tests/petsc/solver_02.cc +++ b/tests/petsc/solver_02.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_03.cc b/tests/petsc/solver_03.cc index c5a0571787..1c525a7577 100644 --- a/tests/petsc/solver_03.cc +++ b/tests/petsc/solver_03.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_03_mf.cc b/tests/petsc/solver_03_mf.cc index 6b9f6b2fa3..e912f89f3e 100644 --- a/tests/petsc/solver_03_mf.cc +++ b/tests/petsc/solver_03_mf.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_03_precondition_boomeramg.cc b/tests/petsc/solver_03_precondition_boomeramg.cc index 8861d2b025..526a0dec7d 100644 --- a/tests/petsc/solver_03_precondition_boomeramg.cc +++ b/tests/petsc/solver_03_precondition_boomeramg.cc @@ -32,12 +32,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_03_precondition_boomeramg_symmetric.cc b/tests/petsc/solver_03_precondition_boomeramg_symmetric.cc index b4e092ec2c..7e7b64b510 100644 --- a/tests/petsc/solver_03_precondition_boomeramg_symmetric.cc +++ b/tests/petsc/solver_03_precondition_boomeramg_symmetric.cc @@ -33,12 +33,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_03_precondition_eisenstat.cc b/tests/petsc/solver_03_precondition_eisenstat.cc index e6a7392fa1..842fb95649 100644 --- a/tests/petsc/solver_03_precondition_eisenstat.cc +++ b/tests/petsc/solver_03_precondition_eisenstat.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_03_precondition_icc.cc b/tests/petsc/solver_03_precondition_icc.cc index 2a7f10876a..a59ea2055a 100644 --- a/tests/petsc/solver_03_precondition_icc.cc +++ b/tests/petsc/solver_03_precondition_icc.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_03_precondition_ilu.cc b/tests/petsc/solver_03_precondition_ilu.cc index 18f382071e..f1b4e26387 100644 --- a/tests/petsc/solver_03_precondition_ilu.cc +++ b/tests/petsc/solver_03_precondition_ilu.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_03_precondition_lu.cc b/tests/petsc/solver_03_precondition_lu.cc index 57a821f8e1..f9fa7f582d 100644 --- a/tests/petsc/solver_03_precondition_lu.cc +++ b/tests/petsc/solver_03_precondition_lu.cc @@ -32,12 +32,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_03_precondition_parasails.cc b/tests/petsc/solver_03_precondition_parasails.cc index 7a79ae0f9d..8e5dc6d212 100644 --- a/tests/petsc/solver_03_precondition_parasails.cc +++ b/tests/petsc/solver_03_precondition_parasails.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_03_precondition_sor.cc b/tests/petsc/solver_03_precondition_sor.cc index fa9f2e292c..027ce627ff 100644 --- a/tests/petsc/solver_03_precondition_sor.cc +++ b/tests/petsc/solver_03_precondition_sor.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_03_precondition_ssor.cc b/tests/petsc/solver_03_precondition_ssor.cc index 90ad0826b3..0206677e6e 100644 --- a/tests/petsc/solver_03_precondition_ssor.cc +++ b/tests/petsc/solver_03_precondition_ssor.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_04.cc b/tests/petsc/solver_04.cc index 78b11c2ff9..3a7be18369 100644 --- a/tests/petsc/solver_04.cc +++ b/tests/petsc/solver_04.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_05.cc b/tests/petsc/solver_05.cc index 327a465118..9b876fc291 100644 --- a/tests/petsc/solver_05.cc +++ b/tests/petsc/solver_05.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_06.cc b/tests/petsc/solver_06.cc index dd9795c462..443df43616 100644 --- a/tests/petsc/solver_06.cc +++ b/tests/petsc/solver_06.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_07.cc b/tests/petsc/solver_07.cc index b93e99cec5..efb516b7f3 100644 --- a/tests/petsc/solver_07.cc +++ b/tests/petsc/solver_07.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_08.cc b/tests/petsc/solver_08.cc index ec6268a11a..1ae58cff99 100644 --- a/tests/petsc/solver_08.cc +++ b/tests/petsc/solver_08.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_09.cc b/tests/petsc/solver_09.cc index b7421238dc..8d4f080a48 100644 --- a/tests/petsc/solver_09.cc +++ b/tests/petsc/solver_09.cc @@ -35,12 +35,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_10.cc b/tests/petsc/solver_10.cc index 0086dc0d58..ce2b743424 100644 --- a/tests/petsc/solver_10.cc +++ b/tests/petsc/solver_10.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_11.cc b/tests/petsc/solver_11.cc index e088e3ec1f..95b238247c 100644 --- a/tests/petsc/solver_11.cc +++ b/tests/petsc/solver_11.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_12.cc b/tests/petsc/solver_12.cc index a24a04e4e2..c145d4a248 100644 --- a/tests/petsc/solver_12.cc +++ b/tests/petsc/solver_12.cc @@ -31,12 +31,14 @@ #include #include -template +template 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; diff --git a/tests/petsc/solver_13.cc b/tests/petsc/solver_13.cc index 12e3415b6a..e481a3299e 100644 --- a/tests/petsc/solver_13.cc +++ b/tests/petsc/solver_13.cc @@ -31,12 +31,14 @@ #include #include -template +template 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;