PARALUTION  1.0.0
PARALUTION
paralution::DPCG< OperatorType, VectorType, ValueType > Class Template Reference

#include <dpcg.hpp>

Inheritance diagram for paralution::DPCG< OperatorType, VectorType, ValueType >:
paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType > paralution::Solver< OperatorType, VectorType, ValueType > paralution::ParalutionObj

Public Member Functions

 DPCG ()
 
virtual ~DPCG ()
 
virtual void Print (void) const
 Print information about the solver. More...
 
virtual void Build (void)
 Build the solver (data allocation, structure computation, numerical computation) More...
 
virtual void Clear (void)
 Clear (free all local data) the solver. More...
 
virtual void SetNVectors (const int novecni)
 
void Init (const double abs_tol, const double rel_tol, const double div_tol, const int max_iter)
 Initialize the solver with absolute/relative/divergence tolerance and maximum number of iterations. More...
 
void Init (const double abs_tol, const double rel_tol, const double div_tol, const int min_iter, const int max_iter)
 Initialize the solver with absolute/relative/divergence tolerance and minimum/maximum number of iterations. More...
 
void InitMinIter (const int min_iter)
 Set the minimum number of iterations. More...
 
void InitMaxIter (const int max_iter)
 Set the maximum number of iterations. More...
 
void InitTol (const double abs, const double rel, const double div)
 Set the absolute/relative/divergence tolerance. More...
 
void SetResidualNorm (const int resnorm)
 Set the residual norm to L1, L2 or Inf norm resnorm == 1 L1 Norm resnorm == 2 L2 Norm (default) resnorm == 3 Inf Norm. More...
 
void RecordResidualHistory (void)
 Record the residual history. More...
 
void RecordHistory (const std::string filename) const
 Write the history to file. More...
 
virtual void Verbose (const int verb=1)
 Provide verbose output of the solver: verb == 0 no output verb == 1 print info about the solver (start,end); verb == 2 print (iter, residual) via iteration control;. More...
 
virtual void Solve (const VectorType &rhs, VectorType *x)
 Solve Operator x = rhs. More...
 
virtual void SetPreconditioner (Solver< OperatorType, VectorType, ValueType > &precond)
 Set a preconditioner of the linear solver. More...
 
virtual int GetIterationCount (void)
 Return the iteration count. More...
 
virtual double GetCurrentResidual (void)
 Return the current residual. More...
 
virtual int GetSolverStatus (void)
 Return the current status. More...
 
virtual int GetAmaxResidualIndex (void)
 Return absolute maximum index of residual vector when using Linf norm. More...
 
void SetOperator (const OperatorType &op)
 Set the Operator of the solver. More...
 
virtual void ResetOperator (const OperatorType &op)
 Reset the operator; see ReBuildNumeric. More...
 
virtual void SolveZeroSol (const VectorType &rhs, VectorType *x)
 Solve Operator x = rhs; but set first the init x = 0. More...
 
virtual void ReBuildNumeric (void)
 Rebuild only with numerical computation (no allocation or data structure computation) More...
 
virtual void MoveToHost (void)
 Move all the data (i.e. move the solver) to the host. More...
 
virtual void MoveToAccelerator (void)
 Move all the data (i.e. move the solver) to the accelerator. More...
 

Protected Member Functions

virtual void SolveNonPrecond_ (const VectorType &rhs, VectorType *x)
 Non-preconditioner solution procedure. More...
 
virtual void SolvePrecond_ (const VectorType &rhs, VectorType *x)
 Preconditioned solution procedure. More...
 
virtual void PrintStart_ (void) const
 Print starting msg of the solver. More...
 
virtual void PrintEnd_ (void) const
 Print ending msg of the solver. More...
 
virtual void MoveToHostLocalData_ (void)
 Move all local data to the host. More...
 
virtual void MoveToAcceleratorLocalData_ (void)
 Move all local data to the accelerator. More...
 
ValueType Norm (const VectorType &vec)
 Computes the vector norm. More...
 

Protected Attributes

IterationControl iter_ctrl_
 Iteration control (monitor) More...
 
int res_norm_
 Residual norm res_norm = 1 L1 Norm res_norm = 2 L2 Norm res_norm = 3 Linf Norm. More...
 
int index_
 Absolute maximum index of residual vector when using Linf norm. More...
 
const OperatorType * op_
 Pointer to the operator. More...
 
Solver< OperatorType, VectorType, ValueType > * precond_
 Pointer to the defined preconditioner. More...
 
