Panzer  Version of the Day
Classes | Public Member Functions | Protected Member Functions | Protected Attributes | List of all members
panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT > Class Template Reference

#include <Panzer_BlockedEpetraLinearObjFactory.hpp>

Inheritance diagram for panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >:
Inheritance graph
[legend]

Classes

class  DOFManagerContainer
 

Public Member Functions

 BlockedEpetraLinearObjFactory (const Teuchos::RCP< const Teuchos::MpiComm< int > > &comm, const Teuchos::RCP< const UniqueGlobalIndexerBase > &gidProvider, bool useDiscreteAdjoint=false)
 
 BlockedEpetraLinearObjFactory (const Teuchos::RCP< const Teuchos::MpiComm< int > > &comm, const Teuchos::RCP< const UniqueGlobalIndexerBase > &gidProvider, const Teuchos::RCP< const UniqueGlobalIndexerBase > &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< LinearObjContainerbuildLinearObjContainer () const
 
virtual Teuchos::RCP< LinearObjContainerbuildPrimitiveLinearObjContainer () const
 
virtual Teuchos::RCP< LinearObjContainerbuildGhostedLinearObjContainer () const
 
virtual Teuchos::RCP< LinearObjContainerbuildPrimitiveGhostedLinearObjContainer () 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_GlobalEvaluationDatabuildDomainContainer () const
 
virtual Teuchos::MpiComm< int > getComm () const
 
template<typename EvalT >
Teuchos::RCP< panzer::CloneableEvaluatorbuildScatter () const
 Use preconstructed scatter evaluators. More...
 
template<typename EvalT >
Teuchos::RCP< panzer::CloneableEvaluatorbuildGather () const
 Use preconstructed gather evaluators. More...
 
template<typename EvalT >
Teuchos::RCP< panzer::CloneableEvaluatorbuildGatherTangent () const
 Use preconstructed gather evaluators. More...
 
template<typename EvalT >
Teuchos::RCP< panzer::CloneableEvaluatorbuildGatherDomain () const
 Use preconstructed gather evaluators. More...
 
template<typename EvalT >
Teuchos::RCP< panzer::CloneableEvaluatorbuildGatherOrientation () const
 Use preconstructed gather evaluators. More...
 
template<typename EvalT >
Teuchos::RCP< panzer::CloneableEvaluatorbuildScatterDirichlet () const
 Use preconstructed dirichlet scatter evaluators. More...
 
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) More...
 
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > getThyraRangeSpace () const
 Get the range vector space (f) More...
 
Teuchos::RCP< Thyra::VectorBase< double > > getThyraDomainVector () const
 Get a domain vector. More...
 
Teuchos::RCP< Thyra::VectorBase< double > > getThyraRangeVector () const
 Get a range vector. More...
 
Teuchos::RCP< Thyra::LinearOpBase< double > > getThyraMatrix () const
 Get a Thyra operator. More...
 
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > getGhostedThyraDomainSpace () const
 Get the domain vector space (x and dxdt) More...
 
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > getGhostedThyraRangeSpace () const
 Get the range vector space (f) More...
 
Teuchos::RCP< Thyra::VectorBase< double > > getGhostedThyraDomainVector () const
 Get a domain vector. More...
 
Teuchos::RCP< Thyra::VectorBase< double > > getGhostedThyraRangeVector () const
 Get a range vector. More...
 
Teuchos::RCP< Thyra::LinearOpBase< double > > getGhostedThyraMatrix () const
 Get a Thyra operator. More...
 
virtual const Teuchos::RCP< Epetra_MapgetMap (int i) const
 get the map from the matrix More...
 
virtual const Teuchos::RCP< Epetra_MapgetColMap (int i) const
 get the map from the matrix More...
 
virtual const Teuchos::RCP< Epetra_MapgetGhostedMap (int i) const
 get the ghosted map from the matrix More...
 
