#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType>
+template<class SOLVER, typename MatrixType, typename VectorType>
void
check_solve( SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A, const MATRIX &B,
+ const MatrixType &A, const MatrixType &B,
std::vector<VectorType> &u, std::vector<PetscScalar > &v)
{
deallog << "Solver type: " << typeid(solver).name() << std::endl;
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType>
+template<class SOLVER, typename MatrixType, typename VectorType>
void
check_solve( SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
std::vector<VectorType> &u, std::vector<PetscScalar > &v)
{
deallog << "Solver type: " << typeid(solver).name() << std::endl;
/**
* Fill the matrix with values.
*/
- template <typename MATRIX>
- void diag(MATRIX &) const;
+ template <typename MatrixType>
+ void diag(MatrixType &) const;
template <typename number>
void gnuplot_print(std::ostream &, const Vector<number> &) const;
}
-template<typename MATRIX>
+template<typename MatrixType>
inline
void
-FDDiagMatrix::diag(MATRIX &A) const
+FDDiagMatrix::diag(MatrixType &A) const
{
for (unsigned int i=0; i<=ny-2; i++)
{
/**
* Fill the matrix with values.
*/
- template <typename MATRIX>
- void three_point(MATRIX &) const;
+ template <typename MatrixType>
+ void three_point(MatrixType &) const;
private:
/**
}
-template<typename MATRIX>
+template<typename MatrixType>
inline
void
-FD1DLaplaceMatrix::three_point(MATRIX &A) const
+FD1DLaplaceMatrix::three_point(MatrixType &A) const
{
for (unsigned int i=0; i<=n-2; i++)
{