bool build_
 Flag == true after building the solver (e.g. Build()) More...
 
LocalVector< intpermutation_
 Permutation vector (used if the solver performs permutation/re-ordering techniques) More...
 
int verb_
 Verbose flag verb == 0 no output verb == 1 print info about the solver (start,end); verb == 2 print (iter, residual) via iteration control;. More...
 
size_t global_obj_id
 

Private Member Functions

void MakeZ_COO (void)
 
void MakeZ_CSR (void)
 

Private Attributes

OperatorType L_
 
OperatorType LT_
 
OperatorType AZ_
 
OperatorType ZT_
 
OperatorType Z_
 
OperatorType AZT_
 
OperatorType E_
 
VectorType r_
 
VectorType w_
 
VectorType p_
 
VectorType q_
 
VectorType Dinv_
 
VectorType hat_
 
VectorType intmed_
 
VectorType Qb_
 
VectorType Ptx_
 
VectorType LLtx_
 
VectorType LLtx2_
 
int novecni_
 

Constructor & Destructor Documentation

template<class OperatorType , class VectorType , typename ValueType >
paralution::DPCG< OperatorType, VectorType, ValueType >::DPCG ( )
template<class OperatorType , class VectorType , typename ValueType >
paralution::DPCG< OperatorType, VectorType, ValueType >::~DPCG ( )
virtual

Member Function Documentation

template<class OperatorType , class VectorType , typename ValueType >
void paralution::DPCG< OperatorType, VectorType, ValueType >::Build ( void  )
virtual

Build the solver (data allocation, structure computation, numerical computation)

Reimplemented from paralution::Solver< OperatorType, VectorType, ValueType >.

Referenced by main().

template<class OperatorType , class VectorType , typename ValueType >
void paralution::DPCG< OperatorType, VectorType, ValueType >::Clear ( void  )
virtual

Clear (free all local data) the solver.

Reimplemented from paralution::Solver< OperatorType, VectorType, ValueType >.

Referenced by main().

template<class OperatorType , class VectorType , typename ValueType >
int paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::GetAmaxResidualIndex ( void  )
virtualinherited

Return absolute maximum index of residual vector when using Linf norm.

template<class OperatorType , class VectorType , typename ValueType >
double paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::GetCurrentResidual ( void  )
virtualinherited

Return the current residual.

Referenced by paralution_fortran_solve().

template<class OperatorType , class VectorType , typename ValueType >
int paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::GetIterationCount ( void  )
virtualinherited

Return the iteration count.

Referenced by paralution_fortran_solve().

template<class OperatorType , class VectorType , typename ValueType >
int paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::GetSolverStatus ( void  )
virtualinherited

Return the current status.

Referenced by paralution_fortran_solve().

template<class OperatorType , class VectorType , typename ValueType >
void paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::Init ( const double  abs_tol,
const double  rel_tol,
const double  div_tol,
const int  max_iter 
)
inherited

Initialize the solver with absolute/relative/divergence tolerance and maximum number of iterations.

Referenced by paralution::BaseAMG< OperatorType, VectorType, ValueType >::Build(), main(), mexFunction(), paralution_fortran_solve(), and paralution_solve().

template<class OperatorType , class VectorType , typename ValueType >
void paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::Init ( const double  abs_tol,
const double  rel_tol,
const double  div_tol,
const int  min_iter,
const int  max_iter 
)
inherited

Initialize the solver with absolute/relative/divergence tolerance and minimum/maximum number of iterations.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::InitMaxIter ( const int  max_iter)
inherited

Set the maximum number of iterations.

Referenced by main().

template<class OperatorType , class VectorType , typename ValueType >
void paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::InitMinIter ( const int  min_iter)
inherited

Set the minimum number of iterations.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::InitTol ( const double  abs,
const double  rel,
const double  div 
)
inherited

Set the absolute/relative/divergence tolerance.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::DPCG< OperatorType, VectorType, ValueType >::MakeZ_COO ( void  )
private
template<class OperatorType , class VectorType , typename ValueType >
void paralution::DPCG< OperatorType, VectorType, ValueType >::MakeZ_CSR ( void  )
private
template<class OperatorType , class VectorType , typename ValueType >
void paralution::Solver< OperatorType, VectorType, ValueType >::MoveToAccelerator ( void  )
virtualinherited

Move all the data (i.e. move the solver) to the accelerator.

Referenced by main(), mexFunction(), and paralution_fortran_solve().