virtual const Teuchos::RCP< Epetra_MapgetGhostedColMap (int i) const
 get the ghosted map from the matrix More...
 
virtual const Teuchos::RCP< Epetra_CrsGraphgetGraph (int i, int j) const
 get the graph of the crs matrix More...
 
virtual const Teuchos::RCP< Epetra_CrsGraphgetGhostedGraph (int i, int j) const
 get the ghosted graph of the crs matrix More...
 
virtual const Teuchos::RCP< Epetra_ImportgetGhostedImport (int i) const
 get importer for converting an overalapped object to a "normal" object More...
 
virtual const Teuchos::RCP< Epetra_ImportgetGhostedColImport (int i) const
 get importer for converting an overalapped object to a "normal" object More...
 
virtual const Teuchos::RCP< Epetra_ExportgetGhostedExport (int j) const
 get exporter for converting an overalapped object to a "normal" object More...
 
virtual const Teuchos::RCP< Epetra_ExportgetGhostedColExport (int j) const
 get exporter for converting an overalapped object to a "normal" object More...
 
virtual const Teuchos::RCP< const Epetra_CommgetEpetraComm () const
 get exporter for converting an overalapped object to a "normal" object More...
 
Teuchos::RCP< Epetra_CrsMatrixgetEpetraMatrix (int i, int j) const
 
Teuchos::RCP< Epetra_CrsMatrixgetGhostedEpetraMatrix (int i, int j) const
 
int getBlockRowCount () const
 how many block rows More...
 
int getBlockColCount () const
 how many block columns More...
 
Teuchos::RCP< const panzer::BlockedDOFManager< int, int > > getGlobalIndexer () const
 
Teuchos::RCP< const panzer::UniqueGlobalIndexerBasegetRangeGlobalIndexer () const
 Get the range global indexer object associated with this factory. More...
 
Teuchos::RCP< const panzer::UniqueGlobalIndexerBasegetDomainGlobalIndexer () const
 Get the domain global indexer object associated with this factory. More...
 
const std::vector< Teuchos::RCP< const UniqueGlobalIndexer< LocalOrdinalT, int > > > & getRangeGlobalIndexers () const
 Get global indexers associated with the blocks. More...
 
const std::vector< Teuchos::RCP< const UniqueGlobalIndexer< LocalOrdinalT, int > > > & getDomainGlobalIndexers () const
 Get global indexers associated with the blocks. More...
 
void addExcludedPair (int rowBlock, int colBlock)
 exclude a block pair from the matrix More...
 
void addExcludedPairs (const std::vector< std::pair< int, int > > &exPairs)
 exclude a vector of pairs from the matrix More...
 
- 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. More...
 
template<typename EvalT >
Teuchos::RCP< PHX::Evaluator< Traits > > buildGather (const Teuchos::ParameterList &pl) const
 Use preconstructed gather evaluators. More...
 
template<typename EvalT >
Teuchos::RCP< PHX::Evaluator< Traits > > buildGatherTangent (const Teuchos::ParameterList &pl) const
 Use preconstructed gather evaluators. More...
 
template<typename EvalT >
Teuchos::RCP< PHX::Evaluator< Traits > > buildGatherDomain (const Teuchos::ParameterList &pl) const
 Use preconstructed gather evaluators. More...
 
template<typename EvalT >
Teuchos::RCP< PHX::Evaluator< Traits > > buildGatherOrientation (const Teuchos::ParameterList &pl) const
 Use preconstructed gather evaluators. More...
 
template<typename EvalT >
Teuchos::RCP< PHX::Evaluator< Traits > > buildScatterDirichlet (const Teuchos::ParameterList &pl) const
 Use preconstructed dirichlet scatter evaluators. More...
 
PANZER_DEPRECATED Teuchos::RCP< const panzer::UniqueGlobalIndexerBasegetUniqueGlobalIndexerBase () const
 Get the range global indexer object associated with this factory. More...
 
virtual void beginFill (LinearObjContainer &loc) const
 
