Panzer Version of the Day
|
#include <Panzer_BlockedTpetraLinearObjFactory.hpp>
Public Types | |
typedef BlockedTpetraLinearObjContainer< ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT > | BTLOC |
typedef Tpetra::Vector< ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT > | VectorType |
typedef Tpetra::CrsMatrix< ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT > | CrsMatrixType |
typedef Tpetra::Operator< ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT > | OperatorType |
typedef Tpetra::CrsGraph< LocalOrdinalT, GlobalOrdinalT, NodeT > | CrsGraphType |
typedef Tpetra::Map< LocalOrdinalT, GlobalOrdinalT, NodeT > | MapType |
typedef Tpetra::Import< LocalOrdinalT, GlobalOrdinalT, NodeT > | ImportType |
typedef Tpetra::Export< LocalOrdinalT, GlobalOrdinalT, NodeT > | ExportType |
typedef Thyra::TpetraVector< ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT > | ThyraVector |
typedef Thyra::TpetraLinearOp< ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT > | ThyraLinearOp |
Public Member Functions | |
BlockedTpetraLinearObjFactory (const Teuchos::RCP< const Teuchos::MpiComm< int > > &comm, const Teuchos::RCP< const BlockedDOFManager > &gidProvider) | |
BlockedTpetraLinearObjFactory (const Teuchos::RCP< const Teuchos::MpiComm< int > > &comm, const std::vector< Teuchos::RCP< const panzer::GlobalIndexer > > &gidProviders) | |
Ctor that takes a vector of DOFManagers instead of the BlockedDOFManager. Plan is to deprecate the BlockedDOFManager, but for now it is ingrained in all gather/scatter operators. | |
virtual | ~BlockedTpetraLinearObjFactory () |
virtual void | readVector (const std::string &, LinearObjContainer &, int) const |
virtual void | writeVector (const std::string &, const LinearObjContainer &, int) const |
virtual Teuchos::RCP< LinearObjContainer > | buildLinearObjContainer () const |
virtual Teuchos::RCP< LinearObjContainer > | buildPrimitiveLinearObjContainer () const |
virtual Teuchos::RCP< LinearObjContainer > | buildGhostedLinearObjContainer () const |
virtual Teuchos::RCP< LinearObjContainer > | buildPrimitiveGhostedLinearObjContainer () const |
virtual void | globalToGhostContainer (const LinearObjContainer &container, LinearObjContainer &ghostContainer, int) const |
virtual void | ghostToGlobalContainer (const LinearObjContainer &ghostContainer, LinearObjContainer &container, int) const |
virtual void | adjustForDirichletConditions (const LinearObjContainer &localBCRows, const LinearObjContainer &globalBCRows, LinearObjContainer &ghostedObjs, bool zeroVectorRows=false, bool adjustX=false) const |
virtual void | applyDirichletBCs (const LinearObjContainer &counter, LinearObjContainer &result) const |
virtual Teuchos::RCP< ReadOnlyVector_GlobalEvaluationData > | buildReadOnlyDomainContainer () const |
Teuchos::MpiComm< int > | getComm () const |
template<typename EvalT > | |
Teuchos::RCP< panzer::CloneableEvaluator > | buildScatter () const |
Use preconstructed scatter evaluators. | |
template<typename EvalT > | |
Teuchos::RCP< panzer::CloneableEvaluator > | buildGather () const |
Use preconstructed gather evaluators. | |
template<typename EvalT > | |
Teuchos::RCP< panzer::CloneableEvaluator > | buildGatherTangent () const |
Use preconstructed gather evaluators. | |
template<typename EvalT > | |
Teuchos::RCP< panzer::CloneableEvaluator > | buildGatherDomain () const |
Use preconstructed gather evaluators. | |
template<typename EvalT > | |
Teuchos::RCP< panzer::CloneableEvaluator > | buildGatherOrientation () const |
Use preconstructed gather evaluators. | |
template<typename EvalT > | |
Teuchos::RCP< panzer::CloneableEvaluator > | buildScatterDirichlet () const |
Use preconstructed dirichlet scatter evaluators. | |
void | initializeContainer (int, LinearObjContainer &loc) const |
void | initializeContainer (int mem, BTLOC &loc) const |
void | initializeGhostedContainer (int, LinearObjContainer &loc) const |
void | initializeGhostedContainer (int mem, BTLOC &loc) const |
Teuchos::RCP< const Thyra::VectorSpaceBase< ScalarT > > | getThyraDomainSpace () const |
Get the domain vector space (x and dxdt) | |
Teuchos::RCP< const Thyra::VectorSpaceBase< ScalarT > > | getThyraRangeSpace () const |
Get the range vector space (f) | |
Teuchos::RCP< const Thyra::VectorSpaceBase< ScalarT > > | getThyraDomainSpace (int blk) const |
Get the domain vector space (x and dxdt) | |
Teuchos::RCP< const Thyra::VectorSpaceBase< ScalarT > > | getThyraRangeSpace (int blk) const |
Get the range vector space (f) | |
Teuchos::RCP< Thyra::VectorBase< ScalarT > > | getThyraDomainVector () const |
Get a domain vector. | |
Teuchos::RCP< Thyra::VectorBase< ScalarT > > | getThyraRangeVector () const |
Get a range vector. | |
Teuchos::RCP< Thyra::LinearOpBase< ScalarT > > | getThyraMatrix () const |
Get a Thyra operator. | |
Teuchos::RCP< const Thyra::VectorSpaceBase< ScalarT > > | getGhostedThyraDomainSpace () const |
Get the domain vector space (x and dxdt) | |
Teuchos::RCP< const Thyra::VectorSpaceBase< ScalarT > > | getGhostedThyraRangeSpace () const |
Get the range vector space (f) | |
Teuchos::RCP< Thyra::VectorBase< ScalarT > > | getGhostedThyraDomainVector () const |
Get a domain vector. | |
Teuchos::RCP< Thyra::VectorBase< ScalarT > > | getGhostedThyraRangeVector () const |
Get a range vector. | |
Teuchos::RCP< Thyra::BlockedLinearOpBase< ScalarT > > | getGhostedThyraMatrix () const |
Get a Thyra operator. | |
virtual Teuchos::RCP< const MapType > | getMap (int i) const |
get the map from the matrix | |
virtual Teuchos::RCP< const MapType > | getGhostedMap (int i) const |
get the ghosted map from the matrix | |
virtual Teuchos::RCP< const CrsGraphType > | getGraph (int i, int j) const |
get the graph of the crs matrix | |
virtual Teuchos::RCP< const CrsGraphType > | getGhostedGraph (int i, int j) const |
get the ghosted graph of the crs matrix | |
virtual Teuchos::RCP< const ImportType > | getGhostedImport (int i) const |
get importer for converting an overalapped object to a "normal" object | |
virtual Teuchos::RCP< const ExportType > | getGhostedExport (int j) const |
get exporter for converting an overalapped object to a "normal" object | |
Teuchos::RCP< CrsMatrixType > | getTpetraMatrix (int i, int j) const |
Teuchos::RCP< CrsMatrixType > | getGhostedTpetraMatrix (int i, int j) const |
Teuchos::RCP< VectorType > | getTpetraDomainVector (int i) const |
Teuchos::RCP< VectorType > | getGhostedTpetraDomainVector (int i) const |
Teuchos::RCP< VectorType > | getTpetraRangeVector (int i) const |
Teuchos::RCP< VectorType > | getGhostedTpetraRangeVector (int i) const |
int | getBlockRowCount () const |
how many block rows | |
int | getBlockColCount () const |
how many block columns | |
void | addExcludedPair (int rowBlock, int colBlock) |
exclude a block pair from the matrix | |
void | addExcludedPairs (const std::vector< std::pair< int, int > > &exPairs) |
exclude a vector of pairs from the matrix | |
virtual void | beginFill (LinearObjContainer &loc) const |
virtual void | endFill (LinearObjContainer &loc) const |
Teuchos::RCP< const panzer::BlockedDOFManager > | getGlobalIndexer () const |
Teuchos::RCP< const panzer::GlobalIndexer > | getDomainGlobalIndexer () const |
Get the domain unique global indexer this factory was created with. | |
Teuchos::RCP< const panzer::GlobalIndexer > | getRangeGlobalIndexer () const |
Get the range unique global indexer this factory was created with. | |
![]() | |
virtual | ~LinearObjFactory () |
template<typename BuilderT > | |
void | buildGatherScatterEvaluators (const BuilderT &builder) |
template<typename EvalT > | |
Teuchos::RCP< PHX::Evaluator< Traits > > | buildScatter (const Teuchos::ParameterList &pl) const |
Use preconstructed scatter evaluators. | |
template<typename EvalT > | |
Teuchos::RCP< PHX::Evaluator< Traits > > | buildGather (const Teuchos::ParameterList &pl) const |
Use preconstructed gather evaluators. | |
template<typename EvalT > | |
Teuchos::RCP< PHX::Evaluator< Traits > > | buildGatherTangent (const Teuchos::ParameterList &pl) const |
Use preconstructed gather evaluators. | |
template<typename EvalT > | |
Teuchos::RCP< PHX::Evaluator< Traits > > | buildGatherDomain (const Teuchos::ParameterList &pl) const |
Use preconstructed gather evaluators. | |
template<typename EvalT > | |
Teuchos::RCP< PHX::Evaluator< Traits > > | buildGatherOrientation (const Teuchos::ParameterList &pl) const |
Use preconstructed gather evaluators. | |
template<typename EvalT > | |
Teuchos::RCP< PHX::Evaluator< Traits > > | buildScatterDirichlet (const Teuchos::ParameterList &pl) const |
Use preconstructed dirichlet scatter evaluators. | |
![]() | |
virtual | ~ThyraObjFactory () |
Protected Member Functions | |
Teuchos::RCP< const GlobalIndexer > | getGlobalIndexer (int i) const |
void | makeRoomForBlocks (std::size_t blockCnt) |
Allocate the space in the std::vector objects so we can fill with appropriate Tpetra data. | |
void | ghostToGlobalThyraVector (const Teuchos::RCP< const Thyra::VectorBase< ScalarT > > &in, const Teuchos::RCP< Thyra::VectorBase< ScalarT > > &out) const |
void | ghostToGlobalThyraMatrix (const Thyra::LinearOpBase< ScalarT > &in, Thyra::LinearOpBase< ScalarT > &out) const |
void | globalToGhostThyraVector (const Teuchos::RCP< const Thyra::VectorBase< ScalarT > > &in, const Teuchos::RCP< Thyra::VectorBase< ScalarT > > &out) const |
void | adjustForDirichletConditions (const VectorType &local_bcs, const VectorType &global_bcs, const Teuchos::Ptr< VectorType > &f, const Teuchos::Ptr< CrsMatrixType > &A, bool zeroVectorRows) const |
void | ghostToGlobalTpetraVector (int i, const VectorType &in, VectorType &out) const |
void | ghostToGlobalTpetraMatrix (int blockRow, const CrsMatrixType &in, CrsMatrixType &out) const |
void | globalToGhostTpetraVector (int i, const VectorType &in, VectorType &out) const |
virtual Teuchos::RCP< const MapType > | buildTpetraMap (int i) const |
virtual Teuchos::RCP< const MapType > | buildTpetraGhostedMap (int i) const |
virtual Teuchos::RCP< const CrsGraphType > | buildTpetraGraph (int i, int j) const |
virtual Teuchos::RCP< const CrsGraphType > | buildTpetraGhostedGraph (int i, int j) const |
Protected Attributes | |
Teuchos::RCP< const GlobalIndexer > | blockProvider_ |
Teuchos::RCP< const BlockedDOFManager > | blockedDOFManager_ |
std::vector< Teuchos::RCP< const GlobalIndexer > > | gidProviders_ |
std::unordered_set< std::pair< int, int >, panzer::pair_hash > | excludedPairs_ |
Teuchos::RCP< Thyra::ProductVectorSpaceBase< ScalarT > > | rangeSpace_ |
Teuchos::RCP< Thyra::ProductVectorSpaceBase< ScalarT > > | domainSpace_ |
Teuchos::RCP< Thyra::ProductVectorSpaceBase< ScalarT > > | ghostedRangeSpace_ |
Teuchos::RCP< Thyra::ProductVectorSpaceBase< ScalarT > > | ghostedDomainSpace_ |
Teuchos::RCP< const Teuchos::MpiComm< int > > | comm_ |
std::vector< Teuchos::RCP< const MapType > > | maps_ |
std::vector< Teuchos::RCP< const MapType > > | ghostedMaps_ |
std::unordered_map< std::pair< int, int >, Teuchos::RCP< const CrsGraphType >, panzer::pair_hash > | graphs_ |
std::unordered_map< std::pair< int, int >, Teuchos::RCP< const CrsGraphType >, panzer::pair_hash > | ghostedGraphs_ |
std::vector< Teuchos::RCP< const ImportType > > | importers_ |
std::vector< Teuchos::RCP< const ExportType > > | exporters_ |
Definition at line 81 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
typedef BlockedTpetraLinearObjContainer<ScalarT,LocalOrdinalT,GlobalOrdinalT,NodeT> panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::BTLOC |
Definition at line 84 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
typedef Tpetra::Vector<ScalarT,LocalOrdinalT,GlobalOrdinalT,NodeT> panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::VectorType |
Definition at line 85 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
typedef Tpetra::CrsMatrix<ScalarT,LocalOrdinalT,GlobalOrdinalT,NodeT> panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::CrsMatrixType |
Definition at line 86 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
typedef Tpetra::Operator<ScalarT,LocalOrdinalT,GlobalOrdinalT,NodeT> panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::OperatorType |
Definition at line 87 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
typedef Tpetra::CrsGraph<LocalOrdinalT,GlobalOrdinalT,NodeT> panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::CrsGraphType |
Definition at line 88 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
typedef Tpetra::Map<LocalOrdinalT,GlobalOrdinalT,NodeT> panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::MapType |
Definition at line 89 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
typedef Tpetra::Import<LocalOrdinalT,GlobalOrdinalT,NodeT> panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::ImportType |
Definition at line 90 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
typedef Tpetra::Export<LocalOrdinalT,GlobalOrdinalT,NodeT> panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::ExportType |
Definition at line 91 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
typedef Thyra::TpetraVector<ScalarT,LocalOrdinalT,GlobalOrdinalT,NodeT> panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::ThyraVector |
Definition at line 93 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
typedef Thyra::TpetraLinearOp<ScalarT,LocalOrdinalT,GlobalOrdinalT,NodeT> panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::ThyraLinearOp |
Definition at line 94 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::BlockedTpetraLinearObjFactory | ( | const Teuchos::RCP< const Teuchos::MpiComm< int > > & | comm, |
const Teuchos::RCP< const BlockedDOFManager > & | gidProvider ) |
Definition at line 75 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::BlockedTpetraLinearObjFactory | ( | const Teuchos::RCP< const Teuchos::MpiComm< int > > & | comm, |
const std::vector< Teuchos::RCP< const panzer::GlobalIndexer > > & | gidProviders ) |
Ctor that takes a vector of DOFManagers instead of the BlockedDOFManager. Plan is to deprecate the BlockedDOFManager, but for now it is ingrained in all gather/scatter operators.
Definition at line 91 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
Definition at line 100 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
inlinevirtual |
Read in a vector from a file. Fill a particular vector in the linear object container.
[in] | identifier | Key for specifying which file(s) to read |
[in] | loc | Linear object container to fill with the vector |
[in] | id | Id for the field to be filled |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 111 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
inlinevirtual |
Write in a vector from a file. Fill a particular vector in the linear object container.
[in] | identifier | Key for specifying which file(s) to read |
[in] | loc | Linear object container to fill with the vector |
[in] | id | Id for the field to be filled |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 114 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
virtual |
Build a container with all the neccessary linear algebra objects. This is the non-ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 109 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
inlinevirtual |
Build a container with all the neccessary linear algebra objects, purely on the single physics. This gives linear algebra objects that are relevant for a single physics solve. In many cases this is simply a call to buildLinearObjContainer however, in a few important cases (for instance in stochastic galerkin methods) this will return a container for a single instantiation of the physics. This is the non-ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 119 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
virtual |
Build a container with all the neccessary linear algebra objects. This is the ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 125 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
inlinevirtual |
Build a container with all the neccessary linear algebra objects, purely on the single physics. This gives linear algebra objects that are relevant for a single physics solve. In many cases this is simply a call to buildGhostedLinearObjContainer however, in a few important cases (for instance in stochastic galerkin methods) this will return a container for a single instantiation of the physics. This is the ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 124 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
virtual |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 140 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 163 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
Adjust the residual vector and Jacobian matrix (if they exist) for applied dirichlet conditions. The adjustment considers if a boundary condition was set globally and locally and based on that result adjust the ghosted matrix and residual vector so that when they are summed across processors they resulting Dirichlet condition is correct.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 186 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
Adjust a vector by replacing selected rows with the value of the evaluated dirichlet conditions. This is handled through the standard container mechanism.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 336 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
Build a GlobalEvaluationDataContainer that handles all domain communication. This is used primarily for gather operations and hides the allocation and usage of the ghosted vector from the user.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 352 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
Acess to the MPI Comm used in constructing this LOF.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 397 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
inline |
Use preconstructed scatter evaluators.
Definition at line 167 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 172 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 177 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 182 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 187 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed dirichlet scatter evaluators.
Definition at line 192 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
virtual |
Initialize container with a specific set of member values.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 404 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
void panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::initializeContainer | ( | int | mem, |
BTLOC & | loc ) const |
Initialize container with a specific set of member values.
Definition at line 423 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
Initialize container with a specific set of member values.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 412 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
void panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::initializeGhostedContainer | ( | int | mem, |
BTLOC & | loc ) const |
Initialize container with a specific set of member values.
Definition at line 444 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
Get the domain vector space (x and dxdt)
Implements panzer::ThyraObjFactory< double >.
Definition at line 506 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
Get the range vector space (f)
Implements panzer::ThyraObjFactory< double >.
Definition at line 523 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< const Thyra::VectorSpaceBase< ScalarT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getThyraDomainSpace | ( | int | blk | ) | const |
Get the domain vector space (x and dxdt)
Definition at line 540 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< const Thyra::VectorSpaceBase< ScalarT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getThyraRangeSpace | ( | int | blk | ) | const |
Get the range vector space (f)
Definition at line 552 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Thyra::VectorBase< ScalarT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getThyraDomainVector | ( | ) | const |
Get a domain vector.
Definition at line 564 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Thyra::VectorBase< ScalarT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getThyraRangeVector | ( | ) | const |
Get a range vector.
Definition at line 582 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
Get a Thyra operator.
Implements panzer::ThyraObjFactory< double >.
Definition at line 594 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< const Thyra::VectorSpaceBase< ScalarT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getGhostedThyraDomainSpace | ( | ) | const |
Get the domain vector space (x and dxdt)
Definition at line 624 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< const Thyra::VectorSpaceBase< ScalarT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getGhostedThyraRangeSpace | ( | ) | const |
Get the range vector space (f)
Definition at line 641 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Thyra::VectorBase< ScalarT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getGhostedThyraDomainVector | ( | ) | const |
Get a domain vector.
Definition at line 658 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Thyra::VectorBase< ScalarT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getGhostedThyraRangeVector | ( | ) | const |
Get a range vector.
Definition at line 670 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Thyra::BlockedLinearOpBase< ScalarT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getGhostedThyraMatrix | ( | ) | const |
Get a Thyra operator.
Definition at line 682 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
get the map from the matrix
Definition at line 860 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
get the ghosted map from the matrix
Definition at line 871 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
get the graph of the crs matrix
Definition at line 883 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
get the ghosted graph of the crs matrix
Definition at line 903 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
get importer for converting an overalapped object to a "normal" object
Definition at line 923 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
get exporter for converting an overalapped object to a "normal" object
Definition at line 934 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Tpetra::CrsMatrix< ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getTpetraMatrix | ( | int | i, |
int | j ) const |
Definition at line 1078 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Tpetra::CrsMatrix< ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getGhostedTpetraMatrix | ( | int | i, |
int | j ) const |
Definition at line 1093 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Tpetra::Vector< ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getTpetraDomainVector | ( | int | i | ) | const |
Definition at line 1108 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Tpetra::Vector< ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getGhostedTpetraDomainVector | ( | int | i | ) | const |
Definition at line 1117 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Tpetra::Vector< ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getTpetraRangeVector | ( | int | i | ) | const |
Definition at line 1126 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Tpetra::Vector< ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT > > panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getGhostedTpetraRangeVector | ( | int | i | ) | const |
Definition at line 1135 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
int panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getBlockRowCount | ( | ) | const |
how many block rows
Definition at line 1144 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
int panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::getBlockColCount | ( | ) | const |
how many block columns
Definition at line 1152 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
void panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::addExcludedPair | ( | int | rowBlock, |
int | colBlock ) |
exclude a block pair from the matrix
Definition at line 469 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
void panzer::BlockedTpetraLinearObjFactory< Traits, ScalarT, LocalOrdinalT, GlobalOrdinalT, NodeT >::addExcludedPairs | ( | const std::vector< std::pair< int, int > > & | exPairs | ) |
exclude a vector of pairs from the matrix
Definition at line 476 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
Reimplemented from panzer::LinearObjFactory< Traits >.
Definition at line 1159 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
virtual |
Reimplemented from panzer::LinearObjFactory< Traits >.
Definition at line 1168 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
inline |
Definition at line 309 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
inlinevirtual |
Get the domain unique global indexer this factory was created with.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 313 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
inlinevirtual |
Get the range unique global indexer this factory was created with.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 317 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
protected |
Definition at line 485 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protected |
Allocate the space in the std::vector objects so we can fill with appropriate Tpetra data.
Definition at line 492 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 711 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 739 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 785 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 270 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 816 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 828 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 846 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 945 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 959 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 973 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 997 of file Panzer_BlockedTpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 329 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
protected |
Definition at line 330 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
protected |
Definition at line 331 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
protected |
Definition at line 334 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 344 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 345 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 347 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 348 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
protected |
Definition at line 371 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 372 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 373 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 374 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 375 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 377 of file Panzer_BlockedTpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 378 of file Panzer_BlockedTpetraLinearObjFactory.hpp.