Panzer Version of the Day
Loading...
Searching...
No Matches
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 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< 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_GlobalEvaluationDatabuildReadOnlyDomainContainer () const
 
virtual Teuchos::RCP< WriteVector_GlobalEvaluationDatabuildWriteDomainContainer () const
 
virtual Teuchos::MpiComm< int > getComm () const
 
template<typename EvalT >
Teuchos::RCP< panzer::CloneableEvaluatorbuildScatter () const
 Use preconstructed scatter evaluators.
 
template<typename EvalT >
Teuchos::RCP< panzer::CloneableEvaluatorbuildGather () const
 Use preconstructed gather evaluators.
 
template<typename EvalT >
Teuchos::RCP< panzer::CloneableEvaluatorbuildGatherTangent () const
 Use preconstructed gather evaluators.
 
template<typename EvalT >
Teuchos::RCP< panzer::CloneableEvaluatorbuildGatherDomain () const
 Use preconstructed gather evaluators.
 
template<typename EvalT >
Teuchos::RCP< panzer::CloneableEvaluatorbuildGatherOrientation () const
 Use preconstructed gather evaluators.
 
template<typename EvalT >
Teuchos::RCP< panzer::CloneableEvaluatorbuildScatterDirichlet () 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_MapgetMap (int i) const
 get the map from the matrix
 
virtual const Teuchos::RCP< Epetra_MapgetColMap (int i) const
 get the map from the matrix
 
virtual const Teuchos::RCP< Epetra_MapgetGhostedMap (int i) const
 get the ghosted map from the matrix
 
virtual const Teuchos::RCP< Epetra_MapgetGhostedMap2 (int i) const
 Get or create the i-th ghosted map.
 
virtual const Teuchos::RCP< Epetra_MapgetGhostedColMap (int i) const
 get the ghosted map from the matrix
 
virtual const Teuchos::RCP< Epetra_MapgetGhostedColMap2 (int i) const
 Get or create the i-th ghosted column map.
 
virtual const Teuchos::RCP< Epetra_CrsGraphgetGraph (int i, int j) const
 get the graph of the crs matrix
 
virtual const Teuchos::RCP< Epetra_CrsGraphgetGhostedGraph (int i, int j) const
 get the ghosted graph of the crs matrix
 
virtual const Teuchos::RCP< Epetra_ImportgetGhostedImport (int i) const
 get importer for converting an overalapped object to a "normal" object
 
virtual const Teuchos::RCP< Epetra_ImportgetGhostedImport2 (int i) const
 Get or create the i-th ghosted importer corresponding to the i-th ghosted map.
 
virtual const Teuchos::RCP< Epetra_ImportgetGhostedColImport (int i) const
 get importer for converting an overalapped object to a "normal" object
 