virtual void endFill (LinearObjContainer &loc) 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 UniqueGlobalIndexer< LocalOrdinalT, int > > getGlobalIndexer (int i) const
 
Teuchos::RCP< const UniqueGlobalIndexer< LocalOrdinalT, int > > 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. More...
 
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_MapbuildMap (int i) const
 
virtual const Teuchos::RCP< Epetra_MapbuildGhostedMap (int i) const
 
virtual const Teuchos::RCP< Epetra_MapbuildColMap (int i) const
 
virtual const Teuchos::RCP< Epetra_MapbuildColGhostedMap (int i) const
 
virtual const Teuchos::RCP< Epetra_CrsGraphbuildGraph (int i, int j) const
 
virtual const Teuchos::RCP< Epetra_CrsGraphbuildGhostedGraph (int i, int j, bool optimizeStorage) const
 
virtual const Teuchos::RCP< Epetra_CrsGraphbuildFilteredGhostedGraph (int i, int j) const
 

Protected Attributes

Teuchos::RCP< const DOFManagerContainerrowDOFManagerContainer_
 
Teuchos::RCP< const DOFManagerContainercolDOFManagerContainer_
 
bool useColGidProviders_
 
std::unordered_set< std::pair< int, int >, panzer::pair_hashexcludedPairs_
 
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_CommeComm_
 
Teuchos::RCP< const Teuchos::OpaqueWrapper< MPI_Comm > > rawMpiComm_
 
Teuchos::RCP< Teuchos::MpiComm< int > > tComm_
 
std::vector< Teuchos::RCP< Epetra_Map > > maps_
 
std::vector< Teuchos::RCP< Epetra_Map > > ghostedMaps_
 
std::vector< Teuchos::RCP< Epetra_Import > > importers_
 
std::vector< Teuchos::RCP< Epetra_Export > > exporters_
 
std::vector< Teuchos::RCP< Epetra_Map > > colMaps_
 
std::vector< Teuchos::RCP< Epetra_Map > > colGhostedMaps_
 
std::vector< Teuchos::RCP< Epetra_Import > > colImporters_
 
std::vector< Teuchos::RCP< Epetra_Export > > colExporters_
 
std::unordered_map< std::pair< int, int >, Teuchos::RCP< Epetra_CrsGraph >, panzer::pair_hashgraphs_
 
std::unordered_map< std::pair< int, int >, Teuchos::RCP< Epetra_CrsGraph >, panzer::pair_hashghostedGraphs_
 
bool useDiscreteAdjoint_
 

Detailed Description

template<typename Traits, typename LocalOrdinalT>
class panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >

Definition at line 85 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

Constructor & Destructor Documentation

◆ BlockedEpetraLinearObjFactory() [1/2]

template<typename Traits , typename LocalOrdinalT >
panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::BlockedEpetraLinearObjFactory ( const Teuchos::RCP< const Teuchos::MpiComm< int > > &  comm,
const Teuchos::RCP< const UniqueGlobalIndexerBase > &  gidProvider,
bool  useDiscreteAdjoint = false 
)

◆ BlockedEpetraLinearObjFactory() [2/2]

template<typename Traits , typename LocalOrdinalT >
panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::BlockedEpetraLinearObjFactory ( const Teuchos::RCP< const Teuchos::MpiComm< int > > &  comm,
const Teuchos::RCP< const UniqueGlobalIndexerBase > &  gidProvider,
const Teuchos::RCP< const UniqueGlobalIndexerBase > &  colGidProvider,
bool  useDiscreteAdjoint = false 
)

◆ ~BlockedEpetraLinearObjFactory()

template<typename Traits , typename LocalOrdinalT >
panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::~BlockedEpetraLinearObjFactory ( )
virtual

Member Function Documentation

◆ readVector()

template<typename Traits , typename LocalOrdinalT >
void panzer::EpetraLinearObjFactory::readVector ( const std::string &  identifier,
LinearObjContainer loc,
int  id 
) const
virtual

