Stokhos Package Browser (Single Doxygen Collection)
Version of the Day
|
#include <Stokhos_EpetraSparse3Tensor.hpp>
Public Member Functions | |
EpetraSparse3Tensor (const Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > &basis, const Teuchos::RCP< const Stokhos::Sparse3Tensor< int, double > > &Cijk, const Teuchos::RCP< const EpetraExt::MultiComm > &globalMultiComm, int k_begin=0, int k_end=-1) | |
Constructor from a full Cijk. More... | |
EpetraSparse3Tensor (const Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > &basis, const Teuchos::RCP< const Stokhos::Sparse3Tensor< int, double > > &Cijk, const Teuchos::RCP< const EpetraExt::MultiComm > &globalMultiComm, const Teuchos::RCP< const Epetra_BlockMap > &stoch_row_map, const Teuchos::RCP< const Stokhos::Sparse3Tensor< int, double > > &Cijk_parallel=Teuchos::null, int k_begin=0, int k_end=-1) | |
Constructor from an already parallelized Cijk. More... | |
EpetraSparse3Tensor (const EpetraSparse3Tensor &epetraCijk, int k_begin_=0, int k_end_=-1) | |
Copy constructor with possible change in scaling and k limits. More... | |
~EpetraSparse3Tensor () | |
Destructor. More... | |
void | rebalance (Teuchos::ParameterList &isorropia_params) |
Rebalance maps and graph using Isorropia. More... | |
void | transformToLocal () |
Transform Cijk to local i and j indices. More... | |
int | getKBegin () const |
Return k_begin index. More... | |
int | getKEnd () const |
Return k_end index. More... | |
bool | isStochasticParallel () const |
Return whether stochastic blocks are parallel distributed. More... | |
int | GRID (int lrid) const |
Return global row id for given local row id. More... | |
int | GCID (int lcid) const |
Return global column id for given local column id. More... | |
bool | myGRID (int grid) const |
Return true if global row id is on processor. More... | |
bool | myGCID (int gcid) const |
Return true if global column id is on processor. More... | |
int | numMyRows () const |
Return number of rows on this processor. More... | |
int | numMyCols () const |
Return number of columns on this processor. More... | |
Teuchos::RCP< const EpetraExt::MultiComm > | getMultiComm () const |
Get global comm. More... | |
Teuchos::RCP< const Epetra_Comm > | getStochasticComm () const |
Get stochastic comm. More... | |
Teuchos::RCP< const Epetra_BlockMap > | getStochasticRowMap () const |
Get stochastic row map. More... | |
Teuchos::RCP< const Epetra_BlockMap > | getStochasticColMap () const |
Get stochastic column map. More... | |
Teuchos::RCP< const Stokhos::Sparse3Tensor< int, double > > | getCijk () const |
Get Cijk. More... | |
Teuchos::RCP< const Stokhos::Sparse3Tensor< int, double > > | getParallelCijk () const |
Get parallel Cijk. More... | |
Teuchos::RCP< const Epetra_CrsGraph > | getStochasticGraph () const |
Get stochastic graph. More... | |
Protected Types | |
typedef Stokhos::Sparse3Tensor < int, double > | Cijk_type |
Protected Member Functions | |
Teuchos::RCP< Cijk_type > | buildParallelCijk () const |
Build parallel Cijk tensor from a parallel row map. More... | |
Protected Attributes | |
Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > | basis |
Basis. More... | |
Teuchos::RCP< const Cijk_type > | Cijk |
Triple product. More... | |
Teuchos::RCP< const EpetraExt::MultiComm > | globalMultiComm |
Multi-comm. More... | |
int | num_global_stoch_blocks |
Number of global stochastic blocks. More... | |
int | k_begin |
Beginning of k index. More... | |
int | k_end |
End of k index. More... | |
Teuchos::RCP< const Epetra_Comm > | stoch_comm |
Stochastic comm. More... | |
bool | is_parallel |
Whether stochastic blocks are parallel. More... | |
Teuchos::RCP< const Epetra_BlockMap > | stoch_row_map |
Stochastic row-map. More... | |
Teuchos::RCP< const Epetra_BlockMap > | stoch_col_map |
Stochastic col-map. More... | |
Teuchos::RCP< const Cijk_type > | Cijk_parallel |
Cijk tensor parallel over i. More... | |
Teuchos::RCP< const Epetra_CrsGraph > | stoch_graph |
Stochastic operator graph. More... | |
Definition at line 55 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
Definition at line 144 of file Stokhos_EpetraSparse3Tensor.hpp.
Stokhos::EpetraSparse3Tensor::EpetraSparse3Tensor | ( | const Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > & | basis, |
const Teuchos::RCP< const Stokhos::Sparse3Tensor< int, double > > & | Cijk, | ||
const Teuchos::RCP< const EpetraExt::MultiComm > & | globalMultiComm, | ||
int | k_begin = 0 , |
||
int | k_end = -1 |
||
) |
Constructor from a full Cijk.
Definition at line 52 of file Stokhos_EpetraSparse3Tensor.cpp.
Stokhos::EpetraSparse3Tensor::EpetraSparse3Tensor | ( | const Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > & | basis, |
const Teuchos::RCP< const Stokhos::Sparse3Tensor< int, double > > & | Cijk, | ||
const Teuchos::RCP< const EpetraExt::MultiComm > & | globalMultiComm, | ||
const Teuchos::RCP< const Epetra_BlockMap > & | stoch_row_map, | ||
const Teuchos::RCP< const Stokhos::Sparse3Tensor< int, double > > & | Cijk_parallel = Teuchos::null , |
||
int | k_begin = 0 , |
||
int | k_end = -1 |
||
) |
Constructor from an already parallelized Cijk.
Definition at line 89 of file Stokhos_EpetraSparse3Tensor.cpp.
Stokhos::EpetraSparse3Tensor::EpetraSparse3Tensor | ( | const EpetraSparse3Tensor & | epetraCijk, |
int | k_begin_ = 0 , |
||
int | k_end_ = -1 |
||
) |
Copy constructor with possible change in scaling and k limits.
Definition at line 127 of file Stokhos_EpetraSparse3Tensor.cpp.
|
inline |
Destructor.
Definition at line 79 of file Stokhos_EpetraSparse3Tensor.hpp.
void Stokhos::EpetraSparse3Tensor::rebalance | ( | Teuchos::ParameterList & | isorropia_params | ) |
Rebalance maps and graph using Isorropia.
Definition at line 157 of file Stokhos_EpetraSparse3Tensor.cpp.
void Stokhos::EpetraSparse3Tensor::transformToLocal | ( | ) |
Transform Cijk to local i and j indices.
Definition at line 210 of file Stokhos_EpetraSparse3Tensor.cpp.
|
inline |
Return k_begin index.
Definition at line 88 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Return k_end index.
Definition at line 91 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Return whether stochastic blocks are parallel distributed.
Definition at line 94 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Return global row id for given local row id.
Definition at line 97 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Return global column id for given local column id.
Definition at line 100 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Return true if global row id is on processor.
Definition at line 103 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Return true if global column id is on processor.
Definition at line 106 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Return number of rows on this processor.
Definition at line 109 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Return number of columns on this processor.
Definition at line 112 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Get global comm.
Definition at line 116 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Get stochastic comm.
Definition at line 120 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Get stochastic row map.
Definition at line 124 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Get stochastic column map.
Definition at line 128 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Get Cijk.
Definition at line 132 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Get parallel Cijk.
Definition at line 136 of file Stokhos_EpetraSparse3Tensor.hpp.
|
inline |
Get stochastic graph.
Definition at line 140 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
Build parallel Cijk tensor from a parallel row map.
Definition at line 182 of file Stokhos_EpetraSparse3Tensor.cpp.
|
protected |
Definition at line 152 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
Triple product.
Definition at line 155 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
Multi-comm.
Definition at line 158 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
Number of global stochastic blocks.
Definition at line 161 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
Beginning of k index.
Definition at line 164 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
End of k index.
Definition at line 167 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
Stochastic comm.
Definition at line 170 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
Whether stochastic blocks are parallel.
Definition at line 173 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
Stochastic row-map.
Definition at line 176 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
Stochastic col-map.
Definition at line 179 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
Cijk tensor parallel over i.
Definition at line 182 of file Stokhos_EpetraSparse3Tensor.hpp.
|
protected |
Stochastic operator graph.
Definition at line 185 of file Stokhos_EpetraSparse3Tensor.hpp.