| 
    Stokhos
    Development
    
   | 
 
#include <Stokhos_AdaptivityManager.hpp>
Public Member Functions | |
| AdaptivityManager (const Teuchos::RCP< const Stokhos::ProductBasis< int, double > > &sg_master_basis, const std::vector< Teuchos::RCP< const Stokhos::ProductBasis< int, double > > > &sg_basis_row_dof, const Epetra_CrsGraph &determ_graph, bool onlyUseLinear, int kExpOrder, bool scaleOp=true) | |
| AdaptivityManager (const Teuchos::RCP< const Stokhos::ProductBasis< int, double > > &sg_master_basis, const std::vector< Teuchos::RCP< const Stokhos::ProductBasis< int, double > > > &sg_basis_row_dof, const Epetra_Comm &comm, bool scaleOp=true) | |
| int | getGlobalColId (int determLid, int basisIndex) const | 
| int | getGlobalRowId (int determLid, int basisIndex) const | 
| Teuchos::RCP< Epetra_CrsMatrix > | buildMatrixFromGraph () const | 
| void | setupWithGraph (const Epetra_CrsGraph &graph, bool onlyUseLinear, int kExpOrder) | 
| Teuchos::RCP< const Epetra_Map > | getAdaptedMap () const | 
| void | setupOperator (Epetra_CrsMatrix &A, const Sparse3Tensor< int, double > &Cijk, Stokhos::EpetraOperatorOrthogPoly &poly, bool onlyUseLinear=false, bool includeMean=true) const | 
| void | sumInOperator (Epetra_CrsMatrix &A, const Stokhos::Sparse3Tensor< int, double > &Cijk, int k, const Epetra_CrsMatrix &J_k) const | 
| void | copyToAdaptiveVector (const Stokhos::EpetraVectorOrthogPoly &x_sg, Epetra_Vector &x) const | 
| void | copyFromAdaptiveVector (const Epetra_Vector &x, Stokhos::EpetraVectorOrthogPoly &x_sg) const | 
| int | getRowStochasticBasisSize (int determLid) const | 
| int | getColStochasticBasisSize (int determLid) const | 
| Teuchos::RCP< const  Stokhos::ProductBasis< int, double > >  | getMasterStochasticBasis () const | 
| Teuchos::RCP< const  Stokhos::ProductBasis< int, double > >  | getRowStochasticBasis (int determLid) const | 
| const std::vector < Teuchos::RCP< const Stokhos::ProductBasis< int, double > > > &  | getRowStochasticBasis () const | 
| Teuchos::RCP< const  Stokhos::ProductBasis< int, double > >  | getColStochasticBasis (int determLid) const | 
| bool | isScaled () | 
Describes and constructs all things needed for adaptivity.
| Teuchos::RCP< Epetra_CrsMatrix > Stokhos::AdaptivityManager::buildMatrixFromGraph | ( | ) | const | 
Build a CRS matrix from the internally constructed graph
| void Stokhos::AdaptivityManager::copyFromAdaptiveVector | ( | const Epetra_Vector & | x, | 
| Stokhos::EpetraVectorOrthogPoly & | x_sg | ||
| ) | const | 
Copy from an adaptive vector to a set of blocked vectors
References Stokhos::ProductEpetraVector::getBlockVector(), and Stokhos::ProductContainer< coeff_type >::size().
| void Stokhos::AdaptivityManager::copyToAdaptiveVector | ( | const Stokhos::EpetraVectorOrthogPoly & | x_sg, | 
| Epetra_Vector & | x | ||
| ) | const | 
Copy to an adaptive vector from a set of blocked vectors
References Stokhos::ProductEpetraVector::getBlockVector().
      
  | 
  inline | 
Get map associated with this set of adaptive indices
      
  | 
  inline | 
Get stochastic basis associated with a particular deterministic column local id.
      
  | 
  inline | 
How many stochastic degrees of freedom are associated with a particular deterministic row degree of freedom.
      
  | 
  inline | 
Given a deterministic local column ID and a basis index determine the global column ID in the fully assembled system.
| [in] | determLid | Deterministic local column ID | 
| [in] | basisIndex | Index into the stochastic basis associated with this column ID. | 
      
  | 
  inline | 
Given a deterministic local row ID and a basis index determine the global row ID in the fully assembled system.
| [in] | determLid | Deterministic local row ID | 
| [in] | basisIndex | Index into the stochastic basis associated with this row ID. | 
      
  | 
  inline | 
Get master stochastic basis
      
  | 
  inline | 
Get stochastic basis associated with a particular deterministic row local id.
      
  | 
  inline | 
Get the vector of row stochastic basis functions.
      
  | 
  inline | 
How many stochastic degrees of freedom are associated with a particular deterministic row degree of freedom.
| void Stokhos::AdaptivityManager::setupOperator | ( | Epetra_CrsMatrix & | A, | 
| const Sparse3Tensor< int, double > & | Cijk, | ||
| Stokhos::EpetraOperatorOrthogPoly & | poly, | ||
| bool | onlyUseLinear = false,  | 
        ||
| bool | includeMean = true  | 
        ||
| ) | const | 
| void Stokhos::AdaptivityManager::setupWithGraph | ( | const Epetra_CrsGraph & | graph, | 
| bool | onlyUseLinear, | ||
| int | kExpOrder | ||
| ) | 
Build a CRS graph from a determinstic graph
| void Stokhos::AdaptivityManager::sumInOperator | ( | Epetra_CrsMatrix & | A, | 
| const Stokhos::Sparse3Tensor< int, double > & | Cijk, | ||
| int | k, | ||
| const Epetra_CrsMatrix & | J_k | ||
| ) | const | 
Sum into a matrix constructed from buildMatrixFromGraph using the Cjik tensor a matrix J_k 
 1.8.5