Read in a vector from a file. Fill a particular vector in the linear object container.

Parameters
[in]identifierKey for specifying which file(s) to read
[in]locLinear object container to fill with the vector
[in]idId for the field to be filled

Implements panzer::LinearObjFactory< Traits >.

Definition at line 137 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ writeVector()

template<typename Traits , typename LocalOrdinalT >
void panzer::EpetraLinearObjFactory::writeVector ( const std::string &  identifier,
const LinearObjContainer loc,
int  id 
) const
virtual

Write in a vector from a file. Fill a particular vector in the linear object container.

Parameters
[in]identifierKey for specifying which file(s) to read
[in]locLinear object container to fill with the vector
[in]idId for the field to be filled

Implements panzer::LinearObjFactory< Traits >.

Definition at line 187 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildLinearObjContainer()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< LinearObjContainer > panzer::EpetraLinearObjFactory::buildLinearObjContainer ( ) const
virtual

Build a container with all the neccessary linear algebra objects. This is the non-ghosted version.

Implements panzer::LinearObjFactory< Traits >.

Definition at line 231 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildPrimitiveLinearObjContainer()

template<typename Traits, typename LocalOrdinalT>
virtual Teuchos::RCP<LinearObjContainer> panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildPrimitiveLinearObjContainer ( ) const
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 108 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ buildGhostedLinearObjContainer()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< LinearObjContainer > panzer::EpetraLinearObjFactory::buildGhostedLinearObjContainer ( ) const
virtual

Build a container with all the neccessary linear algebra objects. This is the ghosted version.

Implements panzer::LinearObjFactory< Traits >.

Definition at line 252 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildPrimitiveGhostedLinearObjContainer()

template<typename Traits, typename LocalOrdinalT>
virtual Teuchos::RCP<LinearObjContainer> panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildPrimitiveGhostedLinearObjContainer ( ) const
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 113 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ globalToGhostContainer()

template<typename Traits , typename LocalOrdinalT >
void panzer::EpetraLinearObjFactory::globalToGhostContainer ( const LinearObjContainer container,
LinearObjContainer ghostContainer,
int  mem 
) const
virtual

◆ ghostToGlobalContainer()

template<typename Traits , typename LocalOrdinalT >
void panzer::EpetraLinearObjFactory::ghostToGlobalContainer ( const LinearObjContainer ghostContainer,
LinearObjContainer container,
int  mem 
) const
virtual

◆ adjustForDirichletConditions() [1/2]

template<typename Traits , typename LocalOrdinalT >
void panzer::EpetraLinearObjFactory::adjustForDirichletConditions ( const LinearObjContainer localBCRows,
const LinearObjContainer globalBCRows,
LinearObjContainer ghostedObjs,
bool  zeroVectorRows = false,
bool  adjustX = false 
) const
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 358 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ applyDirichletBCs()

template<typename Traits , typename LocalOrdinalT >
void panzer::EpetraLinearObjFactory::applyDirichletBCs ( const LinearObjContainer counter,
LinearObjContainer result 
) const
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 495 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildDomainContainer()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< ReadOnlyVector_GlobalEvaluationData > panzer::EpetraLinearObjFactory::buildDomainContainer ( ) const
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 534 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getComm()

template<typename Traits , typename LocalOrdinalT >
Teuchos::MpiComm< int > panzer::EpetraLinearObjFactory::getComm ( ) const
virtual

Acess to the MPI Comm used in constructing this LOF.

Implements panzer::LinearObjFactory< Traits >.

Definition at line 564 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildScatter()

template<typename Traits, typename LocalOrdinalT>
template<typename EvalT >
Teuchos::RCP<panzer::CloneableEvaluator> panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildScatter ( ) const
inline

Use preconstructed scatter evaluators.

Definition at line 148 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ buildGather()

