Panzer
Version of the Day
|
#include <Panzer_BlockedEpetraLinearObjFactory.hpp>
Classes | |
class | DOFManagerContainer |
Protected Member Functions | |
void | initializeContainer_internal (int mem, ThyraObjContainer< double > &loc) const |
void | initializeGhostedContainer_internal (int mem, ThyraObjContainer< double > &loc) const |
Teuchos::RCP< const GlobalIndexer > | getGlobalIndexer (int i) const |
Teuchos::RCP< const GlobalIndexer > | getColGlobalIndexer (int i) const |
void | makeRoomForBlocks (std::size_t blockCnt, std::size_t colBlockCnt=0) |
Allocate the space in the std::vector objects so we can fill with appropriate Epetra data. 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 |
Build the i -th owned map from the owned indices of the i -th global indexer. More... | |
virtual const Teuchos::RCP < Epetra_Map > | buildGhostedMap (int i) const |
Build the i -th ghosted map from the owned and ghosted indices of the i -th global indexer. More... | |
virtual const Teuchos::RCP < Epetra_Map > | buildGhostedMap2 (int i) const |
Build the i -th ghosted map from the ghosted indices of the i -th global indexer. More... | |
virtual const Teuchos::RCP < Epetra_Map > | buildColMap (int i) const |
Build the i -th owned column map from the owned indices of the i -th (column) global indexer. More... | |
virtual const Teuchos::RCP < Epetra_Map > | buildColGhostedMap (int i) const |
Build the i -th ghosted column map from the owned and ghosted indices of the i -th (column) global indexer. More... | |
virtual const Teuchos::RCP < Epetra_Map > | buildColGhostedMap2 (int i) const |
Build the i -th ghosted column map from the ghosted indices of the i -th (column) global indexer. More... | |
virtual const Teuchos::RCP < Epetra_CrsGraph > | buildGraph (int i, int j) const |
virtual const Teuchos::RCP < Epetra_CrsGraph > | buildGhostedGraph (int i, int j, bool optimizeStorage) const |
virtual const Teuchos::RCP < Epetra_CrsGraph > | buildFilteredGhostedGraph (int i, int j) const |
Protected Attributes | |
Teuchos::RCP< const DOFManagerContainer > | rowDOFManagerContainer_ |
Teuchos::RCP< const DOFManagerContainer > | colDOFManagerContainer_ |
bool | useColGidProviders_ |
std::unordered_set< std::pair < int, int > , panzer::pair_hash > | excludedPairs_ |
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | rangeSpace_ |
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | domainSpace_ |
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | ghostedRangeSpace_ |
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > | ghostedDomainSpace_ |
Teuchos::RCP< const Epetra_Comm > | eComm_ |
Teuchos::RCP< const Teuchos::OpaqueWrapper < MPI_Comm > > | rawMpiComm_ |
Teuchos::RCP< Teuchos::MpiComm < int > > | tComm_ |
std::vector< Teuchos::RCP < Epetra_Map > > | maps_ |
The list of owned maps corresponding to the owned indices of the global indexers. More... | |
std::vector< Teuchos::RCP < Epetra_Map > > | ghostedMaps_ |
The list of ghosted maps corresponding to the owned and ghosted indices of the global indexers. More... | |
std::vector< Teuchos::RCP < Epetra_Map > > | ghostedMaps2_ |
The list of ghosted maps corresponding to the ghosted indices of the global indexers. More... | |
std::vector< Teuchos::RCP < Epetra_Import > > | importers_ |
The list of ghosted importers corresponding to ghostedMaps_ . More... | |
std::vector< Teuchos::RCP < Epetra_Import > > | importers2_ |
The list of ghosted importers corresponding to ghostedMaps2_ . More... | |
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. More... | |
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. More... | |
std::vector< Teuchos::RCP < Epetra_Map > > | colGhostedMaps2_ |
The list of ghosted column maps corresponding to the ghosted indices of the (column) global indexers. More... | |
std::vector< Teuchos::RCP < Epetra_Import > > | colImporters_ |
The list of ghosted importers corresponding to colGhostedMaps_ . More... | |
std::vector< Teuchos::RCP < Epetra_Import > > | colImporters2_ |
The list of ghosted importers corresponding to colGhostedMaps2_ . More... | |
std::vector< Teuchos::RCP < Epetra_Export > > | colExporters_ |
std::unordered_map< std::pair < int, int >, Teuchos::RCP < Epetra_CrsGraph > , panzer::pair_hash > | graphs_ |
std::unordered_map< std::pair < int, int >, Teuchos::RCP < Epetra_CrsGraph > , panzer::pair_hash > | ghostedGraphs_ |
bool | useDiscreteAdjoint_ |
Definition at line 54 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::BlockedEpetraLinearObjFactory | ( | const Teuchos::RCP< const Teuchos::MpiComm< int > > & | comm, |
const Teuchos::RCP< const GlobalIndexer > & | gidProvider, | ||
bool | useDiscreteAdjoint = false |
||
) |
Definition at line 54 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::BlockedEpetraLinearObjFactory | ( | const Teuchos::RCP< const Teuchos::MpiComm< int > > & | comm, |
const Teuchos::RCP< const GlobalIndexer > & | gidProvider, | ||
const Teuchos::RCP< const GlobalIndexer > & | colGidProvider, | ||
bool | useDiscreteAdjoint = false |
||
) |
Definition at line 77 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Definition at line 102 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Read in a vector from a file. Fill a particular vector in the linear object container.
[in] | identifier | Key for specifying which file(s) to read |
[in] | loc | Linear object container to fill with the vector |
[in] | id | Id for the field to be filled |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 111 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 161 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Build a container with all the neccessary linear algebra objects. This is the non-ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 205 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
inlinevirtual |
Build a container with all the neccessary linear algebra objects, purely on the single physics. This gives linear algebra objects that are relevant for a single physics solve. In many cases this is simply a call to buildLinearObjContainer however, in a few important cases (for instance in stochastic galerkin methods) this will return a container for a single instantiation of the physics. This is the non-ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 77 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
virtual |
Build a container with all the neccessary linear algebra objects. This is the ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 226 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
inlinevirtual |
Build a container with all the neccessary linear algebra objects, purely on the single physics. This gives linear algebra objects that are relevant for a single physics solve. In many cases this is simply a call to buildGhostedLinearObjContainer however, in a few important cases (for instance in stochastic galerkin methods) this will return a container for a single instantiation of the physics. This is the ghosted version.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 82 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
virtual |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 247 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Implements panzer::LinearObjFactory< Traits >.
Definition at line 289 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Adjust the residual vector and Jacobian matrix (if they exist) for applied dirichlet conditions. The adjustment considers if a boundary condition was set globally and locally and based on that result adjust the ghosted matrix and residual vector so that when they are summed across processors they resulting Dirichlet condition is correct.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 332 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 469 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 513 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Build a GlobalEvaluationDataContainer that handles all domain communication. This is used primarily for gather operations and hides the allocation and usage of the ghosted vector from the user.
Definition at line 555 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Acess to the MPI Comm used in constructing this LOF.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 591 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
inline |
Use preconstructed scatter evaluators.
Definition at line 123 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 138 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 148 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 158 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed gather evaluators.
Definition at line 167 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Use preconstructed dirichlet scatter evaluators.
Definition at line 172 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
virtual |
Initialize container with a specific set of member values.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 598 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Initialize container with a specific set of member values.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 608 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get the domain vector space (x and dxdt)
Implements panzer::ThyraObjFactory< double >.
Definition at line 746 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get the range vector space (f)
Implements panzer::ThyraObjFactory< double >.
Definition at line 769 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Thyra::VectorBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getThyraDomainVector | ( | ) | const |
Get a domain vector.
Definition at line 792 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Thyra::VectorBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getThyraRangeVector | ( | ) | const |
Get a range vector.
Definition at line 803 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get a Thyra operator.
Implements panzer::ThyraObjFactory< double >.
Definition at line 814 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 856 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< const Thyra::VectorSpaceBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraDomainSpace2 | ( | ) | const |
Get or create the ghosted Thyra
domain space.
Get the vector space corresponding to the ghosted domain. If it does not yet exist, create it from the ghosted column map(s).
Definition at line 891 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 920 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Thyra::VectorBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraDomainVector | ( | ) | const |
Get a domain vector.
Definition at line 943 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Thyra::VectorBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraRangeVector | ( | ) | const |
Get a range vector.
Definition at line 954 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Thyra::LinearOpBase< double > > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedThyraMatrix | ( | ) | const |
Get a Thyra operator.
Definition at line 965 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the map from the matrix
Definition at line 1165 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the map from the matrix
Definition at line 1176 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the ghosted map from the matrix
Definition at line 1195 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get or create the i
-th ghosted map.
[in] | i | The index into the list of ghosted maps. |
i
-th ghosted map. Definition at line 1211 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the ghosted map from the matrix
Definition at line 1227 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get or create the i
-th ghosted column map.
[in] | i | The index into the list of ghosted column maps. |
i
-th ghosted column map. Definition at line 1245 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the graph of the crs matrix
Definition at line 1258 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get the ghosted graph of the crs matrix
Definition at line 1277 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get importer for converting an overalapped object to a "normal" object
Definition at line 1302 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get or create the i
-th ghosted importer corresponding to the i
-th ghosted map.
[in] | i | The index into the list of ghosted importers. |
i
-th ghosted importer. Definition at line 1319 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get importer for converting an overalapped object to a "normal" object
Definition at line 1336 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get or create the i
-th ghosted column importer corresponding to the i
-th ghosted column map.
[in] | i | The index into the list of ghosted column importers. |
i
-th ghosted column importer. Definition at line 1356 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get exporter for converting an overalapped object to a "normal" object
Definition at line 1376 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get or create the i
-th ghosted exporter corresponding to the i
-th ghosted map.
[in] | i | The index into the list of ghosted exporters. |
i
-th ghosted exporter. Definition at line 1393 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get exporter for converting an overalapped object to a "normal" object
Definition at line 1410 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
Get or create the i
-th ghosted column exporter corresponding to the i
-th ghosted column map.
[in] | i | The index into the list of ghosted column exporters. |
i
-th ghosted column exporter. Definition at line 1430 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
virtual |
get exporter for converting an overalapped object to a "normal" object
Definition at line 1711 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Epetra_CrsMatrix > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getEpetraMatrix | ( | int | i, |
int | j | ||
) | const |
Definition at line 1691 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
Teuchos::RCP< Epetra_CrsMatrix > panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getGhostedEpetraMatrix | ( | int | i, |
int | j | ||
) | const |
Definition at line 1701 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
int panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getBlockRowCount | ( | ) | const |
how many block rows
Definition at line 1718 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
int panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::getBlockColCount | ( | ) | const |
how many block columns
Definition at line 1725 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
inline |
Definition at line 378 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inlinevirtual |
Get the range global indexer object associated with this factory.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 381 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inlinevirtual |
Get the domain global indexer object associated with this factory.
Implements panzer::LinearObjFactory< Traits >.
Definition at line 384 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Get global indexers associated with the blocks.
Definition at line 388 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
inline |
Get global indexers associated with the blocks.
Definition at line 392 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
void panzer::BlockedEpetraLinearObjFactory< Traits, LocalOrdinalT >::addExcludedPair | ( | int | rowBlock, |
int | colBlock | ||
) |
exclude a block pair from the matrix
Definition at line 685 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 692 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Initialize container with a specific set of member values.
Definition at line 643 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Initialize container with a specific set of member values.
Definition at line 664 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 700 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 707 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 720 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1001 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1038 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1084 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 420 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1125 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1151 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 1138 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Build the i
-th owned map from the owned indices of the i
-th global indexer.
[in] | i | The index into the list of global indexers. |
i
-th owned map. Definition at line 1444 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Build the i
-th ghosted map from the owned and ghosted indices of the i
-th global indexer.
[in] | i | The index into the list of global indexers. |
i
-th owned and ghosted map. Definition at line 1477 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Build the i
-th ghosted map from the ghosted indices of the i
-th global indexer.
[in] | i | The index into the list of global indexers. |
i
-th ghosted map. Definition at line 1495 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Build the i
-th owned column map from the owned indices of the i
-th (column) global indexer.
[in] | i | The index into the list of (column) global indexers. |
i
-th owned column map. Definition at line 1456 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Build the i
-th ghosted column map from the owned and ghosted indices of the i
-th (column) global indexer.
[in] | i | The index into the list of (column) global indexers. |
i
-th owned and ghosted column map. Definition at line 1513 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Build the i
-th ghosted column map from the ghosted indices of the i
-th (column) global indexer.
[in] | i | The index into the list of (column) global indexers. |
i
-th ghosted column map. Definition at line 1533 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1548 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1578 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protectedvirtual |
Definition at line 1642 of file Panzer_BlockedEpetraLinearObjFactory_impl.hpp.
|
protected |
Definition at line 504 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 505 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 507 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 510 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 520 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 521 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 523 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 524 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 620 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 621 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 622 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of owned maps corresponding to the owned indices of the global indexers.
Definition at line 628 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted maps corresponding to the owned and ghosted indices of the global indexers.
Definition at line 634 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted maps corresponding to the ghosted indices of the global indexers.
Definition at line 640 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted importers corresponding to ghostedMaps_
.
Definition at line 645 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted importers corresponding to ghostedMaps2_
.
Definition at line 650 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 652 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of owned column maps corresponding to the owned indices of the (column) global indexers.
Definition at line 658 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted column maps corresponding to the owned and ghosted indices of the (column) global indexers.
Definition at line 664 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted column maps corresponding to the ghosted indices of the (column) global indexers.
Definition at line 670 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted importers corresponding to colGhostedMaps_
.
Definition at line 675 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
The list of ghosted importers corresponding to colGhostedMaps2_
.
Definition at line 681 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 683 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 685 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
mutableprotected |
Definition at line 686 of file Panzer_BlockedEpetraLinearObjFactory.hpp.
|
protected |
Definition at line 688 of file Panzer_BlockedEpetraLinearObjFactory.hpp.