Stokhos Package Browser (Single Doxygen Collection) Version of the Day
Loading...
Searching...
No Matches
Public Types | Public Member Functions | Protected Attributes | List of all members
Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver > Class Template Reference

Amesos2 solver adapter for UQ::PCE scalar type. More...

#include <Amesos2_Solver_UQ_PCE.hpp>

Inherits Solver< Tpetra::CrsMatrix< Sacado::UQ::PCE< Storage >, LocalOrdinal, GlobalOrdinal, Kokkos::Compat::KokkosDeviceWrapperNode< Device > >, Tpetra::MultiVector< Sacado::UQ::PCE< Storage >, LocalOrdinal, GlobalOrdinal, Kokkos::Compat::KokkosDeviceWrapperNode< Device > > >.

Public Types

typedef Sacado::UQ::PCE< StorageScalar
 
typedef Kokkos::Compat::KokkosDeviceWrapperNode< Device > Node
 
typedef Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, NodeMatrix
 
typedef Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, NodeVector
 
typedef Scalar::value_type BaseScalar
 
typedef Tpetra::Map< LocalOrdinal, GlobalOrdinal, NodeMap
 
typedef Tpetra::CrsGraph< LocalOrdinal, GlobalOrdinal, NodeFlatGraph
 
typedef Tpetra::CrsMatrix< BaseScalar, LocalOrdinal, GlobalOrdinal, NodeFlatMatrix
 
typedef Tpetra::MultiVector< BaseScalar, LocalOrdinal, GlobalOrdinal, NodeFlatVector
 
typedef ConcreteSolver< FlatMatrix, FlatVectorFlatConcreteSolver
 
typedef Solver< FlatMatrix, FlatVectorFlatSolver
 
typedef Solver< Matrix, Vectorsolver_type
 
typedef solver_type::type type
 
typedef Scalar::cijk_type cijk_type
 

Public Member Functions

 PCESolverAdapter (const Teuchos::RCP< const Matrix > &A_, const Teuchos::RCP< Vector > &X_, const Teuchos::RCP< const Vector > &B_)
 Constructor.
 

Protected Attributes

Teuchos::RCP< const MatrixA
 
Teuchos::RCP< VectorX
 
Teuchos::RCP< const VectorB
 
Teuchos::RCP< const Mapflat_X_map
 
Teuchos::RCP< const Mapflat_B_map
 
Teuchos::RCP< const FlatGraphflat_graph
 
Teuchos::RCP< const FlatGraphcijk_graph
 
Teuchos::RCP< const FlatMatrixflat_A
 
Teuchos::RCP< FlatVectorflat_X
 
Teuchos::RCP< const FlatVectorflat_B
 
Teuchos::RCP< FlatSolverflat_solver
 
cijk_type cijk
 

Mathematical Functions

virtual typepreOrdering (void)
 Pre-orders the matrix.
 
virtual typesymbolicFactorization (void)
 Performs symbolic factorization on the matrix.
 
virtual typenumericFactorization (void)
 Performs numeric factorization on the matrix.
 
virtual void solve (void)
 Solves $ A X = B$ (or $ A^T X = B$ )
 
virtual void solve (const Teuchos::Ptr< Vector > XX, const Teuchos::Ptr< const Vector > BB) const
 Solve $ A X = B$ using the given X and B vectors.
 
virtual void solve (Vector *XX, const Vector *BB) const
 Solve $ A X = B$ using the given X and B vectors.
 

Parameter Methods

virtual typesetParameters (const Teuchos::RCP< Teuchos::ParameterList > &parameterList)
 Set/update internal variables and solver options.
 
virtual Teuchos::RCP< const Teuchos::ParameterList > getValidParameters (void) const
 Return a const parameter list of all of the valid parameters that this->setParameterList(...) will accept.
 

Accessor Methods

virtual void setA (const Teuchos::RCP< const Matrix > a, EPhase keep_phase=CLEAN)
 Sets the matrix A of this solver.
 
virtual void setA (const Matrix *a, EPhase keep_phase=CLEAN)
 Sets the matrix A of this solver.
 