template<class OperatorType , class VectorType , typename ValueType >
void paralution::DPCG< OperatorType, VectorType, ValueType >::MoveToAcceleratorLocalData_ ( void  )
protectedvirtual

Move all local data to the accelerator.

Implements paralution::Solver< OperatorType, VectorType, ValueType >.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::Solver< OperatorType, VectorType, ValueType >::MoveToHost ( void  )
virtualinherited

Move all the data (i.e. move the solver) to the host.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::DPCG< OperatorType, VectorType, ValueType >::MoveToHostLocalData_ ( void  )
protectedvirtual

Move all local data to the host.

Implements paralution::Solver< OperatorType, VectorType, ValueType >.

template<class OperatorType , class VectorType, typename ValueType >
ValueType paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::Norm ( const VectorType &  vec)
protectedinherited

Computes the vector norm.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::DPCG< OperatorType, VectorType, ValueType >::Print ( void  ) const
virtual

Print information about the solver.

Implements paralution::Solver< OperatorType, VectorType, ValueType >.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::DPCG< OperatorType, VectorType, ValueType >::PrintEnd_ ( void  ) const
protectedvirtual

Print ending msg of the solver.

Implements paralution::Solver< OperatorType, VectorType, ValueType >.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::DPCG< OperatorType, VectorType, ValueType >::PrintStart_ ( void  ) const
protectedvirtual

Print starting msg of the solver.

Implements paralution::Solver< OperatorType, VectorType, ValueType >.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::Solver< OperatorType, VectorType, ValueType >::ReBuildNumeric ( void  )
virtualinherited
template<class OperatorType , class VectorType , typename ValueType >
void paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::RecordHistory ( const std::string  filename) const
inherited

Write the history to file.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::RecordResidualHistory ( void  )
inherited

Record the residual history.

template<class OperatorType, class VectorType , typename ValueType >
void paralution::Solver< OperatorType, VectorType, ValueType >::ResetOperator ( const OperatorType &  op)
virtualinherited
template<class OperatorType , class VectorType , typename ValueType >
void paralution::DPCG< OperatorType, VectorType, ValueType >::SetNVectors ( const int  novecni)
virtual

Referenced by main().

template<class OperatorType, class VectorType , typename ValueType >
void paralution::Solver< OperatorType, VectorType, ValueType >::SetOperator ( const OperatorType &  op)
inherited
template<class OperatorType, class VectorType, typename ValueType>
void paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::SetPreconditioner ( Solver< OperatorType, VectorType, ValueType > &  precond)
virtualinherited
template<class OperatorType , class VectorType , typename ValueType >
void paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::SetResidualNorm ( const int  resnorm)
inherited

Set the residual norm to L1, L2 or Inf norm resnorm == 1 L1 Norm resnorm == 2 L2 Norm (default) resnorm == 3 Inf Norm.

template<class OperatorType , class VectorType, typename ValueType >
void paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::Solve ( const VectorType &  rhs,
VectorType *  x 
)
virtualinherited
template<class OperatorType , class VectorType , typename ValueType >
void paralution::DPCG< OperatorType, VectorType, ValueType >::SolveNonPrecond_ ( const VectorType &  rhs,
VectorType *  x 
)
protectedvirtual

Non-preconditioner solution procedure.

Implements paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::DPCG< OperatorType, VectorType, ValueType >::SolvePrecond_ ( const VectorType &  rhs,
VectorType *  x 
)
protectedvirtual

Preconditioned solution procedure.

Implements paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >.

template<class OperatorType , class VectorType, typename ValueType >
void paralution::Solver< OperatorType, VectorType, ValueType >::SolveZeroSol ( const VectorType &  rhs,
VectorType *  x 
)
virtualinherited
template<class OperatorType , class VectorType , typename ValueType >
void paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::Verbose ( const int  verb = 1)
virtualinherited

Provide verbose output of the solver: verb == 0 no output verb == 1 print info about the solver (start,end); verb == 2 print (iter, residual) via iteration control;.

Reimplemented from paralution::Solver< OperatorType, VectorType, ValueType >.

Referenced by paralution::BaseAMG< OperatorType, VectorType, ValueType >::Build(), paralution::AMG< OperatorType, VectorType, ValueType >::BuildSmoothers(), paralution::BaseAMG< OperatorType, VectorType, ValueType >::BuildSmoothers(), main(), mexFunction(), and paralution_solve().

Field Documentation

