Panzer
Version of the Day
|
#include <Panzer_BlockedEpetraLinearObjFactory.hpp>
Classes | |
class | DOFManagerContainer |
Public Member Functions | |
BlockedEpetraLinearObjFactory (const Teuchos::RCP< const Teuchos::MpiComm< int > > &comm, const Teuchos::RCP< const 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< LinearObjContainer > | buildLinearObjContainer () const |
virtual Teuchos::RCP< LinearObjContainer > | buildPrimitiveLinearObjContainer () const |
virtual Teuchos::RCP< LinearObjContainer > | buildGhostedLinearObjContainer () const |
virtual Teuchos::RCP< LinearObjContainer > | buildPrimitiveGhostedLinearObjContainer () const |
virtual void | globalToGhostContainer (const LinearObjContainer &container, LinearObjContainer &ghostContainer, int) const |
virtual void | ghostToGlobalContainer (const LinearObjContainer &ghostContainer, LinearObjContainer &container, int) const |
virtual void | adjustForDirichletConditions (const LinearObjContainer &localBCRows, const LinearObjContainer &globalBCRows, LinearObjContainer &ghostedObjs, bool zeroVectorRows=false, bool adjustX=false) const |
virtual void | applyDirichletBCs (const LinearObjContainer &counter, LinearObjContainer &result) const |
virtual Teuchos::RCP< ReadOnlyVector_GlobalEvaluationData > | buildDomainContainer () const |
virtual Teuchos::MpiComm< int > | getComm () const |
template<typename EvalT > | |
Teuchos::RCP< panzer::CloneableEvaluator > | buildScatter () const |
Use preconstructed scatter evaluators. More... | |
template<typename EvalT > | |
Teuchos::RCP< panzer::CloneableEvaluator > | buildGather () const |
Use preconstructed gather evaluators. More... | |
template<typename EvalT > | |
Teuchos::RCP< panzer::CloneableEvaluator > | buildGatherTangent () const |
Use preconstructed gather evaluators. More... | |
template<typename EvalT > | |
Teuchos::RCP< panzer::CloneableEvaluator > | buildGatherDomain () const |
Use preconstructed gather evaluators. More... | |
template<typename EvalT > | |
Teuchos::RCP< panzer::CloneableEvaluator > | buildGatherOrientation () const |
Use preconstructed gather evaluators. More... | |
template<typename EvalT > | |
Teuchos::RCP< panzer::CloneableEvaluator > | buildScatterDirichlet () 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_Map > | getMap (int i) const |
get the map from the matrix More... | |
virtual const Teuchos::RCP< Epetra_Map > | getColMap (int i) const |
get the map from the matrix More... | |
virtual const Teuchos::RCP< Epetra_Map > | getGhostedMap (int i) const |
get the ghosted map from the matrix More... | |
virtual const Teuchos::RCP< Epetra_Map > | getGhostedColMap (int i) const |
get the ghosted map from the matrix More... | |
virtual const Teuchos::RCP< Epetra_CrsGraph > | getGraph (int i, int j) const |
get the graph of the crs matrix More... | |
virtual const Teuchos::RCP< Epetra_CrsGraph > | getGhostedGraph (int i, int j) const |
get the ghosted graph of the crs matrix More... | |
virtual const Teuchos::RCP< Epetra_Import > | getGhostedImport (int i) const |
get importer for converting an overalapped object to a "normal" object More... | |
virtual const Teuchos::RCP< Epetra_Import > | getGhostedColImport (int i) const |
get importer for converting an overalapped object to a "normal" object More... | |
virtual const Teuchos::RCP< Epetra_Export > | getGhostedExport (int j) const |
get exporter for converting an overalapped object to a "normal" object More... | |
virtual const Teuchos::RCP< Epetra_Export > | getGhostedColExport (int j) const |
get exporter for converting an overalapped object to a "normal" object More... | |
virtual const Teuchos::RCP< const Epetra_Comm > | getEpetraComm () const |
get exporter for converting an overalapped object to a "normal" object More... | |
Teuchos::RCP< Epetra_CrsMatrix > | getEpetraMatrix (int i, int j) const |
Teuchos::RCP< Epetra_CrsMatrix > | getGhostedEpetraMatrix (int i, int j) const |
int | getBlockRowCount () const |
how many block rows More... | |
int | getBlockColCount () const |
how many block columns More... | |
Teuchos::RCP< const panzer::BlockedDOFManager< int, int > > | getGlobalIndexer () const |
Teuchos::RCP< const panzer::UniqueGlobalIndexerBase > | getRangeGlobalIndexer () const |
Get the range global indexer object associated with this factory. More... | |
Teuchos::RCP< const panzer::UniqueGlobalIndexerBase > | getDomainGlobalIndexer () 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... | |
![]() | |
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::UniqueGlobalIndexerBase > | getUniqueGlobalIndexerBase () const |
Get the range global indexer object associated with this factory. More... | |
virtual void | beginFill (LinearObjContainer &loc) const |
virtual void | endFill (LinearObjContainer &loc) const |
![]() | |
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_Map > | buildMap (int i) const |
virtual const Teuchos::RCP< Epetra_Map > | buildGhostedMap (int i) const |
virtual const Teuchos::RCP< Epetra_Map > | buildColMap (int i) const |
virtual const Teuchos::RCP< Epetra_Map > | buildColGhostedMap (int i) const |
virtual const Teuchos::RCP< Epetra_CrsGraph > | buildGraph (int i, int j) const |
virtual const Teuchos::RCP< Epetra_CrsGraph > | buildGhostedGraph (int i, int j, bool optimizeStorage) const |
virtual const Teuchos::RCP< Epetra_CrsGraph > | buildFilteredGhostedGraph (int i, int j) const |
Definition at line 85 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::BlockedEpetraLinearObjFactory | ( | const Teuchos::RCP< const Teuchos::MpiComm< int > > & | comm, |
const Teuchos::RCP< const UniqueGlobalIndexerBase > & | gidProvider, | ||
bool | useDiscreteAdjoint = false |
||
) |
Definition at line 80 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
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 |
||
) |
Definition at line 103 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Definition at line 128 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Read in a vector from a file. Fill a particular vector in the linear object container.
[in] | identifier | Key for specifying which file(s) to read |
[in] | loc | Linear object container to fill with the vector |
[in] | id | Id for the field to be filled |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 137 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Write in a vector from a file. Fill a particular vector in the linear object container.
[in] | identifier | Key for specifying which file(s) to read |
[in] | loc | Linear object container to fill with the vector |
[in] | id | Id for the field to be filled |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 187 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Build a container with all the neccessary linear algebra objects. This is the non-ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 231 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
inlinevirtual |
Build a container with all the neccessary linear algebra objects, purely on the single physics. This gives linear algebra objects that are relevant for a single physics solve. In many cases this is simply a call to buildLinearObjContainer however, in a few important cases (for instance in stochastic galerkin methods) this will return a container for a single instantiation of the physics. This is the non-ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 108 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
virtual |
Build a container with all the neccessary linear algebra objects. This is the ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 252 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
inlinevirtual |
Build a container with all the neccessary linear algebra objects, purely on the single physics. This gives linear algebra objects that are relevant for a single physics solve. In many cases this is simply a call to buildGhostedLinearObjContainer however, in a few important cases (for instance in stochastic galerkin methods) this will return a container for a single instantiation of the physics. This is the ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 113 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
virtual |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 273 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 315 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Adjust the residual vector and Jacobian matrix (if they exist) for applied dirichlet conditions. The adjustment considers if a boundary condition was set globally and locally and based on that result adjust the ghosted matrix and residual vector so that when they are summed across processors they resulting Dirichlet condition is correct.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 358 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Adjust a vector by replacing selected rows with the value of the evaluated dirichlet conditions. This is handled through the standard container mechanism.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 495 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Build a GlobalEvaluationDataContainer that handles all domain communication. This is used primarily for gather operations and hides the allocation and usage of the ghosted vector from the user.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 534 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
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.
|
inline |
Use preconstructed scatter evaluators.
Definition at line 148 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 163 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 173 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 183 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 192 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed dirichlet scatter evaluators.
Definition at line 197 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
virtual |
Initialize container with a specific set of member values.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 571 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Initialize container with a specific set of member values.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 581 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get the domain vector space (x and dxdt)
Implements panzer::ThyraObjFactory< double >.
Definition at line 707 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get the range vector space (f)
Implements panzer::ThyraObjFactory< double >.
Definition at line 730 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
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.
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.
|
virtual |
Get a Thyra operator.
Implements panzer::ThyraObjFactory< double >.
Definition at line 775 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraDomainSpace | ( | ) | const |
Get the domain vector space (x and dxdt)
Definition at line 811 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraRangeSpace | ( | ) | const |
Get the range vector space (f)
Definition at line 834 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
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.
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.
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.
|
virtual |
get the map from the matrix
Definition at line 1079 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the map from the matrix
Definition at line 1090 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the ghosted map from the matrix
Definition at line 1103 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the ghosted map from the matrix
Definition at line 1113 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the graph of the crs matrix
Definition at line 1127 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the ghosted graph of the crs matrix
Definition at line 1146 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get importer for converting an overalapped object to a "normal" object
Definition at line 1165 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get importer for converting an overalapped object to a "normal" object
Definition at line 1175 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get exporter for converting an overalapped object to a "normal" object
Definition at line 1188 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get exporter for converting an overalapped object to a "normal" object
Definition at line 1198 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get exporter for converting an overalapped object to a "normal" object
Definition at line 1432 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Epetra_CrsMatrix > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getEpetraMatrix | ( | int | i, |
int | j | ||
) | const |
Definition at line 1412 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Epetra_CrsMatrix > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedEpetraMatrix | ( | int | i, |
int | j | ||
) | const |
Definition at line 1422 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
int panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getBlockRowCount | ( | ) | const |
how many block rows
Definition at line 1439 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
int panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getBlockColCount | ( | ) | const |
how many block columns
Definition at line 1446 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
inline |
Definition at line 301 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inlinevirtual |
Get the range global indexer object associated with this factory.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 304 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inlinevirtual |
Get the domain global indexer object associated with this factory.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 307 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Get global indexers associated with the blocks.
Definition at line 311 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Get global indexers associated with the blocks.
Definition at line 315 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::addExcludedPair | ( | int | rowBlock, |
int | colBlock | ||
) |
exclude a block pair from the matrix
Definition at line 658 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::addExcludedPairs | ( | const std::vector< std::pair< int, int > > & | exPairs | ) |
exclude a vector of pairs from the matrix
Definition at line 665 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Initialize container with a specific set of member values.
Definition at line 616 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Initialize container with a specific set of member values.
Definition at line 637 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 673 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 680 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Allocate the space in the std::vector objects so we can fill with appropriate Epetra data.
Definition at line 687 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 915 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 952 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 998 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 446 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1039 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1065 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1052 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1211 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1239 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1223 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1252 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1268 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1298 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1363 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 427 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 428 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 430 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 433 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 443 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 444 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 446 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 447 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 475 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 476 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 477 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 479 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 480 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 481 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 482 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 484 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 485 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 486 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 487 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 489 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 490 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 492 of file Panzer_BlockedEpetraLinearObjFactory.hpp.