virtual bool matrixShapeOK (void)
 Returns true if the solver can handle the matrix shape.
 
virtual void setX (const Teuchos::RCP< Vector > x)
 Sets the LHS vector X.
 
virtual void setX (Vector *x)
 Sets the LHS vector X using a raw pointer.
 
virtual const Teuchos::RCP< VectorgetX (void)
 Returns the vector that is the LHS of the linear system.
 
virtual VectorgetXRaw (void)
 Returns a raw pointer to the LHS of the linear system.
 
virtual void setB (const Teuchos::RCP< const Vector > b)
 Sets the RHS vector B.
 
virtual void setB (const Vector *b)
 Sets the RHS vector B using a raw pointer.
 
virtual const Teuchos::RCP< const VectorgetB (void)
 Returns the vector that is the RHS of the linear system.
 
virtual const VectorgetBRaw (void)
 Returns a raw pointer to the RHS of the linear system.
 
virtual Teuchos::RCP< const Teuchos::Comm< int > > getComm (void) const
 Returns a pointer to the Teuchos::Comm communicator with this matrix.
 
virtual Status & getStatus () const
 Returns a reference to this solver's internal status object.
 
virtual std::string name (void) const
 Return the name of this solver.
 

Methods implementing Describable

virtual std::string description (void) const
 Returns a short description of this Solver.
 
virtual void describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
 

Performance and Timing