template<typename Traits, typename LocalOrdinalT>
template<typename EvalT >
Teuchos::RCP<panzer::CloneableEvaluator > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildGather ( ) const
inline

Use preconstructed gather evaluators.

Definition at line 163 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ buildGatherTangent()

template<typename Traits, typename LocalOrdinalT>
template<typename EvalT >
Teuchos::RCP<panzer::CloneableEvaluator > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildGatherTangent ( ) const
inline

Use preconstructed gather evaluators.

Definition at line 173 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ buildGatherDomain()

template<typename Traits, typename LocalOrdinalT>
template<typename EvalT >
Teuchos::RCP<panzer::CloneableEvaluator > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildGatherDomain ( ) const
inline

Use preconstructed gather evaluators.

Definition at line 183 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ buildGatherOrientation()

template<typename Traits, typename LocalOrdinalT>
template<typename EvalT >
Teuchos::RCP<panzer::CloneableEvaluator > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildGatherOrientation ( ) const
inline

Use preconstructed gather evaluators.

Definition at line 192 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ buildScatterDirichlet()

template<typename Traits, typename LocalOrdinalT>
template<typename EvalT >
Teuchos::RCP<panzer::CloneableEvaluator> panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildScatterDirichlet ( ) const
inline

Use preconstructed dirichlet scatter evaluators.

Definition at line 197 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ initializeContainer()

template<typename Traits , typename LocalOrdinalT >
void panzer::EpetraLinearObjFactory::initializeContainer ( int  mem,
LinearObjContainer loc 
) const
virtual

Initialize container with a specific set of member values.

Note
This will overwrite everything in the container and zero out values not requested.

Implements panzer::LinearObjFactory< Traits >.

Definition at line 571 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ initializeGhostedContainer()

template<typename Traits , typename LocalOrdinalT >
void panzer::EpetraLinearObjFactory::initializeGhostedContainer ( int  mem,
LinearObjContainer loc 
) const
virtual

Initialize container with a specific set of member values.

Note
This will overwrite everything in the container and zero out values not requested.

Implements panzer::LinearObjFactory< Traits >.

Definition at line 581 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getThyraDomainSpace()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > panzer::EpetraLinearObjFactory::getThyraDomainSpace ( ) const
virtual

Get the domain vector space (x and dxdt)

Implements panzer::ThyraObjFactory< double >.

Definition at line 707 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getThyraRangeSpace()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > panzer::EpetraLinearObjFactory::getThyraRangeSpace ( ) const
virtual

Get the range vector space (f)

Implements panzer::ThyraObjFactory< double >.

Definition at line 730 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getThyraDomainVector()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< Thyra::VectorBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getThyraDomainVector ( ) const

Get a domain vector.

Definition at line 753 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getThyraRangeVector()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< Thyra::VectorBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getThyraRangeVector ( ) const

Get a range vector.

Definition at line 764 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getThyraMatrix()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< Thyra::LinearOpBase< double > > panzer::EpetraLinearObjFactory::getThyraMatrix ( ) const
virtual

Get a Thyra operator.

Implements panzer::ThyraObjFactory< double >.

Definition at line 775 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedThyraDomainSpace()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraDomainSpace ( ) const

Get the domain vector space (x and dxdt)

Definition at line 811 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedThyraRangeSpace()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraRangeSpace ( ) const

Get the range vector space (f)

Definition at line 834 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedThyraDomainVector()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< Thyra::VectorBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraDomainVector ( ) const

Get a domain vector.

Definition at line 857 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedThyraRangeVector()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< Thyra::VectorBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraRangeVector ( ) const

Get a range vector.

Definition at line 868 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedThyraMatrix()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< Thyra::LinearOpBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraMatrix ( ) const

Get a Thyra operator.

Definition at line 879 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getMap()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_Map > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getMap ( int  i) const
virtual

get the map from the matrix

Definition at line 1079 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getColMap()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_Map > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getColMap ( int  i) const
virtual

get the map from the matrix

