|
Panzer Version of the Day
|
#include <Panzer_BlockedEpetraLinearObjFactory.hpp>

Classes | |
| class | DOFManagerContainer |
Public Member Functions | |
| BlockedEpetraLinearObjFactory (const Teuchos::RCP< const Teuchos::MpiComm< int > > &comm, const Teuchos::RCP< const GlobalIndexer > &gidProvider, bool useDiscreteAdjoint=false) | |
| BlockedEpetraLinearObjFactory (const Teuchos::RCP< const Teuchos::MpiComm< int > > &comm, const Teuchos::RCP< const GlobalIndexer > &gidProvider, const Teuchos::RCP< const GlobalIndexer > &colGidProvider, bool useDiscreteAdjoint=false) | |
| virtual | ~BlockedEpetraLinearObjFactory () |
| virtual void | readVector (const std::string &identifier, LinearObjContainer &loc, int id) const |
| virtual void | writeVector (const std::string &identifier, const LinearObjContainer &loc, int id) 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 |
| virtual Teuchos::RCP< WriteVector_GlobalEvaluationData > | buildWriteDomainContainer () const |
| virtual 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 | initializeGhostedContainer (int, LinearObjContainer &loc) const |
| Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | getThyraDomainSpace () const |
| Get the domain vector space (x and dxdt) | |
| Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | getThyraRangeSpace () const |
| Get the range vector space (f) | |
| Teuchos::RCP< Thyra::VectorBase< double > > | getThyraDomainVector () const |
| Get a domain vector. | |
| Teuchos::RCP< Thyra::VectorBase< double > > | getThyraRangeVector () const |
| Get a range vector. | |
| Teuchos::RCP< Thyra::LinearOpBase< double > > | getThyraMatrix () const |
| Get a Thyra operator. | |
| Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | getGhostedThyraDomainSpace () const |
| Get the domain vector space (x and dxdt) | |
| Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | getGhostedThyraDomainSpace2 () const |
Get or create the ghosted Thyra domain space. | |
| Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | getGhostedThyraRangeSpace () const |
| Get the range vector space (f) | |
| Teuchos::RCP< Thyra::VectorBase< double > > | getGhostedThyraDomainVector () const |
| Get a domain vector. | |
| Teuchos::RCP< Thyra::VectorBase< double > > | getGhostedThyraRangeVector () const |
| Get a range vector. | |
| Teuchos::RCP< Thyra::LinearOpBase< double > > | getGhostedThyraMatrix () const |
| Get a Thyra operator. | |
| virtual const Teuchos::RCP< Epetra_Map > | getMap (int i) const |
| get the map from the matrix | |
| virtual const Teuchos::RCP< Epetra_Map > | getColMap (int i) const |
| get the map from the matrix | |
| virtual const Teuchos::RCP< Epetra_Map > | getGhostedMap (int i) const |
| get the ghosted map from the matrix | |
| virtual const Teuchos::RCP< Epetra_Map > | getGhostedMap2 (int i) const |
Get or create the i-th ghosted map. | |
| virtual const Teuchos::RCP< Epetra_Map > | getGhostedColMap (int i) const |
| get the ghosted map from the matrix | |
| virtual const Teuchos::RCP< Epetra_Map > | getGhostedColMap2 (int i) const |
Get or create the i-th ghosted column map. | |
| virtual const Teuchos::RCP< Epetra_CrsGraph > | getGraph (int i, int j) const |
| get the graph of the crs matrix | |
| virtual const Teuchos::RCP< Epetra_CrsGraph > | getGhostedGraph (int i, int j) const |
| get the ghosted graph of the crs matrix | |
| virtual const Teuchos::RCP< Epetra_Import > | getGhostedImport (int i) const |
| get importer for converting an overalapped object to a "normal" object | |
| virtual const Teuchos::RCP< Epetra_Import > | getGhostedImport2 (int i) const |
Get or create the i-th ghosted importer corresponding to the i-th ghosted map. | |
| virtual const Teuchos::RCP< Epetra_Import > | getGhostedColImport (int i) const |
| get importer for converting an overalapped object to a "normal" object | |
| virtual const Teuchos::RCP< Epetra_Import > | getGhostedColImport2 (int i) const |
Get or create the i-th ghosted column importer corresponding to the i-th ghosted column map. | |
| virtual const Teuchos::RCP< Epetra_Export > | getGhostedExport (int j) const |
| get exporter for converting an overalapped object to a "normal" object | |
| virtual const Teuchos::RCP< Epetra_Export > | getGhostedExport2 (int i) const |
Get or create the i-th ghosted exporter corresponding to the i-th ghosted map. | |
| virtual const Teuchos::RCP< Epetra_Export > | getGhostedColExport (int j) const |
| get exporter for converting an overalapped object to a "normal" object | |
| virtual const Teuchos::RCP< Epetra_Export > | getGhostedColExport2 (int i) const |
Get or create the i-th ghosted column exporter corresponding to the i-th ghosted column map. | |
| virtual const Teuchos::RCP< const Epetra_Comm > | getEpetraComm () const |
| get exporter for converting an overalapped object to a "normal" object | |
| Teuchos::RCP< Epetra_CrsMatrix > | getEpetraMatrix (int i, int j) const |
| Teuchos::RCP< Epetra_CrsMatrix > | getGhostedEpetraMatrix (int i, int j) const |
| int | getBlockRowCount () const |
| how many block rows | |
| int | getBlockColCount () const |
| how many block columns | |
| Teuchos::RCP< const panzer::BlockedDOFManager > | getGlobalIndexer () const |
| Teuchos::RCP< const panzer::GlobalIndexer > | getRangeGlobalIndexer () const |
| Get the range global indexer object associated with this factory. | |
| Teuchos::RCP< const panzer::GlobalIndexer > | getDomainGlobalIndexer () const |
| Get the domain global indexer object associated with this factory. | |
| const std::vector< Teuchos::RCP< const GlobalIndexer > > & | getRangeGlobalIndexers () const |
| Get global indexers associated with the blocks. | |
| const std::vector< Teuchos::RCP< const GlobalIndexer > > & | getDomainGlobalIndexers () const |
| Get global indexers associated with the blocks. | |
| 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 | |
Public Member Functions inherited from panzer::LinearObjFactory< Traits > | |
| 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 void | beginFill (LinearObjContainer &) const |
| virtual void | endFill (LinearObjContainer &) const |
Public Member Functions inherited from panzer::ThyraObjFactory< double > | |
| virtual | ~ThyraObjFactory () |
Protected Member Functions | |
| void | initializeContainer_internal (int mem, ThyraObjContainer< double > &loc) const |
| void | initializeGhostedContainer_internal (int mem, ThyraObjContainer< double > &loc) const |
| Teuchos::RCP< const GlobalIndexer > | getGlobalIndexer (int i) const |
| Teuchos::RCP< const GlobalIndexer > | getColGlobalIndexer (int i) const |
| void | makeRoomForBlocks (std::size_t blockCnt, std::size_t colBlockCnt=0) |
| Allocate the space in the std::vector objects so we can fill with appropriate Epetra data. | |
| void | ghostToGlobalThyraVector (const Teuchos::RCP< const Thyra::VectorBase< double > > &in, const Teuchos::RCP< Thyra::VectorBase< double > > &out, bool col) const |
| void | ghostToGlobalThyraMatrix (const Thyra::LinearOpBase< double > &in, Thyra::LinearOpBase< double > &out) const |
| void | globalToGhostThyraVector (const Teuchos::RCP< const Thyra::VectorBase< double > > &in, const Teuchos::RCP< Thyra::VectorBase< double > > &out, bool col) const |
| void | adjustForDirichletConditions (const Epetra_Vector &local_bcs, const Epetra_Vector &global_bcs, const Teuchos::Ptr< Epetra_Vector > &f, const Teuchos::Ptr< Epetra_CrsMatrix > &A, bool zeroVectorRows) const |
| void | ghostToGlobalEpetraVector (int i, const Epetra_Vector &in, Epetra_Vector &out, bool col) const |
| void | globalToGhostEpetraVector (int i, const Epetra_Vector &in, Epetra_Vector &out, bool col) const |
| void | ghostToGlobalEpetraMatrix (int blockRow, const Epetra_CrsMatrix &in, Epetra_CrsMatrix &out) const |
| virtual const Teuchos::RCP< Epetra_Map > | buildMap (int i) const |
Build the i-th owned map from the owned indices of the i-th global indexer. | |
| virtual const Teuchos::RCP< Epetra_Map > | buildGhostedMap (int i) const |
Build the i-th ghosted map from the owned and ghosted indices of the i-th global indexer. | |
| virtual const Teuchos::RCP< Epetra_Map > | buildGhostedMap2 (int i) const |
Build the i-th ghosted map from the ghosted indices of the i-th global indexer. | |
| virtual const Teuchos::RCP< Epetra_Map > | buildColMap (int i) const |
Build the i-th owned column map from the owned indices of the i-th (column) global indexer. | |
| virtual const Teuchos::RCP< Epetra_Map > | buildColGhostedMap (int i) const |
Build the i-th ghosted column map from the owned and ghosted indices of the i-th (column) global indexer. | |
| virtual const Teuchos::RCP< Epetra_Map > | buildColGhostedMap2 (int i) const |
Build the i-th ghosted column map from the ghosted indices of the i-th (column) global indexer. | |
| virtual const Teuchos::RCP< Epetra_CrsGraph > | buildGraph (int i, int j) const |
| virtual const Teuchos::RCP< Epetra_CrsGraph > | buildGhostedGraph (int i, int j, bool optimizeStorage) const |
| virtual const Teuchos::RCP< Epetra_CrsGraph > | buildFilteredGhostedGraph (int i, int j) const |
Protected Attributes | |
| Teuchos::RCP< const DOFManagerContainer > | rowDOFManagerContainer_ |
| Teuchos::RCP< const DOFManagerContainer > | colDOFManagerContainer_ |
| bool | useColGidProviders_ |
| std::unordered_set< std::pair< int, int >, panzer::pair_hash > | excludedPairs_ |
| Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | rangeSpace_ |
| Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | domainSpace_ |
| Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | ghostedRangeSpace_ |
| Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | ghostedDomainSpace_ |
| Teuchos::RCP< const Epetra_Comm > | eComm_ |
| Teuchos::RCP< const Teuchos::OpaqueWrapper< MPI_Comm > > | rawMpiComm_ |
| Teuchos::RCP< Teuchos::MpiComm< int > > | tComm_ |
| std::vector< Teuchos::RCP< Epetra_Map > > | maps_ |
| The list of owned maps corresponding to the owned indices of the global indexers. | |
| std::vector< Teuchos::RCP< Epetra_Map > > | ghostedMaps_ |
| The list of ghosted maps corresponding to the owned and ghosted indices of the global indexers. | |
| std::vector< Teuchos::RCP< Epetra_Map > > | ghostedMaps2_ |
| The list of ghosted maps corresponding to the ghosted indices of the global indexers. | |
| std::vector< Teuchos::RCP< Epetra_Import > > | importers_ |
The list of ghosted importers corresponding to ghostedMaps_. | |
| std::vector< Teuchos::RCP< Epetra_Import > > | importers2_ |
The list of ghosted importers corresponding to ghostedMaps2_. | |
| std::vector< Teuchos::RCP< Epetra_Export > > | exporters_ |
| std::vector< Teuchos::RCP< Epetra_Map > > | colMaps_ |
| The list of owned column maps corresponding to the owned indices of the (column) global indexers. | |
| std::vector< Teuchos::RCP< Epetra_Map > > | colGhostedMaps_ |
| The list of ghosted column maps corresponding to the owned and ghosted indices of the (column) global indexers. | |
| std::vector< Teuchos::RCP< Epetra_Map > > | colGhostedMaps2_ |
| The list of ghosted column maps corresponding to the ghosted indices of the (column) global indexers. | |
| std::vector< Teuchos::RCP< Epetra_Import > > | colImporters_ |
The list of ghosted importers corresponding to colGhostedMaps_. | |
| std::vector< Teuchos::RCP< Epetra_Import > > | colImporters2_ |
The list of ghosted importers corresponding to colGhostedMaps2_. | |
| std::vector< Teuchos::RCP< Epetra_Export > > | colExporters_ |
| std::unordered_map< std::pair< int, int >, Teuchos::RCP< Epetra_CrsGraph >, panzer::pair_hash > | graphs_ |
| std::unordered_map< std::pair< int, int >, Teuchos::RCP< Epetra_CrsGraph >, panzer::pair_hash > | ghostedGraphs_ |
| bool | useDiscreteAdjoint_ |
Definition at line 54 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
| panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::BlockedEpetraLinearObjFactory | ( | const Teuchos::RCP< const Teuchos::MpiComm< int > > & | comm, |
| const Teuchos::RCP< const GlobalIndexer > & | gidProvider, | ||
| bool | useDiscreteAdjoint = false |
||
| ) |
Definition at line 53 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::BlockedEpetraLinearObjFactory | ( | const Teuchos::RCP< const Teuchos::MpiComm< int > > & | comm, |
| const Teuchos::RCP< const GlobalIndexer > & | gidProvider, | ||
| const Teuchos::RCP< const GlobalIndexer > & | colGidProvider, | ||
| bool | useDiscreteAdjoint = false |
||
| ) |
Definition at line 76 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Definition at line 102 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
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 110 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
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 160 of file Panzer_BlockedEpetraLinearObjFactory_impl.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 205 of file Panzer_BlockedEpetraLinearObjFactory_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 77 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
virtual |
Build a container with all the neccessary linear algebra objects. This is the ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 226 of file Panzer_BlockedEpetraLinearObjFactory_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 82 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
virtual |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 247 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 289 of file Panzer_BlockedEpetraLinearObjFactory_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 331 of file Panzer_BlockedEpetraLinearObjFactory_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 468 of file Panzer_BlockedEpetraLinearObjFactory_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 512 of file Panzer_BlockedEpetraLinearObjFactory_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.
Definition at line 554 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Acess to the MPI Comm used in constructing this LOF.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 590 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
inline |
Use preconstructed scatter evaluators.
Definition at line 123 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 138 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 148 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 158 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 167 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed dirichlet scatter evaluators.
Definition at line 172 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
virtual |
Initialize container with a specific set of member values.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 597 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Initialize container with a specific set of member values.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 607 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get the domain vector space (x and dxdt)
Implements panzer::ThyraObjFactory< double >.
Definition at line 745 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get the range vector space (f)
Implements panzer::ThyraObjFactory< double >.
Definition at line 768 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| Teuchos::RCP< Thyra::VectorBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getThyraDomainVector | ( | ) | const |
Get a domain vector.
Definition at line 791 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| Teuchos::RCP< Thyra::VectorBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getThyraRangeVector | ( | ) | const |
Get a range vector.
Definition at line 802 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get a Thyra operator.
Implements panzer::ThyraObjFactory< double >.
Definition at line 813 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| Teuchos::RCP< const Thyra::VectorSpaceBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraDomainSpace | ( | ) | const |
Get the domain vector space (x and dxdt)
Definition at line 855 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| Teuchos::RCP< const Thyra::VectorSpaceBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraDomainSpace2 | ( | ) | const |
Get or create the ghosted Thyra domain space.
Get the vector space corresponding to the ghosted domain. If it does not yet exist, create it from the ghosted column map(s).
Definition at line 890 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| Teuchos::RCP< const Thyra::VectorSpaceBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraRangeSpace | ( | ) | const |
Get the range vector space (f)
Definition at line 919 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| Teuchos::RCP< Thyra::VectorBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraDomainVector | ( | ) | const |
Get a domain vector.
Definition at line 942 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| Teuchos::RCP< Thyra::VectorBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraRangeVector | ( | ) | const |
Get a range vector.
Definition at line 953 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| Teuchos::RCP< Thyra::LinearOpBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraMatrix | ( | ) | const |
Get a Thyra operator.
Definition at line 964 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the map from the matrix
Definition at line 1164 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the map from the matrix
Definition at line 1175 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the ghosted map from the matrix
Definition at line 1194 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get or create the i-th ghosted map.
| [in] | i | The index into the list of ghosted maps. |
i-th ghosted map. Definition at line 1210 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the ghosted map from the matrix
Definition at line 1226 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get or create the i-th ghosted column map.
| [in] | i | The index into the list of ghosted column maps. |
i-th ghosted column map. Definition at line 1244 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the graph of the crs matrix
Definition at line 1257 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the ghosted graph of the crs matrix
Definition at line 1276 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get importer for converting an overalapped object to a "normal" object
Definition at line 1301 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get or create the i-th ghosted importer corresponding to the i-th ghosted map.
| [in] | i | The index into the list of ghosted importers. |
i-th ghosted importer. Definition at line 1318 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get importer for converting an overalapped object to a "normal" object
Definition at line 1335 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get or create the i-th ghosted column importer corresponding to the i-th ghosted column map.
| [in] | i | The index into the list of ghosted column importers. |
i-th ghosted column importer. Definition at line 1355 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get exporter for converting an overalapped object to a "normal" object
Definition at line 1375 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get or create the i-th ghosted exporter corresponding to the i-th ghosted map.
| [in] | i | The index into the list of ghosted exporters. |
i-th ghosted exporter. Definition at line 1392 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get exporter for converting an overalapped object to a "normal" object
Definition at line 1409 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get or create the i-th ghosted column exporter corresponding to the i-th ghosted column map.
| [in] | i | The index into the list of ghosted column exporters. |
i-th ghosted column exporter. Definition at line 1429 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get exporter for converting an overalapped object to a "normal" object
Definition at line 1710 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| Teuchos::RCP< Epetra_CrsMatrix > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getEpetraMatrix | ( | int | i, |
| int | j | ||
| ) | const |
Definition at line 1690 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| Teuchos::RCP< Epetra_CrsMatrix > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedEpetraMatrix | ( | int | i, |
| int | j | ||
| ) | const |
Definition at line 1700 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| int panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getBlockRowCount | ( | ) | const |
how many block rows
Definition at line 1717 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| int panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getBlockColCount | ( | ) | const |
how many block columns
Definition at line 1724 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
inline |
Definition at line 378 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inlinevirtual |
Get the range global indexer object associated with this factory.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 381 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inlinevirtual |
Get the domain global indexer object associated with this factory.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 384 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Get global indexers associated with the blocks.
Definition at line 388 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Get global indexers associated with the blocks.
Definition at line 392 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
| void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::addExcludedPair | ( | int | rowBlock, |
| int | colBlock | ||
| ) |
exclude a block pair from the matrix
Definition at line 684 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
| void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::addExcludedPairs | ( | const std::vector< std::pair< int, int > > & | exPairs | ) |
exclude a vector of pairs from the matrix
Definition at line 691 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Initialize container with a specific set of member values.
Definition at line 642 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Initialize container with a specific set of member values.
Definition at line 663 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 699 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 706 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Allocate the space in the std::vector objects so we can fill with appropriate Epetra data.
Definition at line 719 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1000 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1037 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1083 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 419 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1124 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1150 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1137 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Build the i-th owned map from the owned indices of the i-th global indexer.
| [in] | i | The index into the list of global indexers. |
i-th owned map. Definition at line 1443 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Build the i-th ghosted map from the owned and ghosted indices of the i-th global indexer.
| [in] | i | The index into the list of global indexers. |
i-th owned and ghosted map. Definition at line 1476 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Build the i-th ghosted map from the ghosted indices of the i-th global indexer.
| [in] | i | The index into the list of global indexers. |
i-th ghosted map. Definition at line 1494 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Build the i-th owned column map from the owned indices of the i-th (column) global indexer.
| [in] | i | The index into the list of (column) global indexers. |
i-th owned column map. Definition at line 1455 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Build the i-th ghosted column map from the owned and ghosted indices of the i-th (column) global indexer.
| [in] | i | The index into the list of (column) global indexers. |
i-th owned and ghosted column map. Definition at line 1512 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Build the i-th ghosted column map from the ghosted indices of the i-th (column) global indexer.
| [in] | i | The index into the list of (column) global indexers. |
i-th ghosted column map. Definition at line 1532 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1547 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1577 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1641 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 504 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 505 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 507 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 510 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 520 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 521 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 523 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 524 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 620 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 621 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 622 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of owned maps corresponding to the owned indices of the global indexers.
Definition at line 628 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted maps corresponding to the owned and ghosted indices of the global indexers.
Definition at line 634 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted maps corresponding to the ghosted indices of the global indexers.
Definition at line 640 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted importers corresponding to ghostedMaps_.
Definition at line 645 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted importers corresponding to ghostedMaps2_.
Definition at line 650 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 652 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of owned column maps corresponding to the owned indices of the (column) global indexers.
Definition at line 658 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted column maps corresponding to the owned and ghosted indices of the (column) global indexers.
Definition at line 664 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted column maps corresponding to the ghosted indices of the (column) global indexers.
Definition at line 670 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted importers corresponding to colGhostedMaps_.
Definition at line 675 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted importers corresponding to colGhostedMaps2_.
Definition at line 681 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 683 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 685 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 686 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 688 of file Panzer_BlockedEpetraLinearObjFactory.hpp.