template<class OperatorType, class VectorType, typename ValueType>
OperatorType paralution::DPCG< OperatorType, VectorType, ValueType >::AZ_
private
template<class OperatorType, class VectorType, typename ValueType>
OperatorType paralution::DPCG< OperatorType, VectorType, ValueType >::AZT_
private
template<class OperatorType, class VectorType, typename ValueType>
bool paralution::Solver< OperatorType, VectorType, ValueType >::build_
protectedinherited

Flag == true after building the solver (e.g. Build())

template<class OperatorType, class VectorType, typename ValueType>
VectorType paralution::DPCG< OperatorType, VectorType, ValueType >::Dinv_
private
template<class OperatorType, class VectorType, typename ValueType>
OperatorType paralution::DPCG< OperatorType, VectorType, ValueType >::E_
private
size_t paralution::ParalutionObj::global_obj_id
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
VectorType paralution::DPCG< OperatorType, VectorType, ValueType >::hat_
private
template<class OperatorType, class VectorType, typename ValueType>
int paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::index_
protectedinherited

Absolute maximum index of residual vector when using Linf norm.

template<class OperatorType, class VectorType, typename ValueType>
VectorType paralution::DPCG< OperatorType, VectorType, ValueType >::intmed_
private
template<class OperatorType, class VectorType, typename ValueType>
IterationControl paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::iter_ctrl_
protectedinherited

Iteration control (monitor)

template<class OperatorType, class VectorType, typename ValueType>
OperatorType paralution::DPCG< OperatorType, VectorType, ValueType >::L_
private
template<class OperatorType, class VectorType, typename ValueType>
VectorType paralution::DPCG< OperatorType, VectorType, ValueType >::LLtx2_
private
template<class OperatorType, class VectorType, typename ValueType>
VectorType paralution::DPCG< OperatorType, VectorType, ValueType >::LLtx_
private
template<class OperatorType, class VectorType, typename ValueType>
OperatorType paralution::DPCG< OperatorType, VectorType, ValueType >::LT_
private
template<class OperatorType, class VectorType, typename ValueType>
int paralution::DPCG< OperatorType, VectorType, ValueType >::novecni_
private
template<class OperatorType, class VectorType, typename ValueType>
const OperatorType* paralution::Solver< OperatorType, VectorType, ValueType >::op_
protectedinherited

Pointer to the operator.

template<class OperatorType, class VectorType, typename ValueType>
VectorType paralution::DPCG< OperatorType, VectorType, ValueType >::p_
private
template<class OperatorType, class VectorType, typename ValueType>
LocalVector<int> paralution::Solver< OperatorType, VectorType, ValueType >::permutation_
protectedinherited

Permutation vector (used if the solver performs permutation/re-ordering techniques)

template<class OperatorType, class VectorType, typename ValueType>
Solver<OperatorType, VectorType, ValueType>* paralution::Solver< OperatorType, VectorType, ValueType >::precond_
protectedinherited

Pointer to the defined preconditioner.

template<class OperatorType, class VectorType, typename ValueType>
VectorType paralution::DPCG< OperatorType, VectorType, ValueType >::Ptx_
private
template<class OperatorType, class VectorType, typename ValueType>
VectorType paralution::DPCG< OperatorType, VectorType, ValueType >::q_
private
template<class OperatorType, class VectorType, typename ValueType>
VectorType paralution::DPCG< OperatorType, VectorType, ValueType >::Qb_
private
template<class OperatorType, class VectorType, typename ValueType>
VectorType paralution::DPCG< OperatorType, VectorType, ValueType >::r_
private
template<class OperatorType, class VectorType, typename ValueType>
int paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::res_norm_
protectedinherited

Residual norm res_norm = 1 L1 Norm res_norm = 2 L2 Norm res_norm = 3 Linf Norm.

template<class OperatorType, class VectorType, typename ValueType>
int paralution::Solver< OperatorType, VectorType, ValueType >::verb_
protectedinherited

Verbose flag verb == 0 no output verb == 1 print info about the solver (start,end); verb == 2 print (iter, residual) via iteration control;.

template<class OperatorType, class VectorType, typename ValueType>
VectorType paralution::DPCG< OperatorType, VectorType, ValueType >::w_
private
template<class OperatorType, class VectorType, typename ValueType>
OperatorType paralution::DPCG< OperatorType, VectorType, ValueType >::Z_
private
template<class OperatorType, class VectorType, typename ValueType>
OperatorType paralution::DPCG< OperatorType, VectorType, ValueType >::ZT_
private

The documentation for this class was generated from the following files: