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

#include <multigrid.hpp>

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

Public Member Functions

 MultiGrid ()
 
virtual ~MultiGrid ()
 
virtual void SetRestrictOperator (OperatorType **op)
 Set thre restriction method by operator for each level. More...
 
virtual void SetProlongOperator (OperatorType **op)
 Set the prolongation operator for each level. More...
 
virtual void SetOperatorHierarchy (OperatorType **op)
 Set the operator for each level. More...
 
virtual void Print (void) const
 Print information about the solver. More...
 
virtual void SetPreconditioner (Solver< OperatorType, VectorType, ValueType > &precond)
 disabled function More...
 
virtual void SetSolver (Solver< OperatorType, VectorType, ValueType > &solver)
 Set the smoother for each level. More...
 
virtual void SetSmoother (IterativeLinearSolver< OperatorType, VectorType, ValueType > **smoother)
 Set the smoother for each level. More...
 
virtual void SetSmootherPreIter (const int iter)
 Set the number of pre-smoothing steps. More...
 
virtual void SetSmootherPostIter (const int iter)
 Set the number of post-smoothing steps. More...
 
virtual void SetScaling (const bool scaling)
 Enable/disable scaling of intergrid transfers. More...
 
virtual void SetCycle (const _cycle cycle)
 Set the MultiGrid Cycle (default: Vcycle) More...
 
virtual void SetKcycleFull (const bool kcycle_full)
 Set the MultiGrid Kcycle on all levels or only on finest level. More...
 
virtual void InitLevels (const int levels)
 Set the depth of the multigrid solver. More...
 
virtual void Solve (const VectorType &rhs, VectorType *x)
 Called by default the V-cycle. 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...
 
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 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 Restrict_ (const VectorType &fine, VectorType *coarse, const int level)
 
virtual void Prolong_ (const VectorType &coarse, VectorType *fine, const int level)
 
void Vcycle_ (const VectorType &rhs, VectorType *x)
 
void Wcycle_ (const VectorType &rhs, VectorType *x)
 
void Fcycle_ (const VectorType &rhs, VectorType *x)
 
void Kcycle_ (const VectorType &rhs, VectorType *x)
 
virtual void SolveNonPrecond_ (const VectorType &rhs, VectorType *x)
 disabled function More...
 
virtual void SolvePrecond_ (const VectorType &rhs, VectorType *x)
 disabled function 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

int levels_
 
int current_level_
 
bool scaling_
 
int iter_pre_smooth_
 
int iter_post_smooth_
 
int cycle_
 
bool kcycle_full_
 
double res_norm_
 
OperatorType ** op_level_
 
Operator< ValueType > ** restrict_op_level_
 
Operator< ValueType > ** prolong_op_level_
 
VectorType ** d_level_
 
VectorType ** r_level_
 
VectorType ** t_level_
 
VectorType ** s_level_
 
VectorType ** p_level_
 
VectorType ** q_level_
 
VectorType ** k_level_
 
VectorType ** l_level_
 
Solver< OperatorType, VectorType, ValueType > * solver_coarse_
 
IterativeLinearSolver< OperatorType, VectorType, ValueType > ** smoother_level_
 
IterationControl iter_ctrl_
 Iteration control (monitor) 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
 

Constructor & Destructor Documentation

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

Member Function Documentation

template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::Build ( void  )
virtualinherited

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

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

Reimplemented in paralution::BaseAMG< OperatorType, VectorType, ValueType >.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::Clear ( void  )
virtualinherited

Clear (free all local data) the solver.

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

Reimplemented in paralution::BaseAMG< OperatorType, VectorType, ValueType >.

template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::Fcycle_ ( const VectorType &  rhs,
VectorType *  x 
)
protectedinherited
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::BaseMultiGrid< OperatorType, VectorType, ValueType >::InitLevels ( const int  levels)
virtualinherited