Definition at line 1090 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedMap()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_Map > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedMap ( int  i) const
virtual

get the ghosted map from the matrix

Definition at line 1103 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedColMap()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_Map > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedColMap ( int  i) const
virtual

get the ghosted map from the matrix

Definition at line 1113 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGraph()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_CrsGraph > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGraph ( int  i,
int  j 
) const
virtual

get the graph of the crs matrix

Definition at line 1127 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedGraph()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_CrsGraph > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedGraph ( int  i,
int  j 
) const
virtual

get the ghosted graph of the crs matrix

Definition at line 1146 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedImport()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_Import > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedImport ( int  i) const
virtual

get importer for converting an overalapped object to a "normal" object

Definition at line 1165 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedColImport()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_Import > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedColImport ( int  i) const
virtual

get importer for converting an overalapped object to a "normal" object

Definition at line 1175 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedExport()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_Export > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedExport ( int  j) const
virtual

get exporter for converting an overalapped object to a "normal" object

Definition at line 1188 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedColExport()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_Export > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedColExport ( int  j) const
virtual

get exporter for converting an overalapped object to a "normal" object

Definition at line 1198 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getEpetraComm()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< const Epetra_Comm > panzer::EpetraLinearObjFactory::getEpetraComm ( ) const
virtual

get exporter for converting an overalapped object to a "normal" object

Definition at line 1432 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getEpetraMatrix()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< Epetra_CrsMatrix > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getEpetraMatrix ( int  i,
int  j 
) const

◆ getGhostedEpetraMatrix()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< Epetra_CrsMatrix > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedEpetraMatrix ( int  i,
int  j 
) const

◆ getBlockRowCount()

template<typename Traits , typename LocalOrdinalT >
int panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getBlockRowCount ( ) const

how many block rows

Definition at line 1439 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getBlockColCount()

template<typename Traits , typename LocalOrdinalT >
int panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getBlockColCount ( ) const

how many block columns

Definition at line 1446 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGlobalIndexer() [1/2]

template<typename Traits, typename LocalOrdinalT>
Teuchos::RCP<const panzer::BlockedDOFManager<int,int> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGlobalIndexer ( ) const
inline

Definition at line 301 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ getRangeGlobalIndexer()

template<typename Traits, typename LocalOrdinalT>
Teuchos::RCP<const panzer::UniqueGlobalIndexerBase> panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getRangeGlobalIndexer ( ) const
inlinevirtual

Get the range global indexer object associated with this factory.

Implements panzer::LinearObjFactory< Traits >.

Definition at line 304 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ getDomainGlobalIndexer()

template<typename Traits, typename LocalOrdinalT>
Teuchos::RCP<const panzer::UniqueGlobalIndexerBase> panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getDomainGlobalIndexer ( ) const
inlinevirtual

Get the domain global indexer object associated with this factory.

Implements panzer::LinearObjFactory< Traits >.

Definition at line 307 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ getRangeGlobalIndexers()

template<typename Traits, typename LocalOrdinalT>
const std::vector<Teuchos::RCP<const UniqueGlobalIndexer<LocalOrdinalT,int> > >& panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getRangeGlobalIndexers ( ) const
inline

Get global indexers associated with the blocks.

Definition at line 311 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ getDomainGlobalIndexers()

template<typename Traits, typename LocalOrdinalT>
const std::vector<Teuchos::RCP<const UniqueGlobalIndexer<LocalOrdinalT,int> > >& panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getDomainGlobalIndexers ( ) const
inline

Get global indexers associated with the blocks.

Definition at line 315 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ addExcludedPair()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::addExcludedPair ( int  rowBlock,
int  colBlock 
)

exclude a block pair from the matrix

Definition at line 658 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ addExcludedPairs()

template<typename Traits , typename LocalOrdinalT >
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 665 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ initializeContainer_internal()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::initializeContainer_internal ( int  mem,
ThyraObjContainer< double > &  loc 
) const
protected

