// explicit instantiations for SparseMatrixUMFPACK
-#define InstantiateUMFPACK(MATRIX) \
- template \
- void SparseDirectUMFPACK::factorize (const MATRIX &); \
- template \
- void SparseDirectUMFPACK::solve (const MATRIX &, \
- Vector<double> &, \
- bool); \
- template \
- void SparseDirectUMFPACK::solve (const MATRIX &, \
- BlockVector<double> &, \
- bool); \
- template \
- void SparseDirectUMFPACK::initialize (const MATRIX &, \
+#define InstantiateUMFPACK(MatrixType) \
+ template \
+ void SparseDirectUMFPACK::factorize (const MatrixType &); \
+ template \
+ void SparseDirectUMFPACK::solve (const MatrixType &, \
+ Vector<double> &, \
+ bool); \
+ template \
+ void SparseDirectUMFPACK::solve (const MatrixType &, \
+ BlockVector<double> &, \
+ bool); \
+ template \
+ void SparseDirectUMFPACK::initialize (const MatrixType &, \
const AdditionalData);
InstantiateUMFPACK(SparseMatrix<double>)
#include <deal.II/lac/precondition.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/precondition.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
using namespace dealii;
-template <class DOFINFO, class MATRIX>
-void test(DOFINFO &info, MeshWorker::Assembler::MatrixSimple<MATRIX> &ass)
+template <class DOFINFO, typename MatrixType>
+void test(DOFINFO &info, MeshWorker::Assembler::MatrixSimple<MatrixType> &ass)
{
ass.initialize_info(info, false);
deallog << "No faces" << std::endl;
using namespace dealii;
-template <class DOFINFO, class MATRIX>
-void test(DOFINFO &info, MeshWorker::Assembler::MatrixSimple<MATRIX> &ass)
+template <class DOFINFO, typename MatrixType>
+void test(DOFINFO &info, MeshWorker::Assembler::MatrixSimple<MatrixType> &ass)
{
ass.initialize_info(info, false);
deallog << "No faces" << std::endl;
using namespace dealii;
-template <class DOFINFO, class MATRIX>
-void test(DOFINFO &info, MeshWorker::Assembler::MGMatrixSimple<MATRIX> &ass)
+template <class DOFINFO, typename MatrixType>
+void test(DOFINFO &info, MeshWorker::Assembler::MGMatrixSimple<MatrixType> &ass)
{
ass.initialize_info(info, false);
deallog << "No faces" << std::endl;
using namespace dealii;
-template<class PRECONDITIONER, class MATRIX, typename VectorType,
+template<class PRECONDITIONER, typename MatrixType, typename VectorType,
class ADDITIONAL_DATA = typename PRECONDITIONER::AdditionalData>
void
-test_preconditioner (const MATRIX &A,
+test_preconditioner (const MatrixType &A,
const VectorType &b,
const ADDITIONAL_DATA &data = ADDITIONAL_DATA())
{
#include <deal.II/lac/solver_qmrs.h>
#include <deal.II/lac/precondition.h>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve (SOLVER &solver,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
}
}
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_Tsolve (SOLVER &solver,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/solver_qmrs.h>
#include <deal.II/lac/precondition.h>
-template<class SOLVER, class MATRIX, typename VectorType>
+template<class SOLVER, typename MatrixType, typename VectorType>
void
-check_solve (const MATRIX &A,
- VectorType &u,
- VectorType &f,
+check_solve (const MatrixType &A,
+ VectorType &u,
+ VectorType &f,
const typename SOLVER::AdditionalData &additional_data = typename SOLVER::AdditionalData())
{
GrowingVectorMemory<> mem;
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve (SOLVER &solver,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve (SOLVER &solver,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/solver_relaxation.h>
#include <deal.II/lac/precondition.h>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
double
check_solve (SOLVER &solver,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/precondition_block.h>
#include <deal.II/lac/relaxation_block.h>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
double
check_solve (SOLVER &solver,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/precondition_block.h>
#include <deal.II/lac/relaxation_block.h>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
double
check_solve (SOLVER &solver,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <fstream>
-template <class MATRIX, typename VectorType>
+template <typename MatrixType, typename VectorType>
void
-check (const MATRIX &A, const VectorType &f)
+check (const MatrixType &A, const VectorType &f)
{
std::vector<std::string> names;
names.push_back("cg");
-template <class MATRIX, typename VectorType>
+template <typename MatrixType, typename VectorType>
void
-check(const MATRIX &A, const VectorType &f)
+check(const MatrixType &A, const VectorType &f)
{
std::vector<std::string> names;
names.push_back("cg");
deallog << std::endl;
}
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
deallog.pop(); \
residuals.push_back(control.last_value())
-template<class MATRIX>
+template<typename MatrixType>
void
-check_vmult_quadratic(std::vector<double> &residuals,
- const MATRIX &A,
- const char *prefix)
+check_vmult_quadratic (std::vector<double> &residuals,
+ const MatrixType &A,
+ const char *prefix)
{
deallog.push(prefix);
const types::global_dof_index block_size = (types::global_dof_index) std::sqrt(A.n()+.3);
const unsigned int n_blocks = A.n()/block_size;
- typename PreconditionBlock<MATRIX, float>::AdditionalData
+ typename PreconditionBlock<MatrixType, float>::AdditionalData
data(block_size, 1.2);
std::vector<types::global_dof_index> perm(A.n());
std::vector<types::global_dof_index> iperm(A.n());
}
PreconditionIdentity identity;
- PreconditionJacobi<MATRIX> jacobi;
+ PreconditionJacobi<MatrixType> jacobi;
jacobi.initialize(A, .5);
- PreconditionSOR<MATRIX> sor;
+ PreconditionSOR<MatrixType> sor;
sor.initialize(A, 1.2);
-// PreconditionPSOR<MATRIX> psor;
+// PreconditionPSOR<MatrixType> psor;
// psor.initialize(A, perm, iperm, 1.2);
- PreconditionSSOR<MATRIX> ssor;
+ PreconditionSSOR<MatrixType> ssor;
ssor.initialize(A, 1.2);
- PreconditionBlockJacobi<MATRIX, float> block_jacobi;
+ PreconditionBlockJacobi<MatrixType, float> block_jacobi;
block_jacobi.initialize(A, data);
- PreconditionBlockSSOR<MATRIX, float> block_ssor;
+ PreconditionBlockSSOR<MatrixType, float> block_ssor;
block_ssor.initialize(A, data);
- PreconditionBlockSOR<MATRIX, float> block_sor;
+ PreconditionBlockSOR<MatrixType, float> block_sor;
block_sor.initialize(A, data);
- PreconditionBlockSOR<MATRIX, float> block_psor;
+ PreconditionBlockSOR<MatrixType, float> block_psor;
block_psor.set_permutation(perm, iperm);
block_psor.initialize(A, data);
}
-template <class MATRIX>
+template <typename MatrixType>
void
-check_iterator (const MATRIX &A)
+check_iterator (const MatrixType &A)
{
// deallog.push("it");
- typename MATRIX::const_iterator E = A.end();
+ typename MatrixType::const_iterator E = A.end();
if (A.m() < 10)
for (unsigned int r=0; r<A.m(); ++r)
{
- typename MATRIX::const_iterator b = A.begin(r);
+ typename MatrixType::const_iterator b = A.begin(r);
if (b == E)
deallog << "Final" << std::endl;
else
<< '\t' << b->column()
<< '\t' << b->value()
<< std::endl;
- typename MATRIX::const_iterator e = A.end(r);
+ typename MatrixType::const_iterator e = A.end(r);
if (e == E)
deallog << "Final" << std::endl;
else
<< std::endl;
deallog << "cols:";
- for (typename MATRIX::const_iterator i=b; i!=e; ++i)
+ for (typename MatrixType::const_iterator i=b; i!=e; ++i)
deallog << '\t' << ',' << i->column();
deallog << std::endl;
}
- for (typename MATRIX::const_iterator i = A.begin(); i!= A.end(); ++i)
+ for (typename MatrixType::const_iterator i = A.begin(); i!= A.end(); ++i)
deallog << '\t' << i->row()
<< '\t' << i->column()
<< '\t' << i->value()
<< std::endl;
deallog << "Repeat row 2" << std::endl;
- for (typename MATRIX::const_iterator i = A.begin(2); i!= A.end(2); ++i)
+ for (typename MatrixType::const_iterator i = A.begin(2); i!= A.end(2); ++i)
deallog << '\t' << i->row()
<< '\t' << i->column()
<< '\t' << i->value()
/**
* Fill the matrix with values.
*/
- template <typename MATRIX>
- void five_point(MATRIX &, bool nonsymmetric = false) const;
+ template <typename MatrixType>
+ void five_point(MatrixType &, bool nonsymmetric = false) const;
/**
* Fill the matrix with values.
*/
- template <typename MATRIX>
- void nine_point(MATRIX &, bool nonsymmetric = false) const;
+ template <typename MatrixType>
+ void nine_point(MatrixType &, bool nonsymmetric = false) const;
/**
* Fill the matrix with values.
*/
- template <typename MATRIX>
- void upwind(MATRIX &, bool back = false) const;
+ template <typename MatrixType>
+ void upwind(MatrixType &, bool back = false) const;
template <typename number>
void gnuplot_print(std::ostream &, const Vector<number> &) const;
-template<typename MATRIX>
+template<typename MatrixType>
void
-FDMatrix::nine_point(MATRIX &A, bool) const
+FDMatrix::nine_point(MatrixType &A, bool) const
{
for (unsigned int i=0; i<=ny-2; i++)
{
}
}
-template<typename MATRIX>
+template<typename MatrixType>
inline
void
-FDMatrix::five_point(MATRIX &A, bool nonsymmetric) const
+FDMatrix::five_point(MatrixType &A, bool nonsymmetric) const
{
for (unsigned int i=0; i<=ny-2; i++)
{
-template<typename MATRIX>
+template<typename MatrixType>
inline
void
-FDMatrix::upwind(MATRIX &A, bool back) const
+FDMatrix::upwind(MatrixType &A, bool back) const
{
for (unsigned int i=0; i<=ny-2; i++)
{
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve (SOLVER &solver,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
}
}
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_Tsolve (SOLVER &solver,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
-template <typename MATRIX>
+template <typename MatrixType>
class MGTransferPrebuiltMF : public MGTransferPrebuilt<parallel::distributed::Vector<double> >
{
public:
- MGTransferPrebuiltMF(const MGLevelObject<MATRIX> &laplace)
+ MGTransferPrebuiltMF(const MGLevelObject<MatrixType> &laplace)
:
laplace_operator (laplace)
{};
}
private:
- const MGLevelObject<MATRIX> &laplace_operator;
+ const MGLevelObject<MatrixType> &laplace_operator;
};
-template<typename MATRIX, typename Number>
+template<typename MatrixType, typename Number>
class MGCoarseIterative : public MGCoarseGridBase<parallel::distributed::Vector<Number> >
{
public:
MGCoarseIterative() {}
- void initialize(const MATRIX &matrix)
+ void initialize(const MatrixType &matrix)
{
coarse_matrix = &matrix;
}
solver_coarse.solve (*coarse_matrix, dst, src, PreconditionIdentity());
}
- const MATRIX *coarse_matrix;
+ const MatrixType *coarse_matrix;
};
//----------------------------------------------------------------------//
-template<class MATRIX, class RELAX>
-void check_smoother(const MGLevelObject<MATRIX> &m,
+template<typename MatrixType, class RELAX>
+void check_smoother(const MGLevelObject<MatrixType> &m,
const MGLevelObject<RELAX> &r)
{
GrowingVectorMemory<BlockVector<double> > mem;
- MGSmootherBlock<MATRIX, RELAX, double> smoother(mem);
+ MGSmootherBlock<MatrixType, RELAX, double> smoother(mem);
smoother.initialize(m, r);
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
-check_solve(SOLVER &solver,
+check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve(SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve (SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve (SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
-check_solve (SOLVER &solver,
+check_solve (SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
- VectorType &u,
- VectorType &f,
- const PRECONDITION &P)
+ const MatrixType &A,
+ VectorType &u,
+ VectorType &f,
+ const PRECONDITION &P)
{
deallog << "Solver type: " << typeid(solver).name() << std::endl;
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve (SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve (SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve (SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve (SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve (SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/lac/vector_memory.h>
#include <typeinfo>
-template<class SOLVER, class MATRIX, typename VectorType, class PRECONDITION>
+template<class SOLVER, typename MatrixType, typename VectorType, class PRECONDITION>
void
check_solve (SOLVER &solver,
const SolverControl &solver_control,
- const MATRIX &A,
+ const MatrixType &A,
VectorType &u,
VectorType &f,
const PRECONDITION &P)
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
-template <int dim, typename MATRIX, typename VectorType>
-void assemble_laplace (MATRIX &B, VectorType &bb, DoFHandler<dim> &dof_handler, FiniteElement<dim> &fe)
+template <int dim, typename MatrixType, typename VectorType>
+void assemble_laplace (MatrixType &B,
+ VectorType &bb,
+ DoFHandler<dim> &dof_handler,
+ FiniteElement<dim> &fe)
{
QGauss<dim> quadrature_formula(2);
FEValues<dim> fe_values (fe, quadrature_formula,