Set the depth of the multigrid solver.

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::BaseMultiGrid< OperatorType, VectorType, ValueType >::Kcycle_ ( const VectorType &  rhs,
VectorType *  x 
)
protectedinherited
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::BaseMultiGrid< OperatorType, VectorType, ValueType >::MoveToAcceleratorLocalData_ ( void  )
protectedvirtualinherited

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::BaseMultiGrid< OperatorType, VectorType, ValueType >::MoveToHostLocalData_ ( void  )
protectedvirtualinherited

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::BaseMultiGrid< OperatorType, VectorType, ValueType >::Print ( void  ) const
virtualinherited
template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::PrintEnd_ ( void  ) const
protectedvirtualinherited
template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::PrintStart_ ( void  ) const
protectedvirtualinherited
template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::Prolong_ ( const VectorType &  coarse,
VectorType *  fine,
const int  level 
)
protectedvirtualinherited
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::BaseMultiGrid< OperatorType, VectorType, ValueType >::Restrict_ ( const VectorType &  fine,
VectorType *  coarse,
const int  level 
)
protectedvirtualinherited
template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::SetCycle ( const _cycle  cycle)
virtualinherited

Set the MultiGrid Cycle (default: Vcycle)

template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::SetKcycleFull ( const bool  kcycle_full)
virtualinherited

Set the MultiGrid Kcycle on all levels or only on finest level.

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::MultiGrid< OperatorType, VectorType, ValueType >::SetOperatorHierarchy ( OperatorType **  op)
virtual

Set the operator for each level.

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

template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::SetPreconditioner ( Solver< OperatorType, VectorType, ValueType > &  precond)
virtualinherited
template<class OperatorType , class VectorType , typename ValueType >
void paralution::MultiGrid< OperatorType, VectorType, ValueType >::SetProlongOperator ( OperatorType **  op)
virtual

Set the prolongation operator for each level.

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

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::MultiGrid< OperatorType, VectorType, ValueType >::SetRestrictOperator ( OperatorType **  op)
virtual

Set thre restriction method by operator for each level.

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

template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::SetScaling ( const bool  scaling)
virtualinherited

Enable/disable scaling of intergrid transfers.

Referenced by main().

template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::SetSmoother ( IterativeLinearSolver< OperatorType, VectorType, ValueType > **  smoother)
virtualinherited

Set the smoother for each level.

Referenced by main().

template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::SetSmootherPostIter ( const int  iter)
virtualinherited

Set the number of post-smoothing steps.

Referenced by main().

template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::SetSmootherPreIter ( const int  iter)
virtualinherited

Set the number of pre-smoothing steps.

Referenced by main().

template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::SetSolver ( Solver< OperatorType, VectorType, ValueType > &  solver)
virtualinherited

Set the smoother for each level.

Referenced by main().

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

Called by default the V-cycle.

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

Referenced by main().

template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::SolveNonPrecond_ ( const VectorType &  rhs,
VectorType *  x 
)
protectedvirtualinherited
template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::SolvePrecond_ ( const VectorType &  rhs,
VectorType *  x 
)
protectedvirtualinherited
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::BaseMultiGrid< OperatorType, VectorType, ValueType >::Vcycle_ ( const VectorType &  rhs,
VectorType *  x 
)
protectedinherited
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().

template<class OperatorType , class VectorType , typename ValueType >
void paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::Wcycle_ ( const VectorType &  rhs,
VectorType *  x 
)
protectedinherited

Field Documentation

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>
int paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::current_level_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
int paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::cycle_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
VectorType** paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::d_level_
protectedinherited
size_t paralution::ParalutionObj::global_obj_id
protectedinherited
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>
IterationControl paralution::IterativeLinearSolver< OperatorType, VectorType, ValueType >::iter_ctrl_
protectedinherited

Iteration control (monitor)

template<class OperatorType, class VectorType, typename ValueType>
int paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::iter_post_smooth_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
int paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::iter_pre_smooth_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
VectorType** paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::k_level_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
bool paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::kcycle_full_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
VectorType** paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::l_level_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
int paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::levels_
protectedinherited
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>
OperatorType** paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::op_level_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
VectorType** paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::p_level_
protectedinherited
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>
Operator<ValueType>** paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::prolong_op_level_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
VectorType** paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::q_level_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
VectorType** paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::r_level_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
double paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::res_norm_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
Operator<ValueType>** paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::restrict_op_level_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
VectorType** paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::s_level_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
bool paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::scaling_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
IterativeLinearSolver<OperatorType, VectorType, ValueType>** paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::smoother_level_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
Solver<OperatorType, VectorType, ValueType>* paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::solver_coarse_
protectedinherited
template<class OperatorType, class VectorType, typename ValueType>
VectorType** paralution::BaseMultiGrid< OperatorType, VectorType, ValueType >::t_level_
protectedinherited
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;.


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