Initialize container with a specific set of member values.

Note
This will overwrite everything in the container and zero out values not requested.

Definition at line 616 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ initializeGhostedContainer_internal()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::initializeGhostedContainer_internal ( int  mem,
ThyraObjContainer< double > &  loc 
) const
protected

Initialize container with a specific set of member values.

Note
This will overwrite everything in the container and zero out values not requested.

Definition at line 637 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGlobalIndexer() [2/2]

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< const UniqueGlobalIndexer< LocalOrdinalT, int > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGlobalIndexer ( int  i) const
protected

◆ getColGlobalIndexer()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< const UniqueGlobalIndexer< LocalOrdinalT, int > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getColGlobalIndexer ( int  i) const
protected

◆ makeRoomForBlocks()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::makeRoomForBlocks ( std::size_t  blockCnt,
std::size_t  colBlockCnt = 0 
)
protected

Allocate the space in the std::vector objects so we can fill with appropriate Epetra data.

Definition at line 687 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ ghostToGlobalThyraVector()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::ghostToGlobalThyraVector ( const Teuchos::RCP< const Thyra::VectorBase< double > > &  in,
const Teuchos::RCP< Thyra::VectorBase< double > > &  out,
bool  col 
) const
protected

◆ ghostToGlobalThyraMatrix()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::ghostToGlobalThyraMatrix ( const Thyra::LinearOpBase< double > &  in,
Thyra::LinearOpBase< double > &  out 
) const
protected

◆ globalToGhostThyraVector()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::globalToGhostThyraVector ( const Teuchos::RCP< const Thyra::VectorBase< double > > &  in,
const Teuchos::RCP< Thyra::VectorBase< double > > &  out,
bool  col 
) const
protected

◆ adjustForDirichletConditions() [2/2]

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::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
protected

◆ ghostToGlobalEpetraVector()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::ghostToGlobalEpetraVector ( int  i,
const Epetra_Vector in,
Epetra_Vector out,
bool  col 
) const
protected

◆ globalToGhostEpetraVector()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::globalToGhostEpetraVector ( int  i,
const Epetra_Vector in,
Epetra_Vector out,
bool  col 
) const
protected

◆ ghostToGlobalEpetraMatrix()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::ghostToGlobalEpetraMatrix ( int  blockRow,
const Epetra_CrsMatrix in,
Epetra_CrsMatrix out 
) const
protected

◆ buildMap()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_Map > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildMap ( int  i) const
protectedvirtual

◆ buildGhostedMap()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_Map > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildGhostedMap ( int  i) const
protectedvirtual

◆ buildColMap()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_Map > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildColMap ( int  i) const
protectedvirtual

◆ buildColGhostedMap()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_Map > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildColGhostedMap ( int  i) const
protectedvirtual

◆ buildGraph()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_CrsGraph > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildGraph ( int  i,
int  j 
) const
protectedvirtual

◆ buildGhostedGraph()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_CrsGraph > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildGhostedGraph ( int  i,
int  j,
bool  optimizeStorage 
) const
protectedvirtual

◆ buildFilteredGhostedGraph()

template<typename Traits , typename LocalOrdinalT >
const Teuchos::RCP< Epetra_CrsGraph > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildFilteredGhostedGraph ( int  i,
int  j 
) const
protectedvirtual

Member Data Documentation

◆ rowDOFManagerContainer_

template<typename Traits, typename LocalOrdinalT>
Teuchos::RCP<const DOFManagerContainer> panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::rowDOFManagerContainer_
protected

Definition at line 427 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ colDOFManagerContainer_

template<typename Traits, typename LocalOrdinalT>
Teuchos::RCP<const DOFManagerContainer> panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::colDOFManagerContainer_
protected

Definition at line 428 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ useColGidProviders_

template<typename Traits, typename LocalOrdinalT>
bool panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::useColGidProviders_
protected

Definition at line 430 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ excludedPairs_