virtual const Teuchos::RCP< Epetra_ImportgetGhostedColImport2 (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_ExportgetGhostedExport (int j) const
 get exporter for converting an overalapped object to a "normal" object
 
virtual const Teuchos::RCP< Epetra_ExportgetGhostedExport2 (int i) const
 Get or create the i-th ghosted exporter corresponding to the i-th ghosted map.
 
virtual const Teuchos::RCP< Epetra_ExportgetGhostedColExport (int j) const
 get exporter for converting an overalapped object to a "normal" object
 
virtual const Teuchos::RCP< Epetra_ExportgetGhostedColExport2 (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_CommgetEpetraComm () const
 get exporter for converting an overalapped object to a "normal" object
 
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
 
int getBlockColCount () const
 how many block columns
 
Teuchos::RCP< const panzer::BlockedDOFManagergetGlobalIndexer () const
 
Teuchos::RCP< const panzer::GlobalIndexergetRangeGlobalIndexer () const
 Get the range global indexer object associated with this factory.
 
Teuchos::RCP< const panzer::GlobalIndexergetDomainGlobalIndexer () 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 GlobalIndexergetGlobalIndexer (int i) const
 
Teuchos::RCP< const GlobalIndexergetColGlobalIndexer (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_MapbuildMap (int i) const
 Build the i-th owned map from the owned indices of the i-th global indexer.
 
virtual const Teuchos::RCP< Epetra_MapbuildGhostedMap (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_MapbuildGhostedMap2 (int i) const
 Build the i-th ghosted map from the ghosted indices of the i-th global indexer.
 
virtual const Teuchos::RCP< Epetra_MapbuildColMap (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_MapbuildColGhostedMap (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_MapbuildColGhostedMap2 (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_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_
 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_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 86 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 GlobalIndexer > & 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 GlobalIndexer > & gidProvider,
const Teuchos::RCP< const GlobalIndexer > & 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::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::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 142 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ writeVector()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::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 192 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildLinearObjContainer()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< LinearObjContainer > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::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 237 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 109 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ buildGhostedLinearObjContainer()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< LinearObjContainer > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::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 258 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 114 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ globalToGhostContainer()

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

◆ ghostToGlobalContainer()

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

◆ adjustForDirichletConditions() [1/2]

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::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 363 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ applyDirichletBCs()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::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 500 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildReadOnlyDomainContainer()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< ReadOnlyVector_GlobalEvaluationData > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildReadOnlyDomainContainer ( ) 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 544 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildWriteDomainContainer()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< WriteVector_GlobalEvaluationData > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::buildWriteDomainContainer ( ) 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.

Definition at line 586 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getComm()

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

Acess to the MPI Comm used in constructing this LOF.

Implements panzer::LinearObjFactory< Traits >.

Definition at line 622 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 155 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 170 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 180 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 190 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 199 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 204 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ initializeContainer()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::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 629 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ initializeGhostedContainer()

template<typename Traits , typename LocalOrdinalT >
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::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 639 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getThyraDomainSpace()

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

Get the domain vector space (x and dxdt)

Implements panzer::ThyraObjFactory< double >.

Definition at line 777 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getThyraRangeSpace()

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

Get the range vector space (f)

Implements panzer::ThyraObjFactory< double >.

Definition at line 800 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 823 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 834 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getThyraMatrix()

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

Get a Thyra operator.

Implements panzer::ThyraObjFactory< double >.

Definition at line 845 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 887 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedThyraDomainSpace2()

template<typename Traits , typename LocalOrdinalT >
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).

Note
This "version 2" routine works with non-overlapping owned and ghosted maps.
Returns
The vector space corresponding to the ghosted domain.

Definition at line 922 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 951 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 974 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 985 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 996 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 1196 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 1207 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 1226 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedMap2()

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

Get or create the i-th ghosted map.

Note
This "version 2" routine works with non-overlapping owned and ghosted maps.
Parameters
[in]iThe index into the list of ghosted maps.
Returns
The i-th ghosted map.

Definition at line 1242 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 1258 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedColMap2()

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

Get or create the i-th ghosted column map.

Note
This "version 2" routine works with non-overlapping owned and ghosted maps.
Parameters
[in]iThe index into the list of ghosted column maps.
Returns
The i-th ghosted column map.

Definition at line 1276 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 1289 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 1308 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 1333 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedImport2()

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

Get or create the i-th ghosted importer corresponding to the i-th ghosted map.

Note
This "version 2" routine works with non-overlapping owned and ghosted maps.
Parameters
[in]iThe index into the list of ghosted importers.
Returns
The i-th ghosted importer.

Definition at line 1350 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 1367 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedColImport2()

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

Get or create the i-th ghosted column importer corresponding to the i-th ghosted column map.

Note
This "version 2" routine works with non-overlapping owned and ghosted maps.
Parameters
[in]iThe index into the list of ghosted column importers.
Returns
The i-th ghosted column importer.

Definition at line 1387 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 1407 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedExport2()

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

Get or create the i-th ghosted exporter corresponding to the i-th ghosted map.

Note
This "version 2" routine works with non-overlapping owned and ghosted maps.
Parameters
[in]iThe index into the list of ghosted exporters.
Returns
The i-th ghosted exporter.

Definition at line 1424 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 1441 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGhostedColExport2()

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

Get or create the i-th ghosted column exporter corresponding to the i-th ghosted column map.

Note
This "version 2" routine works with non-overlapping owned and ghosted maps.
Parameters
[in]iThe index into the list of ghosted column exporters.
Returns
The i-th ghosted column exporter.

Definition at line 1461 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getEpetraComm()

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

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

Definition at line 1742 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 1749 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 1756 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGlobalIndexer() [1/2]

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

Definition at line 410 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ getRangeGlobalIndexer()

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

Get the range global indexer object associated with this factory.

Implements panzer::LinearObjFactory< Traits >.

Definition at line 413 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ getDomainGlobalIndexer()

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

Get the domain global indexer object associated with this factory.

Implements panzer::LinearObjFactory< Traits >.

Definition at line 416 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ getRangeGlobalIndexers()

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

Get global indexers associated with the blocks.

Definition at line 420 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ getDomainGlobalIndexers()

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

Get global indexers associated with the blocks.

Definition at line 424 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 716 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 723 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 674 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 695 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ getGlobalIndexer() [2/2]

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

◆ getColGlobalIndexer()

template<typename Traits , typename LocalOrdinalT >
Teuchos::RCP< const GlobalIndexer > 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 751 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

Build the i-th owned map from the owned indices of the i-th global indexer.

Parameters
[in]iThe index into the list of global indexers.
Returns
The i-th owned map.

Definition at line 1475 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildGhostedMap()

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

Build the i-th ghosted map from the owned and ghosted indices of the i-th global indexer.

Parameters
[in]iThe index into the list of global indexers.
Returns
The i-th owned and ghosted map.

Definition at line 1508 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildGhostedMap2()

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

Build the i-th ghosted map from the ghosted indices of the i-th global indexer.

Parameters
[in]iThe index into the list of global indexers.
Returns
The i-th ghosted map.

Definition at line 1526 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildColMap()

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

Build the i-th owned column map from the owned indices of the i-th (column) global indexer.

Parameters
[in]iThe index into the list of (column) global indexers.
Returns
The i-th owned column map.

Definition at line 1487 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildColGhostedMap()

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

Build the i-th ghosted column map from the owned and ghosted indices of the i-th (column) global indexer.

Parameters
[in]iThe index into the list of (column) global indexers.
Returns
The i-th owned and ghosted column map.

Definition at line 1544 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ buildColGhostedMap2()

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

Build the i-th ghosted column map from the ghosted indices of the i-th (column) global indexer.

Parameters
[in]iThe index into the list of (column) global indexers.
Returns
The i-th ghosted column map.

Definition at line 1564 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.

◆ 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 536 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ colDOFManagerContainer_

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

Definition at line 537 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ useColGidProviders_

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

Definition at line 539 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 542 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 552 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 553 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 555 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 556 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 652 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 653 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 654 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ maps_

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

The list of owned maps corresponding to the owned indices of the global indexers.

Definition at line 660 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ ghostedMaps_

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

The list of ghosted maps corresponding to the owned and ghosted indices of the global indexers.

Definition at line 666 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ ghostedMaps2_

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

The list of ghosted maps corresponding to the ghosted indices of the global indexers.

Definition at line 672 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ importers_

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

The list of ghosted importers corresponding to ghostedMaps_.

Definition at line 677 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ importers2_

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

The list of ghosted importers corresponding to ghostedMaps2_.

Definition at line 682 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 684 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ colMaps_

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

The list of owned column maps corresponding to the owned indices of the (column) global indexers.

Definition at line 690 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ colGhostedMaps_

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

The list of ghosted column maps corresponding to the owned and ghosted indices of the (column) global indexers.

Definition at line 696 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ colGhostedMaps2_

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

The list of ghosted column maps corresponding to the ghosted indices of the (column) global indexers.

Definition at line 702 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ colImporters_

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

The list of ghosted importers corresponding to colGhostedMaps_.

Definition at line 707 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ colImporters2_

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

The list of ghosted importers corresponding to colGhostedMaps2_.

Definition at line 713 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 715 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 717 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 718 of file Panzer_BlockedEpetraLinearObjFactory.hpp.

◆ useDiscreteAdjoint_

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

Definition at line 720 of file Panzer_BlockedEpetraLinearObjFactory.hpp.


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