virtual void printTiming (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
 Prints timing information about the current solver.
 
virtual void getTiming (Teuchos::ParameterList &timingParameterList) const
 Extracts timing information from the current solver.
 

Detailed Description

template<class Storage, class LocalOrdinal, class GlobalOrdinal, class Device, template< class, class > class ConcreteSolver>
class Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >

Amesos2 solver adapter for UQ::PCE scalar type.

This adapter enables Amesos2 solvers to work with Tpetra matrices and vectors of the Sacado::UQ::PCE scalar type by "flattening" these matrices and vectors into ones with a standard (e.g., double) scalar type.

Definition at line 79 of file Amesos2_Solver_UQ_PCE.hpp.

Member Typedef Documentation

◆ Scalar

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef Sacado::UQ::PCE<Storage> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::Scalar

Definition at line 92 of file Amesos2_Solver_UQ_PCE.hpp.

◆ Node

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef Kokkos::Compat::KokkosDeviceWrapperNode<Device> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::Node

Definition at line 93 of file Amesos2_Solver_UQ_PCE.hpp.

◆ Matrix

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::Matrix

Definition at line 94 of file Amesos2_Solver_UQ_PCE.hpp.

◆ Vector

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef Tpetra::MultiVector<Scalar,LocalOrdinal,GlobalOrdinal,Node> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::Vector

Definition at line 95 of file Amesos2_Solver_UQ_PCE.hpp.

◆ BaseScalar

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef Scalar::value_type Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::BaseScalar

Definition at line 97 of file Amesos2_Solver_UQ_PCE.hpp.

◆ Map

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef Tpetra::Map<LocalOrdinal,GlobalOrdinal,Node> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::Map

Definition at line 98 of file Amesos2_Solver_UQ_PCE.hpp.

◆ FlatGraph

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef Tpetra::CrsGraph<LocalOrdinal,GlobalOrdinal,Node> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::FlatGraph

Definition at line 99 of file Amesos2_Solver_UQ_PCE.hpp.

◆ FlatMatrix

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef Tpetra::CrsMatrix<BaseScalar,LocalOrdinal,GlobalOrdinal,Node> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::FlatMatrix

Definition at line 100 of file Amesos2_Solver_UQ_PCE.hpp.

◆ FlatVector

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef Tpetra::MultiVector<BaseScalar,LocalOrdinal,GlobalOrdinal,Node> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::FlatVector

Definition at line 101 of file Amesos2_Solver_UQ_PCE.hpp.

◆ FlatConcreteSolver

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef ConcreteSolver<FlatMatrix,FlatVector> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::FlatConcreteSolver

Definition at line 102 of file Amesos2_Solver_UQ_PCE.hpp.

◆ FlatSolver

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef Solver<FlatMatrix,FlatVector> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::FlatSolver

Definition at line 103 of file Amesos2_Solver_UQ_PCE.hpp.

◆ solver_type

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef Solver<Matrix,Vector> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::solver_type

Definition at line 105 of file Amesos2_Solver_UQ_PCE.hpp.

◆ type

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef solver_type::type Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::type

Definition at line 106 of file Amesos2_Solver_UQ_PCE.hpp.

◆ cijk_type

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
typedef Scalar::cijk_type Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::cijk_type

Definition at line 107 of file Amesos2_Solver_UQ_PCE.hpp.

Constructor & Destructor Documentation

◆ PCESolverAdapter()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::PCESolverAdapter ( const Teuchos::RCP< const Matrix > & A_,
const Teuchos::RCP< Vector > & X_,
const Teuchos::RCP< const Vector > & B_ )
inline

Constructor.

Definition at line 110 of file Amesos2_Solver_UQ_PCE.hpp.

Member Function Documentation

◆ preOrdering()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual type & Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::preOrdering ( void )
inlinevirtual

Pre-orders the matrix.

Uses the default solver option, unless a solver-specific pre-ordering parameter is given.

See also
setParameters

Definition at line 145 of file Amesos2_Solver_UQ_PCE.hpp.

◆ symbolicFactorization()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual type & Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::symbolicFactorization ( void )
inlinevirtual

Performs symbolic factorization on the matrix.

Precondition
  • The matrix A must not be null

Definition at line 156 of file Amesos2_Solver_UQ_PCE.hpp.

◆ numericFactorization()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual type & Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::numericFactorization ( void )
inlinevirtual

Performs numeric factorization on the matrix.

numericFactorization checks first that symbolicFactorization has successfully been called, and if not, calls it before continuing.

Precondition
  • The matrix A must not be null
Postcondition
  • The factors L and U of A are computed

Definition at line 174 of file Amesos2_Solver_UQ_PCE.hpp.

◆ solve() [1/3]

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual void Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::solve ( void )
inlinevirtual

Solves $ A X = B$ (or $ A^T X = B$ )

solve checks first that numericFactorization has successfully been called, and if not, calls it before continuing.

Precondition
  • The (multi)vectors X and B must not be null
Postcondition
  • The (multi)vector X (given at construction time) contains the solution to the system.

Definition at line 192 of file Amesos2_Solver_UQ_PCE.hpp.

◆ solve() [2/3]

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual void Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::solve ( const Teuchos::Ptr< Vector > XX,
const Teuchos::Ptr< const Vector > BB ) const
inlinevirtual

Solve $ A X = B$ using the given X and B vectors.

This overload of solve uses the given X and B vectors when solving. This X and B are used in place of any X and B that were given upon construction of the Amesos2 solver instance and are used only for this solve.

If a permanent change of X and B are required, see the setX() and setB() methods.

Postcondition
  • The (multi)vector XX contains the solution to the system
  • The XX and BB given at construction time (if any) are unchanged.

Definition at line 211 of file Amesos2_Solver_UQ_PCE.hpp.

◆ solve() [3/3]

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual void Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::solve ( Vector * XX,
const Vector * BB ) const
inlinevirtual

Solve $ A X = B$ using the given X and B vectors.

This overload of solve uses the given X and B vectors when solving. This X and B are used in place of any X and B that were given upon construction of the Amesos2 solver instance and are used only for this solve.

If a permanent change of X and B are required, see the setX() and setB() methods.

Postcondition
  • The (multi)vector XX contains the solution to the system
  • The XX and BB given at construction time (if any) are unchanged.

Definition at line 233 of file Amesos2_Solver_UQ_PCE.hpp.

◆ setParameters()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual type & Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::setParameters ( const Teuchos::RCP< Teuchos::ParameterList > & parameterList)
inlinevirtual

Set/update internal variables and solver options.

Expects that parameterList be named "Amesos2". That list may contain Amesos2-specific parameters. In addition, it may contain sublist for solver-specific parameters. These sublists should be named according to what is returned by the name() function (i.e. The solver's name when enabling for Amesos2 during configuration).

See each solver interface directly for a list of the supported parameters for that solver.

Definition at line 258 of file Amesos2_Solver_UQ_PCE.hpp.

◆ getValidParameters()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual Teuchos::RCP< const Teuchos::ParameterList > Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::getValidParameters ( void ) const
inlinevirtual

Return a const parameter list of all of the valid parameters that this->setParameterList(...) will accept.

Definition at line 270 of file Amesos2_Solver_UQ_PCE.hpp.

◆ setA() [1/2]

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual void Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::setA ( const Teuchos::RCP< const Matrix > a,
EPhase keep_phase = CLEAN )
inlinevirtual

Sets the matrix A of this solver.

Parameters
[in]aAn RCP to a matrix will will be used for future computation steps
[in]keep_phaseThis parameter tells the solver what state it should keep. For example, you may want to replace the matrix but keep the symbolic factorization because you know the structure of the new matrix is the same as the structure of the old matrix. In this case you would pass Amesos2::SYMBFACT as this parameter.

The default value for the second parameter is Amesos2::CLEAN, which means that the internal state of the solver will be completely reset. It will be as if no previous computational steps were performed.

Definition at line 300 of file Amesos2_Solver_UQ_PCE.hpp.

◆ setA() [2/2]

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual void Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::setA ( const Matrix * a,
EPhase keep_phase = CLEAN )
inlinevirtual

Sets the matrix A of this solver.

Parameters
[in]aAn raw C pointer to a matrix will will be used for future computation steps.
[in]keep_phaseThis parameter tells the solver what state it should keep. For example, you may want to replace the matrix but keep the symbolic factorization because you know the structure of the new matrix is the same as the structure of the old matrix. In this case you would pass Amesos2::SYMBFACT as this parameter.

The default value for the second parameter is Amesos2::CLEAN, which means that the internal state of the solver will be completely reset. It will be as if no previous computational steps were performed.

Definition at line 343 of file Amesos2_Solver_UQ_PCE.hpp.

◆ matrixShapeOK()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual bool Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::matrixShapeOK ( void )
inlinevirtual

Returns true if the solver can handle the matrix shape.

Definition at line 349 of file Amesos2_Solver_UQ_PCE.hpp.

◆ setX() [1/2]

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual void Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::setX ( const Teuchos::RCP< Vector > x)
inlinevirtual

Sets the LHS vector X.

Definition at line 355 of file Amesos2_Solver_UQ_PCE.hpp.

◆ setX() [2/2]

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual void Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::setX ( Vector * x)
inlinevirtual

Sets the LHS vector X using a raw pointer.

Definition at line 366 of file Amesos2_Solver_UQ_PCE.hpp.

◆ getX()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual const Teuchos::RCP< Vector > Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::getX ( void )
inlinevirtual

Returns the vector that is the LHS of the linear system.

Definition at line 380 of file Amesos2_Solver_UQ_PCE.hpp.

◆ getXRaw()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual Vector * Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::getXRaw ( void )
inlinevirtual

Returns a raw pointer to the LHS of the linear system.

Definition at line 386 of file Amesos2_Solver_UQ_PCE.hpp.

◆ setB() [1/2]

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual void Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::setB ( const Teuchos::RCP< const Vector > b)
inlinevirtual

Sets the RHS vector B.

Definition at line 392 of file Amesos2_Solver_UQ_PCE.hpp.

◆ setB() [2/2]

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual void Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::setB ( const Vector * b)
inlinevirtual

Sets the RHS vector B using a raw pointer.

Definition at line 403 of file Amesos2_Solver_UQ_PCE.hpp.

◆ getB()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual const Teuchos::RCP< const Vector > Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::getB ( void )
inlinevirtual

Returns the vector that is the RHS of the linear system.

Definition at line 417 of file Amesos2_Solver_UQ_PCE.hpp.

◆ getBRaw()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual const Vector * Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::getBRaw ( void )
inlinevirtual

Returns a raw pointer to the RHS of the linear system.

Definition at line 423 of file Amesos2_Solver_UQ_PCE.hpp.

◆ getComm()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual Teuchos::RCP< const Teuchos::Comm< int > > Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::getComm ( void ) const
inlinevirtual

Returns a pointer to the Teuchos::Comm communicator with this matrix.

Definition at line 429 of file Amesos2_Solver_UQ_PCE.hpp.

◆ getStatus()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual Status & Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::getStatus ( ) const
inlinevirtual

Returns a reference to this solver's internal status object.

Definition at line 435 of file Amesos2_Solver_UQ_PCE.hpp.

◆ name()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual std::string Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::name ( void ) const
inlinevirtual

Return the name of this solver.

Definition at line 441 of file Amesos2_Solver_UQ_PCE.hpp.

◆ description()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual std::string Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::description ( void ) const
inlinevirtual

Returns a short description of this Solver.

Definition at line 453 of file Amesos2_Solver_UQ_PCE.hpp.

◆ describe()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual void Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::describe ( Teuchos::FancyOStream & out,
const Teuchos::EVerbosityLevel verbLevel = Teuchos::Describable::verbLevel_default ) const
inlinevirtual

Prints the status information about the current solver with some level of verbosity.

Definition at line 460 of file Amesos2_Solver_UQ_PCE.hpp.

◆ printTiming()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual void Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::printTiming ( Teuchos::FancyOStream & out,
const Teuchos::EVerbosityLevel verbLevel = Teuchos::Describable::verbLevel_default ) const
inlinevirtual

Prints timing information about the current solver.

Definition at line 473 of file Amesos2_Solver_UQ_PCE.hpp.

◆ getTiming()

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
virtual void Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::getTiming ( Teuchos::ParameterList & timingParameterList) const
inlinevirtual

Extracts timing information from the current solver.

Results are placed in the parameter list timingParameterList

Parameters
timingParameterListAccepts timing information from the current solver

Definition at line 487 of file Amesos2_Solver_UQ_PCE.hpp.

Member Data Documentation

◆ A

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
Teuchos::RCP<const Matrix> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::A
protected

Definition at line 495 of file Amesos2_Solver_UQ_PCE.hpp.

◆ X

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
Teuchos::RCP<Vector> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::X
protected

Definition at line 496 of file Amesos2_Solver_UQ_PCE.hpp.

◆ B

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
Teuchos::RCP<const Vector> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::B
protected

Definition at line 497 of file Amesos2_Solver_UQ_PCE.hpp.

◆ flat_X_map

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
Teuchos::RCP<const Map> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::flat_X_map
protected

Definition at line 498 of file Amesos2_Solver_UQ_PCE.hpp.

◆ flat_B_map

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
Teuchos::RCP<const Map> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::flat_B_map
protected

Definition at line 498 of file Amesos2_Solver_UQ_PCE.hpp.

◆ flat_graph

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
Teuchos::RCP<const FlatGraph> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::flat_graph
protected

Definition at line 499 of file Amesos2_Solver_UQ_PCE.hpp.

◆ cijk_graph

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
Teuchos::RCP<const FlatGraph> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::cijk_graph
protected

Definition at line 499 of file Amesos2_Solver_UQ_PCE.hpp.

◆ flat_A

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
Teuchos::RCP<const FlatMatrix> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::flat_A
protected

Definition at line 500 of file Amesos2_Solver_UQ_PCE.hpp.

◆ flat_X

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
Teuchos::RCP<FlatVector> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::flat_X
protected

Definition at line 501 of file Amesos2_Solver_UQ_PCE.hpp.

◆ flat_B

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
Teuchos::RCP<const FlatVector> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::flat_B
protected

Definition at line 502 of file Amesos2_Solver_UQ_PCE.hpp.

◆ flat_solver

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
Teuchos::RCP<FlatSolver> Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::flat_solver
protected

Definition at line 503 of file Amesos2_Solver_UQ_PCE.hpp.

◆ cijk

template<class Storage , class LocalOrdinal , class GlobalOrdinal , class Device , template< class, class > class ConcreteSolver>
cijk_type Amesos2::PCESolverAdapter< Storage, LocalOrdinal, GlobalOrdinal, Device, ConcreteSolver >::cijk
protected

Definition at line 504 of file Amesos2_Solver_UQ_PCE.hpp.


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