template<typename Traits, typename LocalOrdinalT>
std::unordered_set<std::pair<int,int>,panzer::pair_hash> panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::excludedPairs_
protected

Definition at line 433 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ rangeSpace_

template<typename Traits, typename LocalOrdinalT>
Teuchos::RCP<const Thyra::VectorSpaceBase<double> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::rangeSpace_
mutableprotected

Definition at line 443 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ domainSpace_

template<typename Traits, typename LocalOrdinalT>
Teuchos::RCP<const Thyra::VectorSpaceBase<double> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::domainSpace_
mutableprotected

Definition at line 444 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ ghostedRangeSpace_

template<typename Traits, typename LocalOrdinalT>
Teuchos::RCP<const Thyra::VectorSpaceBase<double> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::ghostedRangeSpace_
mutableprotected

Definition at line 446 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ ghostedDomainSpace_

template<typename Traits, typename LocalOrdinalT>
Teuchos::RCP<const Thyra::VectorSpaceBase<double> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::ghostedDomainSpace_
mutableprotected

Definition at line 447 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ eComm_

template<typename Traits, typename LocalOrdinalT>
Teuchos::RCP<const Epetra_Comm> panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::eComm_
protected

Definition at line 475 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ rawMpiComm_

template<typename Traits, typename LocalOrdinalT>
Teuchos::RCP<const Teuchos::OpaqueWrapper<MPI_Comm> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::rawMpiComm_
protected

Definition at line 476 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ tComm_

template<typename Traits, typename LocalOrdinalT>
Teuchos::RCP<Teuchos::MpiComm<int> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::tComm_
protected

Definition at line 477 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ maps_

template<typename Traits, typename LocalOrdinalT>
std::vector<Teuchos::RCP<Epetra_Map> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::maps_
mutableprotected

Definition at line 479 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ ghostedMaps_

template<typename Traits, typename LocalOrdinalT>
std::vector<Teuchos::RCP<Epetra_Map> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::ghostedMaps_
mutableprotected

Definition at line 480 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ importers_

template<typename Traits, typename LocalOrdinalT>
std::vector<Teuchos::RCP<Epetra_Import> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::importers_
mutableprotected

Definition at line 481 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ exporters_

template<typename Traits, typename LocalOrdinalT>
std::vector<Teuchos::RCP<Epetra_Export> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::exporters_
mutableprotected

Definition at line 482 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ colMaps_

template<typename Traits, typename LocalOrdinalT>
std::vector<Teuchos::RCP<Epetra_Map> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::colMaps_
mutableprotected

Definition at line 484 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ colGhostedMaps_

template<typename Traits, typename LocalOrdinalT>
std::vector<Teuchos::RCP<Epetra_Map> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::colGhostedMaps_
mutableprotected

Definition at line 485 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ colImporters_

template<typename Traits, typename LocalOrdinalT>
std::vector<Teuchos::RCP<Epetra_Import> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::colImporters_
mutableprotected

Definition at line 486 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ colExporters_

template<typename Traits, typename LocalOrdinalT>
std::vector<Teuchos::RCP<Epetra_Export> > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::colExporters_
mutableprotected

Definition at line 487 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ graphs_

template<typename Traits, typename LocalOrdinalT>
std::unordered_map<std::pair<int,int>,Teuchos::RCP<Epetra_CrsGraph>,panzer::pair_hash> panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::graphs_
mutableprotected

Definition at line 489 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ ghostedGraphs_

template<typename Traits, typename LocalOrdinalT>
std::unordered_map<std::pair<int,int>,Teuchos::RCP<Epetra_CrsGraph>,panzer::pair_hash> panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::ghostedGraphs_
mutableprotected

Definition at line 490 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ useDiscreteAdjoint_

template<typename Traits, typename LocalOrdinalT>
bool panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::useDiscreteAdjoint_
protected

Definition at line 492 of file Panzer_BlockedEpetraLinearObjFactory.hpp.


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