MueLu  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
MueLu::Details::LinearSolver< MV, OP, NormType > Class Template Reference

#include <MueLu_Details_LinearSolverFactory_def.hpp>

Inheritance diagram for MueLu::Details::LinearSolver< MV, OP, NormType >:
Trilinos::Details::LinearSolver< MV, OP, NormType > Teuchos::Describable Teuchos::LabeledObject

Public Member Functions

 LinearSolver ()
 Constructor. More...
 
virtual ~LinearSolver ()
 Destructor (virtual for memory safety). More...
 
void setMatrix (const Teuchos::RCP< const OP > &A)
 Set the Solver's matrix. More...
 
Teuchos::RCP< const OP > getMatrix () const
 Get a pointer to this Solver's matrix. More...
 
void solve (MV &X, const MV &B)
 Solve the linear system(s) AX=B. More...
 
void setParameters (const Teuchos::RCP< Teuchos::ParameterList > &params)
 Set this solver's parameters. More...
 
void symbolic ()
 Set up any part of the solve that depends on the structure of the input matrix, but not its numerical values. More...
 
void numeric ()
 Set up any part of the solve that depends on both the structure and the numerical values of the input matrix. More...
 
std::string description () const
 Implementation of Teuchos::Describable::description. More...
 
void describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
 Implementation of Teuchos::Describable::describe. More...
 
- Public Member Functions inherited from Teuchos::Describable
void describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const
 
virtual ~Describable ()
 
 LabeledObject ()
 
virtual ~LabeledObject ()
 
virtual void setObjectLabel (const std::string &objectLabel)
 
virtual std::string getObjectLabel () const
 
DescribableStreamManipulatorState describe (const Describable &describable, const EVerbosityLevel verbLevel=Describable::verbLevel_default)
 
std::ostream & operator<< (std::ostream &os, const DescribableStreamManipulatorState &d)
 

Private Attributes

Teuchos::RCP< const OP > A_
 
Teuchos::RCP
< Teuchos::ParameterList
params_
 

Additional Inherited Members

- Static Public Attributes inherited from Teuchos::Describable
static const EVerbosityLevel verbLevel_default
 

Detailed Description

template<class MV, class OP, class NormType>
class MueLu::Details::LinearSolver< MV, OP, NormType >

Definition at line 71 of file MueLu_Details_LinearSolverFactory_def.hpp.

Constructor & Destructor Documentation

template<class MV , class OP , class NormType >
MueLu::Details::LinearSolver< MV, OP, NormType >::LinearSolver ( )
inline

Constructor.

Definition at line 79 of file MueLu_Details_LinearSolverFactory_def.hpp.

template<class MV , class OP , class NormType >
virtual MueLu::Details::LinearSolver< MV, OP, NormType >::~LinearSolver ( )
inlinevirtual

Destructor (virtual for memory safety).

Reimplemented from Trilinos::Details::LinearSolver< MV, OP, NormType >.

Definition at line 82 of file MueLu_Details_LinearSolverFactory_def.hpp.

Member Function Documentation

template<class MV , class OP , class NormType >
void MueLu::Details::LinearSolver< MV, OP, NormType >::setMatrix ( const Teuchos::RCP< const OP > &  A)
virtual

Set the Solver's matrix.

Parameters
A[in] Pointer to the matrix A in the linear system(s) AX=B to solve.

Implements Trilinos::Details::LinearSolver< MV, OP, NormType >.

template<class MV , class OP , class NormType >
Teuchos::RCP<const OP> MueLu::Details::LinearSolver< MV, OP, NormType >::getMatrix ( ) const
inlinevirtual

Get a pointer to this Solver's matrix.

Implements Trilinos::Details::LinearSolver< MV, OP, NormType >.

Definition at line 91 of file MueLu_Details_LinearSolverFactory_def.hpp.

template<class MV , class OP , class NormType >
void MueLu::Details::LinearSolver< MV, OP, NormType >::solve ( MV &  X,
const MV &  B 
)
virtual

Solve the linear system(s) AX=B.

Implements Trilinos::Details::LinearSolver< MV, OP, NormType >.

template<class MV , class OP , class NormType >
void MueLu::Details::LinearSolver< MV, OP, NormType >::setParameters ( const Teuchos::RCP< Teuchos::ParameterList > &  params)
virtual

Set this solver's parameters.

Implements Trilinos::Details::LinearSolver< MV, OP, NormType >.

template<class MV , class OP , class NormType >
void MueLu::Details::LinearSolver< MV, OP, NormType >::symbolic ( )
inlinevirtual

Set up any part of the solve that depends on the structure of the input matrix, but not its numerical values.

Implements Trilinos::Details::LinearSolver< MV, OP, NormType >.

Definition at line 103 of file MueLu_Details_LinearSolverFactory_def.hpp.

template<class MV , class OP , class NormType >
void MueLu::Details::LinearSolver< MV, OP, NormType >::numeric ( )
virtual

Set up any part of the solve that depends on both the structure and the numerical values of the input matrix.

Implements Trilinos::Details::LinearSolver< MV, OP, NormType >.

template<class MV , class OP , class NormType >
std::string MueLu::Details::LinearSolver< MV, OP, NormType >::description ( ) const
virtual

Implementation of Teuchos::Describable::description.

Reimplemented from Teuchos::Describable.

template<class MV , class OP , class NormType >
void MueLu::Details::LinearSolver< MV, OP, NormType >::describe ( Teuchos::FancyOStream out,
const Teuchos::EVerbosityLevel  verbLevel = Teuchos::Describable::verbLevel_default 
) const
virtual

Implementation of Teuchos::Describable::describe.

Reimplemented from Teuchos::Describable.

Member Data Documentation

template<class MV , class OP , class NormType >
Teuchos::RCP<const OP> MueLu::Details::LinearSolver< MV, OP, NormType >::A_
private

Definition at line 119 of file MueLu_Details_LinearSolverFactory_def.hpp.

template<class MV , class OP , class NormType >
Teuchos::RCP<Teuchos::ParameterList> MueLu::Details::LinearSolver< MV, OP, NormType >::params_
private

Definition at line 120 of file MueLu_Details_LinearSolverFactory_def.hpp.


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