Tpetra parallel linear algebra
Version of the Day
|
A distributed graph accessed by rows (adjacency lists) and stored sparsely. More...
#include <Tpetra_FECrsGraph_decl.hpp>
Public Types | |
typedef CrsGraph< LocalOrdinal, GlobalOrdinal, Node > | crs_graph_type |
Parent class. More... | |
typedef LocalOrdinal | local_ordinal_type |
This class' first template parameter; the type of local indices. More... | |
typedef GlobalOrdinal | global_ordinal_type |
This class' second template parameter; the type of global indices. More... | |
typedef Node | node_type |
This class' Kokkos Node type. More... | |
typedef CrsGraph< LocalOrdinal, GlobalOrdinal, Node > ::device_type | device_type |
The Kokkos device type. More... | |
typedef CrsGraph< LocalOrdinal, GlobalOrdinal, Node > ::execution_space | execution_space |
The Kokkos execution space. More... | |
typedef CrsGraph< LocalOrdinal, GlobalOrdinal, Node > ::local_graph_device_type | local_graph_device_type |
The type of the part of the sparse graph on each MPI process. More... | |
using | map_type = ::Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > |
The Map specialization used by this class. More... | |
using | import_type = ::Tpetra::Import< LocalOrdinal, GlobalOrdinal, Node > |
The Import specialization used by this class. More... | |
using | export_type = ::Tpetra::Export< LocalOrdinal, GlobalOrdinal, Node > |
The Export specialization used by this class. More... | |
using | local_graph_host_type = typename local_graph_device_type::HostMirror |
The type of the part of the sparse graph on each MPI process. More... | |
using | local_inds_device_view_type = typename row_graph_type::local_inds_device_view_type |
The Kokkos::View type for views of local ordinals on device and host. More... | |
using | global_inds_device_view_type = typename row_graph_type::global_inds_device_view_type |
The Kokkos::View type for views of global ordinals on device and host. More... | |
Public Member Functions | |
void | importAndFillComplete (Teuchos::RCP< CrsGraph< local_ordinal_type, global_ordinal_type, Node > > &destGraph, const import_type &importer, const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) const |
Import from this to the given destination graph, and make the result fill complete. More... | |
void | importAndFillComplete (Teuchos::RCP< CrsGraph< local_ordinal_type, global_ordinal_type, Node > > &destGraph, const import_type &rowImporter, const import_type &domainImporter, const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap, const Teuchos::RCP< Teuchos::ParameterList > ¶ms) const |
Import from this to the given destination graph, and make the result fill complete. More... | |
void | exportAndFillComplete (Teuchos::RCP< CrsGraph< local_ordinal_type, global_ordinal_type, Node > > &destGraph, const export_type &exporter, const Teuchos::RCP< const map_type > &domainMap=Teuchos::null, const Teuchos::RCP< const map_type > &rangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) const |
Export from this to the given destination graph, and make the result fill complete. More... | |
void | exportAndFillComplete (Teuchos::RCP< CrsGraph< local_ordinal_type, global_ordinal_type, Node > > &destGraph, const export_type &rowExporter, const export_type &domainExporter, const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap, const Teuchos::RCP< Teuchos::ParameterList > ¶ms) const |
Export from this to the given destination graph, and make the result fill complete. More... | |
bool | haveGlobalConstants () const |
Returns true if globalConstants have been computed; false otherwise. More... | |
void | computeGlobalConstants () |
Compute global constants, if they have not yet been computed. More... | |
local_graph_device_type | getLocalGraphDevice () const |
Get the local graph. More... | |
Constructor/Destructor Methods | |
FECrsGraph (const Teuchos::RCP< const map_type > &ownedRowMap, const Teuchos::RCP< const map_type > &ownedPlusSharedRowMap, const size_t maxNumEntriesPerRow, const Teuchos::RCP< const import_type > &ownedPlusSharedToOwnedimporter=Teuchos::null, const Teuchos::RCP< const map_type > &domainMap=Teuchos::null, const Teuchos::RCP< const map_type > &ownedRangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructorfor globally-indexed assembly specifying a single upper bound for the number of entries in all rows on the calling process. More... | |
FECrsGraph (const Teuchos::RCP< const map_type > &ownedRowMap, const Teuchos::RCP< const map_type > &ownedPlusSharedRowMap, const size_t maxNumEntriesPerRow, const Teuchos::RCP< const map_type > &ownedPlusSharedDomainMap, const Teuchos::RCP< const import_type > &ownedPlusSharedToOwnedimporter=Teuchos::null, const Teuchos::RCP< const map_type > &ownedDomainMap=Teuchos::null, const Teuchos::RCP< const map_type > &ownedRangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructorfor globally-indexed assembly specifying a single upper bound for the number of entries in all rows on the calling process. More... | |
FECrsGraph (const Teuchos::RCP< const map_type > &ownedRowMap, const Teuchos::RCP< const map_type > &ownedPlusSharedRowMap, const Kokkos::DualView< const size_t *, device_type > &numEntPerRow, const Teuchos::RCP< const import_type > &ownedPlusSharedToOwnedimporter=Teuchos::null, const Teuchos::RCP< const map_type > &domainMap=Teuchos::null, const Teuchos::RCP< const map_type > &ownedRangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor for globally-indexed assembly specifying a (possibly different) upper bound for the number of entries in each row. More... | |
FECrsGraph (const Teuchos::RCP< const map_type > &ownedRowMap, const Teuchos::RCP< const map_type > &ownedPlusSharedRowMap, const Kokkos::DualView< const size_t *, device_type > &numEntPerRow, const Teuchos::RCP< const map_type > &ownedPlusSharedDomainMap, const Teuchos::RCP< const import_type > &ownedPlusSharedToOwnedimporter=Teuchos::null, const Teuchos::RCP< const map_type > &ownedDomainMap=Teuchos::null, const Teuchos::RCP< const map_type > &ownedRangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor for globally-indexed assembly specifying a (possibly different) upper bound for the number of entries in each row. More... | |
FECrsGraph (const Teuchos::RCP< const map_type > &ownedRowMap, const Teuchos::RCP< const map_type > &ownedPlusSharedRowMap, const Teuchos::RCP< const map_type > &ownedPlusSharedColMap, const size_t maxNumEntriesPerRow, const Teuchos::RCP< const import_type > &ownedPlusSharedToOwnedimporter=Teuchos::null, const Teuchos::RCP< const map_type > &domainMap=Teuchos::null, const Teuchos::RCP< const map_type > &ownedRangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor for locally-indexed assembly specifying a single upper bound for the number of entries in all rows on the calling process. More... | |
FECrsGraph (const Teuchos::RCP< const map_type > &ownedRowMap, const Teuchos::RCP< const map_type > &ownedPlusSharedRowMap, const Teuchos::RCP< const map_type > &ownedPlusSharedColMap, const size_t maxNumEntriesPerRow, const Teuchos::RCP< const map_type > &ownedPlusSharedDomainMap, const Teuchos::RCP< const import_type > &ownedPlusSharedToOwnedimporter=Teuchos::null, const Teuchos::RCP< const map_type > &ownedDomainMap=Teuchos::null, const Teuchos::RCP< const map_type > &ownedRangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor for locally-indexed assembly specifying a single upper bound for the number of entries in all rows on the calling process. More... | |
FECrsGraph (const Teuchos::RCP< const map_type > &ownedRowMap, const Teuchos::RCP< const map_type > &ownedPlusSharedRowMap, const Teuchos::RCP< const map_type > &ownedPlusSharedColMap, const Kokkos::DualView< const size_t *, device_type > &numEntPerRow, const Teuchos::RCP< const import_type > &ownedPlusSharedToOwnedimporter=Teuchos::null, const Teuchos::RCP< const map_type > &domainMap=Teuchos::null, const Teuchos::RCP< const map_type > &ownedRangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor for locally-indexed assembly specifying a (possibly different) upper bound for the number of entries in each row. More... | |
FECrsGraph (const Teuchos::RCP< const map_type > &ownedRowMap, const Teuchos::RCP< const map_type > &ownedPlusSharedRowMap, const Teuchos::RCP< const map_type > &ownedPlusSharedColMap, const Kokkos::DualView< const size_t *, device_type > &numEntPerRow, const Teuchos::RCP< const map_type > &ownedPlusSharedDomainMap, const Teuchos::RCP< const import_type > &ownedPlusSharedToOwnedimporter=Teuchos::null, const Teuchos::RCP< const map_type > &ownedDomainMap=Teuchos::null, const Teuchos::RCP< const map_type > &ownedRangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor for locally-indexed assembly specifying a (possibly different) upper bound for the number of entries in each row. More... | |
FECrsGraph (const FECrsGraph< LocalOrdinal, GlobalOrdinal, Node > &)=delete | |
Copy constructor (forbidden). More... | |
FECrsGraph (FECrsGraph< LocalOrdinal, GlobalOrdinal, Node > &&)=delete | |
Move constructor (forbidden). More... | |
FECrsGraph & | operator= (const FECrsGraph< LocalOrdinal, GlobalOrdinal, Node > &)=delete |
Copy assignment (forbidden). More... | |
FECrsGraph & | operator= (FECrsGraph< LocalOrdinal, GlobalOrdinal, Node > &&)=delete |
Move assignment (forbidden). More... | |
virtual | ~FECrsGraph ()=default |
Destructor (virtual for memory safety of derived classes). More... | |
Implementation of Teuchos::ParameterListAcceptor | |
Teuchos::RCP< const Teuchos::ParameterList > | getValidParameters () const override |
Default parameter list suitable for validation. More... | |
Constructor/Destructor Methods | |
bool | isIdenticalTo (const CrsGraph< LocalOrdinal, GlobalOrdinal, Node > &graph) const |
Create a cloned CrsGraph for a different Node type. More... | |
Implementation of Teuchos::ParameterListAcceptor | |
void | setParameterList (const Teuchos::RCP< Teuchos::ParameterList > ¶ms) override |
Set the given list of parameters (must be nonnull). More... | |
Insertion/Removal Methods | |
void | insertGlobalIndices (const global_ordinal_type globalRow, const Teuchos::ArrayView< const global_ordinal_type > &indices) |
Insert global indices into the graph. More... | |
void | insertGlobalIndices (const global_ordinal_type globalRow, const local_ordinal_type numEnt, const global_ordinal_type inds[]) |
Epetra compatibility version of insertGlobalIndices (see above) that takes input as a raw pointer, rather than Teuchos::ArrayView. More... | |
void | insertLocalIndices (const local_ordinal_type localRow, const Teuchos::ArrayView< const local_ordinal_type > &indices) |
Insert local indices into the graph. More... | |
void | insertLocalIndices (const local_ordinal_type localRow, const local_ordinal_type numEnt, const local_ordinal_type inds[]) |
Epetra compatibility version of insertLocalIndices (see above) that takes input as a raw pointer, rather than Teuchos::ArrayView. More... | |
void | removeLocalIndices (local_ordinal_type localRow) |
Remove all graph indices from the specified local row. More... | |
Collective methods for changing the graph's global state | |
void | globalAssemble () |
Communicate nonlocal contributions to other processes. More... | |
void | resumeFill (const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
Resume fill operations. More... | |
void | expertStaticFillComplete (const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap, const Teuchos::RCP< const import_type > &importer=Teuchos::null, const Teuchos::RCP< const export_type > &exporter=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
Perform a fillComplete on a graph that already has data, via setAllIndices(). More... | |
Methods implementing RowGraph. | |
Teuchos::RCP< const Teuchos::Comm< int > > | getComm () const override |
Returns the communicator. More... | |
Teuchos::RCP< const map_type > | getRowMap () const override |
Returns the Map that describes the row distribution in this graph. More... | |
Teuchos::RCP< const map_type > | getColMap () const override |
Returns the Map that describes the column distribution in this graph. More... | |
Teuchos::RCP< const map_type > | getDomainMap () const override |
Returns the Map associated with the domain of this graph. More... | |
Teuchos::RCP< const map_type > | getRangeMap () const override |
Returns the Map associated with the domain of this graph. More... | |
Teuchos::RCP< const import_type > | getImporter () const override |
Returns the importer associated with this graph. More... | |
Teuchos::RCP< const export_type > | getExporter () const override |
Returns the exporter associated with this graph. More... | |
global_size_t | getGlobalNumRows () const override |
Returns the number of global rows in the graph. More... | |
global_size_t | getGlobalNumCols () const override |
Returns the number of global columns in the graph. More... | |
size_t | getLocalNumRows () const override |
Returns the number of graph rows owned on the calling node. More... | |
size_t | getLocalNumCols () const override |
Returns the number of columns connected to the locally owned rows of this graph. More... | |
global_ordinal_type | getIndexBase () const override |
Returns the index base for global indices for this graph. More... | |
global_size_t | getGlobalNumEntries () const override |
Returns the global number of entries in the graph. More... | |
size_t | getLocalNumEntries () const override |
The local number of entries in the graph. More... | |
size_t | getNumEntriesInGlobalRow (global_ordinal_type globalRow) const override |
Returns the current number of entries on this node in the specified global row. More... | |
size_t | getNumEntriesInLocalRow (local_ordinal_type localRow) const override |
Get the number of entries in the given row (local index). More... | |
size_t | getLocalAllocationSize () const |
The local number of indices allocated for the graph, over all rows on the calling (MPI) process. More... | |
size_t | getNumAllocatedEntriesInGlobalRow (global_ordinal_type globalRow) const |
Current number of allocated entries in the given row on the calling (MPI) process, using a global row index. More... | |
size_t | getNumAllocatedEntriesInLocalRow (local_ordinal_type localRow) const |
Current number of allocated entries in the given row on the calling (MPI) process, using a local row index. More... | |
size_t | getGlobalMaxNumRowEntries () const override |
Maximum number of entries in any row of the graph, over all processes in the graph's communicator. More... | |
size_t | getLocalMaxNumRowEntries () const override |
Maximum number of entries in any row of the graph, on this process. More... | |
bool | hasColMap () const override |
Whether the graph has a column Map. More... | |
bool | isLocallyIndexed () const override |
Whether the graph's column indices are stored as local indices. More... | |
bool | isGloballyIndexed () const override |
Whether the graph's column indices are stored as global indices. More... | |
bool | isFillComplete () const override |
Whether fillComplete() has been called and the graph is in compute mode. More... | |
bool | isFillActive () const |
Whether resumeFill() has been called and the graph is in edit mode. More... | |
bool | isSorted () const |
Whether graph indices in all rows are known to be sorted. More... | |
bool | isStorageOptimized () const |
Returns true if storage has been optimized. More... | |
void | getGlobalRowCopy (global_ordinal_type gblRow, nonconst_global_inds_host_view_type &gblColInds, size_t &numColInds) const override |
Get a copy of the given row, using global indices. More... | |
void | getLocalRowCopy (local_ordinal_type gblRow, nonconst_local_inds_host_view_type &gblColInds, size_t &numColInds) const override |
Get a copy of the given row, using local indices. More... | |
void | getGlobalRowView (const global_ordinal_type gblRow, global_inds_host_view_type &gblColInds) const override |
Get a const view of the given global row's global column indices. More... | |
bool | supportsRowViews () const override |
Whether this class implements getLocalRowView() and getGlobalRowView() (it does). More... | |
void | getLocalRowView (const LocalOrdinal lclRow, local_inds_host_view_type &lclColInds) const override |
Get a const view of the given local row's local column indices. More... | |
Access to entries in a row | |
virtual void | getGlobalRowCopy (const GlobalOrdinal gblRow, nonconst_global_inds_host_view_type &gblColInds, size_t &numColInds) const =0 |
Get a copy of the global column indices in a given row of the graph. More... | |
virtual void | getLocalRowCopy (const LocalOrdinal lclRow, nonconst_local_inds_host_view_type &lclColInds, size_t &numColInds) const =0 |
Get a copy of the local column indices in a given row of the graph. More... | |
virtual void | getGlobalRowView (const GlobalOrdinal gblRow, global_inds_host_view_type &gblColInds) const =0 |
Get a const, non-persisting view of the given global row's global column indices, as a Teuchos::ArrayView. More... | |
virtual void | getLocalRowView (const LocalOrdinal lclRow, local_inds_host_view_type &lclColInds) const =0 |
Get a constant, nonpersisting, locally indexed view of the given row of the graph. More... | |
Overridden from Teuchos::Describable | |
std::string | description () const override |
Return a one-line human-readable description of this object. More... | |
void | describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const override |
Print this object to the given output stream with the given verbosity level. More... | |
Advanced methods, at increased risk of deprecation. | |
void | getLocalDiagOffsets (const Kokkos::View< size_t *, device_type, Kokkos::MemoryUnmanaged > &offsets) const |
Get offsets of the diagonal entries in the graph. More... | |
void | getLocalDiagOffsets (Teuchos::ArrayRCP< size_t > &offsets) const |
Backwards compatibility overload of the above method. More... | |
void | getLocalOffRankOffsets (offset_device_view_type &offsets) const |
Get offsets of the off-rank entries in the graph. More... | |
void | setAllIndices (const typename local_graph_device_type::row_map_type &rowPointers, const typename local_graph_device_type::entries_type::non_const_type &columnIndices) |
Set the graph's data directly, using 1-D storage. More... | |
void | setAllIndices (const Teuchos::ArrayRCP< size_t > &rowPointers, const Teuchos::ArrayRCP< local_ordinal_type > &columnIndices) |
Set the graph's data directly, using 1-D storage. More... | |
row_ptrs_host_view_type | getLocalRowPtrsHost () const |
Get a host view of the packed row offsets. More... | |
row_ptrs_device_view_type | getLocalRowPtrsDevice () const |
Get a device view of the packed row offsets. More... | |
local_inds_host_view_type | getLocalIndicesHost () const |
Get a host view of the packed column indicies. More... | |
local_inds_device_view_type | getLocalIndicesDevice () const |
Get a device view of the packed column indicies. More... | |
void | replaceColMap (const Teuchos::RCP< const map_type > &newColMap) |
Replace the graph's current column Map with the given Map. More... | |
void | reindexColumns (const Teuchos::RCP< const map_type > &newColMap, const Teuchos::RCP< const import_type > &newImport=Teuchos::null, const bool sortIndicesInEachRow=true) |
Reindex the column indices in place, and replace the column Map. Optionally, replace the Import object as well. More... | |
void | replaceDomainMap (const Teuchos::RCP< const map_type > &newDomainMap) |
Replace the current domain Map with the given objects. More... | |
void | replaceDomainMapAndImporter (const Teuchos::RCP< const map_type > &newDomainMap, const Teuchos::RCP< const import_type > &newImporter) |
Replace the current domain Map and Import with the given parameters. More... | |
void | replaceRangeMap (const Teuchos::RCP< const map_type > &newRangeMap) |
Replace the current Range Map with the given objects. More... | |
void | replaceRangeMapAndExporter (const Teuchos::RCP< const map_type > &newRangeMap, const Teuchos::RCP< const export_type > &newExporter) |
Replace the current Range Map and Export with the given parameters. More... | |
virtual void | removeEmptyProcessesInPlace (const Teuchos::RCP< const map_type > &newMap) override |
Remove processes owning zero rows from the Maps and their communicator. More... | |
Methods for use only by experts | |
virtual void | removeEmptyProcessesInPlace (const Teuchos::RCP< const map_type > &newMap) |
Remove processes which contain no entries in this object's Map. More... | |
Public methods for redistributing data | |
void | doImport (const SrcDistObject &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, const CombineMode CM, const bool restrictedMode=false) |
Import data into this object using an Import object ("forward mode"). More... | |
void | doImport (const SrcDistObject &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, const CombineMode CM, const bool restrictedMode=false) |
Import data into this object using an Export object ("reverse mode"). More... | |
void | doExport (const SrcDistObject &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, const CombineMode CM, const bool restrictedMode=false) |
Export data into this object using an Export object ("forward mode"). More... | |
void | doExport (const SrcDistObject &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, const CombineMode CM, const bool restrictedMode=false) |
Export data into this object using an Import object ("reverse mode"). More... | |
void | beginImport (const SrcDistObject &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, const CombineMode CM, const bool restrictedMode=false) |
void | beginImport (const SrcDistObject &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, const CombineMode CM, const bool restrictedMode=false) |
void | beginExport (const SrcDistObject &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, const CombineMode CM, const bool restrictedMode=false) |
void | beginExport (const SrcDistObject &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, const CombineMode CM, const bool restrictedMode=false) |
void | endImport (const SrcDistObject &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, const CombineMode CM, const bool restrictedMode=false) |
void | endImport (const SrcDistObject &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, const CombineMode CM, const bool restrictedMode=false) |
void | endExport (const SrcDistObject &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, const CombineMode CM, const bool restrictedMode=false) |
void | endExport (const SrcDistObject &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, const CombineMode CM, const bool restrictedMode=false) |
bool | transferArrived () const |
Whether the data from an import/export operation has arrived, and is ready for the unpack and combine step. More... | |
Attribute accessor methods | |
bool | isDistributed () const |
Whether this is a globally distributed object. More... | |
virtual Teuchos::RCP< const map_type > | getMap () const |
The Map describing the parallel distribution of this object. More... | |
I/O methods | |
void | print (std::ostream &os) const |
Print this object to the given output stream. More... | |
Protected Member Functions | |
size_t | insertGlobalIndicesImpl (const local_ordinal_type lclRow, const global_ordinal_type inputGblColInds[], const size_t numInputInds) |
Insert global indices, using an input local row index. More... | |
size_t | insertGlobalIndicesImpl (const RowInfo &rowInfo, const global_ordinal_type inputGblColInds[], const size_t numInputInds, std::function< void(const size_t, const size_t, const size_t)> fun=std::function< void(const size_t, const size_t, const size_t)>()) |
Insert global indices, using an input RowInfo. More... | |
void | setDomainRangeMaps (const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap) |
void | computeLocalConstants () |
Compute local constants, if they have not yet been computed. More... | |
RowInfo | getRowInfo (const local_ordinal_type myRow) const |
Get information about the locally owned row with local index myRow. More... | |
RowInfo | getRowInfoFromGlobalRowIndex (const global_ordinal_type gblRow) const |
Get information about the locally owned row with global index gblRow. More... | |
void | checkInternalState () const |
Throw an exception if the internal state is not consistent. More... | |
void | swap (CrsGraph< local_ordinal_type, global_ordinal_type, Node > &graph) |
Swaps the data from *this with the data and maps from graph. More... | |
const row_ptrs_device_view_type & | getRowPtrsUnpackedDevice () const |
Get the unpacked row pointers on device. More... | |
const row_ptrs_host_view_type & | getRowPtrsUnpackedHost () const |
Get the unpacked row pointers on host. Lazily make a copy from device. More... | |
const row_ptrs_device_view_type & | getRowPtrsPackedDevice () const |
Get the packed row pointers on device. More... | |
const row_ptrs_host_view_type & | getRowPtrsPackedHost () const |
Get the packed row pointers on host. Lazily make a copy from device. More... | |
local_inds_dualv_type::t_host::const_type | getLocalIndsViewHost (const RowInfo &rowinfo) const |
Get a const, locally indexed view of the locally owned row myRow, such that rowinfo = getRowInfo(myRow). More... | |
local_inds_dualv_type::t_dev::const_type | getLocalIndsViewDevice (const RowInfo &rowinfo) const |
Get a const, locally indexed view of the locally owned row myRow, such that rowinfo = getRowInfo(myRow). More... | |
global_inds_dualv_type::t_host::const_type | getGlobalIndsViewHost (const RowInfo &rowinfo) const |
Get a const, globally indexed view of the locally owned row myRow, such that rowinfo = getRowInfo(myRow). More... | |
global_inds_dualv_type::t_dev::const_type | getGlobalIndsViewDevice (const RowInfo &rowinfo) const |
Get a const, globally indexed view of the locally owned row myRow, such that rowinfo = getRowInfo(myRow). More... | |
local_inds_dualv_type::t_host | getLocalIndsViewHostNonConst (const RowInfo &rowinfo) |
Get a ReadWrite locally indexed view of the locally owned row myRow, such that rowinfo = getRowInfo(myRow). More... | |
virtual size_t | constantNumberOfPackets () const |
Whether the implementation's instance promises always to have a constant number of packets per LID (local index), and if so, how many packets per LID there are. More... | |
virtual void | doTransfer (const SrcDistObject &src, const ::Tpetra::Details::Transfer< local_ordinal_type, global_ordinal_type, node_type > &transfer, const char modeString[], const ReverseOption revOp, const CombineMode CM, const bool restrictedMode) |
Redistribute data across (MPI) processes. More... | |
virtual bool | reallocArraysForNumPacketsPerLid (const size_t numExportLIDs, const size_t numImportLIDs) |
Reallocate numExportPacketsPerLID_ and/or numImportPacketsPerLID_, if necessary. More... | |
void | beginTransfer (const SrcDistObject &src, const ::Tpetra::Details::Transfer< local_ordinal_type, global_ordinal_type, node_type > &transfer, const char modeString[], const ReverseOption revOp, const CombineMode CM, const bool restrictedMode) |
Implementation detail of doTransfer. More... | |
Methods governing changes between global and local indices | |
void | makeColMap (Teuchos::Array< int > &remotePIDs) |
Make and set the graph's column Map. More... | |
std::pair< size_t, std::string > | makeIndicesLocal (const bool verbose=false) |
Convert column indices from global to local. More... | |
void | makeImportExport (Teuchos::Array< int > &remotePIDs, const bool useRemotePIDs) |
Make the Import and Export objects, if needed. More... | |
Methods for sorting and merging column indices. | |
bool | isMerged () const |
Whether duplicate column indices in each row have been merged. More... | |
void | setLocallyModified () |
Report that we made a local modification to its structure. More... | |
size_t | sortAndMergeRowIndices (const RowInfo &rowInfo, const bool sorted, const bool merged) |
Sort and merge duplicate column indices in the given row. More... | |
Protected Attributes | |
Teuchos::RCP< const map_type > | rowMap_ |
The Map describing the distribution of rows of the graph. More... | |
Teuchos::RCP< const map_type > | colMap_ |
The Map describing the distribution of columns of the graph. More... | |
Teuchos::RCP< const map_type > | rangeMap_ |
The Map describing the range of the (matrix corresponding to the) graph. More... | |
Teuchos::RCP< const map_type > | domainMap_ |
The Map describing the domain of the (matrix corresponding to the) graph. More... | |
Teuchos::RCP< const import_type > | importer_ |
The Import from the domain Map to the column Map. More... | |
Teuchos::RCP< const export_type > | exporter_ |
The Export from the row Map to the range Map. More... | |
size_t | nodeMaxNumRowEntries_ |
Local maximum of the number of entries in each row. More... | |
global_size_t | globalNumEntries_ |
Global number of entries in the graph. More... | |
global_size_t | globalMaxNumRowEntries_ |
Global maximum of the number of entries in each row. More... | |
local_inds_wdv_type | lclIndsUnpacked_wdv |
Local ordinals of column indices for all rows Valid when isLocallyIndexed is true If OptimizedStorage, storage is PACKED after fillComplete If not OptimizedStorate, storage is UNPACKED after fillComplete; that is, the views have storage equal to sizes provided in CrsGraph constructor. More... | |
local_inds_wdv_type | lclIndsPacked_wdv |
Local ordinals of column indices for all rows Valid when isLocallyIndexed is true Built during fillComplete or non-fillComplete constructors Storage is PACKED after fillComplete that is, the views have storage equal to sizes provided in CrsGraph constructor. More... | |
global_inds_wdv_type | gblInds_wdv |
Global ordinals of column indices for all rows. More... | |
Kokkos::View< const size_t *, device_type >::HostMirror | k_numAllocPerRow_ |
The maximum number of entries to allow in each locally owned row, per row. More... | |
size_t | numAllocForAllRows_ |
The maximum number of entries to allow in each locally owned row. More... | |
Details::EStorageStatus | storageStatus_ |
Status of the graph's storage, when not in a fill-complete state. More... | |
bool | indicesAreSorted_ = true |
Whether the graph's indices are sorted in each row, on this process. More... | |
bool | noRedundancies_ = true |
Whether the graph's indices are non-redundant (merged) in each row, on this process. More... | |
bool | haveLocalConstants_ = false |
Whether this process has computed local constants. More... | |
bool | haveGlobalConstants_ = false |
Whether all processes have computed global constants. More... | |
nonlocals_type | nonlocals_ |
Nonlocal data given to insertGlobalIndices. More... | |
bool | sortGhostsAssociatedWithEachProcessor_ = true |
Whether to require makeColMap() (and therefore fillComplete()) to order column Map GIDs associated with each remote process in ascending order. More... | |
Related Functions | |
(Note that these are not member functions.) | |
template<class CrsGraphType > | |
Teuchos::RCP< CrsGraphType > | importAndFillCompleteCrsGraph (const Teuchos::RCP< const CrsGraphType > &sourceGraph, const Import< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > &importer, const Teuchos::RCP< const Map< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > > &domainMap=Teuchos::null, const Teuchos::RCP< const Map< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > > &rangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
Nonmember CrsGraph constructor that fuses Import and fillComplete(). More... | |
template<class CrsGraphType > | |
Teuchos::RCP< CrsGraphType > | importAndFillCompleteCrsGraph (const Teuchos::RCP< const CrsGraphType > &sourceGraph, const Import< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > &rowImporter, const Import< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > &domainImporter, const Teuchos::RCP< const Map< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > > &domainMap, const Teuchos::RCP< const Map< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > > &rangeMap, const Teuchos::RCP< Teuchos::ParameterList > ¶ms) |
Nonmember CrsGraph constructor that fuses Import and fillComplete(). More... | |
template<class CrsGraphType > | |
Teuchos::RCP< CrsGraphType > | exportAndFillCompleteCrsGraph (const Teuchos::RCP< const CrsGraphType > &sourceGraph, const Export< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > &exporter, const Teuchos::RCP< const Map< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > > &domainMap=Teuchos::null, const Teuchos::RCP< const Map< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > > &rangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
Nonmember CrsGraph constructor that fuses Export and fillComplete(). More... | |
template<class CrsGraphType > | |
Teuchos::RCP< CrsGraphType > | exportAndFillCompleteCrsGraph (const Teuchos::RCP< const CrsGraphType > &sourceGraph, const Export< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > &rowExporter, const Export< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > &domainExporter, const Teuchos::RCP< const Map< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > > &domainMap, const Teuchos::RCP< const Map< typename CrsGraphType::local_ordinal_type, typename CrsGraphType::global_ordinal_type, typename CrsGraphType::node_type > > &rangeMap, const Teuchos::RCP< Teuchos::ParameterList > ¶ms) |
Nonmember CrsGraph constructor that fuses Export and fillComplete(). More... | |
template<class LocalOrdinal , class GlobalOrdinal , class Node > | |
Teuchos::RCP< CrsGraph < LocalOrdinal, GlobalOrdinal, Node > > | createCrsGraph (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node >> &map, size_t maxNumEntriesPerRow=0, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
Nonmember function to create an empty CrsGraph given a row Map and the max number of entries allowed locally per row. More... | |
Implementation of DistObject | |
using | buffer_device_type = typename dist_object_type::buffer_device_type |
Kokkos::Device specialization for communication buffers. More... | |
using | packet_type = global_ordinal_type |
Type of each entry of the DistObject communication buffer. More... | |
using | padding_type = Details::CrsPadding< local_ordinal_type, global_ordinal_type > |
virtual bool | checkSizes (const SrcDistObject &source) override |
Compare the source and target (this) objects for compatibility. More... | |
virtual void | copyAndPermute (const SrcDistObject &source, const size_t numSameIDs, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &permuteToLIDs, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &permuteFromLIDs, const CombineMode CM) override |
void | applyCrsPadding (const padding_type &padding, const bool verbose) |
std::unique_ptr< padding_type > | computeCrsPadding (const RowGraph< local_ordinal_type, global_ordinal_type, node_type > &source, const size_t numSameIDs, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &permuteToLIDs, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &permuteFromLIDs, const bool verbose) const |
std::unique_ptr< padding_type > | computeCrsPaddingForImports (const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &importLIDs, Kokkos::DualView< packet_type *, buffer_device_type > imports, Kokkos::DualView< size_t *, buffer_device_type > numPacketsPerLID, const bool verbose) const |
std::unique_ptr< padding_type > | computePaddingForCrsMatrixUnpack (const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &importLIDs, Kokkos::DualView< char *, buffer_device_type > imports, Kokkos::DualView< size_t *, buffer_device_type > numPacketsPerLID, const bool verbose) const |
void | computeCrsPaddingForSameIDs (padding_type &padding, const RowGraph< local_ordinal_type, global_ordinal_type, node_type > &source, const local_ordinal_type numSameIDs) const |
void | computeCrsPaddingForPermutedIDs (padding_type &padding, const RowGraph< local_ordinal_type, global_ordinal_type, node_type > &source, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &permuteToLIDs, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &permuteFromLIDs) const |
virtual void | packAndPrepare (const SrcDistObject &source, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &exportLIDs, Kokkos::DualView< packet_type *, buffer_device_type > &exports, Kokkos::DualView< size_t *, buffer_device_type > numPacketsPerLID, size_t &constantNumPackets) override |
virtual void | pack (const Teuchos::ArrayView< const local_ordinal_type > &exportLIDs, Teuchos::Array< global_ordinal_type > &exports, const Teuchos::ArrayView< size_t > &numPacketsPerLID, size_t &constantNumPackets) const override |
void | packFillActive (const Teuchos::ArrayView< const local_ordinal_type > &exportLIDs, Teuchos::Array< global_ordinal_type > &exports, const Teuchos::ArrayView< size_t > &numPacketsPerLID, size_t &constantNumPackets) const |
void | packFillActiveNew (const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &exportLIDs, Kokkos::DualView< packet_type *, buffer_device_type > &exports, Kokkos::DualView< size_t *, buffer_device_type > numPacketsPerLID, size_t &constantNumPackets) const |
virtual void | unpackAndCombine (const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &importLIDs, Kokkos::DualView< packet_type *, buffer_device_type > imports, Kokkos::DualView< size_t *, buffer_device_type > numPacketsPerLID, const size_t constantNumPackets, const CombineMode combineMode) override |
Methods for inserting indices or transforming values | |
size_t | insertIndices (RowInfo &rowInfo, const SLocalGlobalViews &newInds, const ELocalGlobal lg, const ELocalGlobal I) |
Insert indices into the given row. More... | |
size_t | findGlobalIndices (const RowInfo &rowInfo, const Teuchos::ArrayView< const global_ordinal_type > &indices, std::function< void(const size_t, const size_t, const size_t)> fun) const |
Finds indices in the given row. More... | |
void | insertGlobalIndicesFiltered (const local_ordinal_type lclRow, const global_ordinal_type gblColInds[], const local_ordinal_type numGblColInds) |
Like insertGlobalIndices(), but with column Map filtering. More... | |
void | insertGlobalIndicesIntoNonownedRows (const global_ordinal_type gblRow, const global_ordinal_type gblColInds[], const local_ordinal_type numGblColInds) |
Implementation of insertGlobalIndices for nonowned rows. More... | |
static const bool | useAtomicUpdatesByDefault |
Whether transformLocalValues should use atomic updates by default. More... | |
Graph data structures (packed and unpacked storage). | |
typedef Kokkos::View< size_t *, Kokkos::LayoutLeft, device_type >::HostMirror | num_row_entries_type |
Row offsets for "1-D" storage. More... | |
num_row_entries_type | k_numRowEntries_ |
The number of local entries in each locally owned row. More... | |
offset_device_view_type | k_offRankOffsets_ |
The offsets for off-rank entries. More... | |
Methods implemented by subclasses and used by doTransfer(). | |
The doTransfer() method uses the subclass' implementations of these methods to implement data transfer. Subclasses of DistObject must implement these methods. This is an instance of the Template Method Pattern. ("Template" here doesn't mean "C++ template"; it means "pattern with holes that are filled in by the subclass' method implementations.") | |
virtual void | copyAndPermute (const SrcDistObject &source, const size_t numSameIDs, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &permuteToLIDs, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &permuteFromLIDs, const CombineMode CM) |
Perform copies and permutations that are local to the calling (MPI) process. More... | |
virtual void | copyAndPermute (const SrcDistObject &source, const size_t numSameIDs, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &permuteToLIDs, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &permuteFromLIDs, const CombineMode CM, const execution_space &space) |
Same as copyAndPermute, but do operations in space . More... | |
virtual void | packAndPrepare (const SrcDistObject &source, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &exportLIDs, Kokkos::DualView< packet_type *, buffer_device_type > &exports, Kokkos::DualView< size_t *, buffer_device_type > numPacketsPerLID, size_t &constantNumPackets) |
Pack data and metadata for communication (sends). More... | |
virtual void | packAndPrepare (const SrcDistObject &source, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &exportLIDs, Kokkos::DualView< packet_type *, buffer_device_type > &exports, Kokkos::DualView< size_t *, buffer_device_type > numPacketsPerLID, size_t &constantNumPackets, const execution_space &space) |
Same as packAndPrepare, but in an execution space instance. More... | |
virtual void | unpackAndCombine (const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &importLIDs, Kokkos::DualView< packet_type *, buffer_device_type > imports, Kokkos::DualView< size_t *, buffer_device_type > numPacketsPerLID, const size_t constantNumPackets, const CombineMode combineMode) |
Perform any unpacking and combining after communication. More... | |
virtual void | unpackAndCombine (const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &importLIDs, Kokkos::DualView< packet_type *, buffer_device_type > imports, Kokkos::DualView< size_t *, buffer_device_type > numPacketsPerLID, const size_t constantNumPackets, const CombineMode combineMode, const execution_space &space) |
std::unique_ptr< std::string > | createPrefix (const char className[], const char methodName[]) const |
virtual bool | reallocImportsIfNeeded (const size_t newSize, const bool verbose, const std::string *prefix, const bool remoteLIDsContiguous=false, const CombineMode CM=INSERT) |
Reallocate imports_ if needed. More... | |
Teuchos::RCP< const map_type > | map_ |
The Map over which this object is distributed. More... | |
Kokkos::DualView< packet_type *, buffer_device_type > | imports_ |
Buffer into which packed data are imported (received from other processes). More... | |
Kokkos::DualView< size_t *, buffer_device_type > | numImportPacketsPerLID_ |
Number of packets to receive for each receive operation. More... | |
Kokkos::DualView< packet_type *, buffer_device_type > | exports_ |
Buffer from which packed data are exported (sent to other processes). More... | |
Kokkos::DualView< size_t *, buffer_device_type > | numExportPacketsPerLID_ |
Number of packets to send for each send operation. More... | |
Collective methods for changing the graph's global state | |
void | endAssembly () |
Migrates data to the owned mode. More... | |
void | endAssembly (const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap) |
void | beginAssembly () |
Activates the owned+shared mode for assembly. More... | |
void | fillComplete (const Teuchos::RCP< const map_type > &ownedDomainMap, const Teuchos::RCP< const map_type > &ownedRangeMap, const Teuchos::RCP< Teuchos::ParameterList > &=Teuchos::null) |
Tell the graph that you are done changing its structure. More... | |
void | fillComplete (const Teuchos::RCP< Teuchos::ParameterList > &=Teuchos::null) |
Tell the graph that you are done changing its structure; set default domain and range Maps. More... | |
void | switchActiveCrsGraph () |
Switches which CrsGraph is active (without migrating data) More... | |
A distributed graph accessed by rows (adjacency lists) and stored sparsely.
LocalOrdinal | The type of local indices. See the documentation of Map for requirements. |
GlobalOrdinal | The type of global indices. See the documentation of Map for requirements. |
Node | The Kokkos Node type. See the documentation of Map for requirements. |
This class implements a distributed-memory parallel sparse graph. It provides access by rows to the elements of the graph, as if the local data were stored in compressed sparse row format (adjacency lists, in graph terms). (Implementations are not required to store the data in this way internally.) This class has an interface like that of Epetra_CrsGraph, but also allows insertion of data into nonowned rows, much like Epetra_FECrsGraph.
Note on some versions of the constructors: consturctors appear in two fashions: one that accepts only one (optional) domainMap (let's call it V1) and one that accepts two domainMaps (let's call it V2). In V1, the input domainMap will be used for both owned and owned+shared graphs. In this case, you should provide a map that works for the owned graph (since that's the graph you will use in mat-vec and mat-mat produts, which will be checked). The domain map for the owned+shared graph is usually only needed to build the colMap of the owned+shared graph.
Whether you need V2 or are ok with V1 depends on what your "owned+shared" maps contain.
If you partition a mesh by node (N), then your owned+shared maps should contain all the nodes that are in the patch of one of the owned nodes, which is precisely what the colMap of the owned+shared graph should contain. On the other hand, if you partition the mesh by cell (C), then your owned+shared maps should contain all nodes belonging to one of the owned elements. Such map does NOT necessarily contain all the GID of all the nodes connected to one of the owned nodes (which is what the colMap should contain). In this case, you are not likely to have a colMap available, and you'll rely on Tpetra to build one for you once the graph is filled.
If you do not provide a valid owned+shared colMap, then Tpetra creates one for you, which is used for both the owned+shared and owned graphs. When doing this, Tpetra guarantees that the domain map of the owned+shared graph is "locally fitted" to its colMap (see Tpetra::Map documentation for the meaning of 'locally fitted'). If you use V1, then the domain map is the owned dofs only, which means that the non-owned GIDs will appear in the colMap in an order that is out of your control.
Now, if you partition by Cell (C), then you don't have a colMap when you create the graph, but only a owned+shared one. If you use version V1 of the consturctor, the Local ID of the shared dofs in the graph's colMap is likely to NOT be the same as in your owned+shared map, since the colMap creation only guarantees that the input domainMap (which should contian owned dofs only) is going to be locally fitted in the colMap. All other GIDs will appear in an order that you can't control.
On the other hand, if you use V2, then you are guaranteed that the owend+shared domain map you provide will be locally fitted to the graph colMap.
This difference is important when you do local assembly with a FECrsMatrix: if the Local IDs of the dofs in your owned+shared maps is THE SAME as in the graph's col map, then you can do assembly using local ids. Otherwise, you need to have access to the GIDs of the dofs, extract the colMap from the matrix, and convert GIDs into LIDs ACCORDINGLY TO THE COL MAP.
Notice that if your mesh is partitioned by node (N) OR you provide a valid colMap to the graph's constructor, then using V1 is likely ok for you.
For more details, see GitHub issue #7455
Definition at line 92 of file Tpetra_FECrsGraph_decl.hpp.
typedef CrsGraph<LocalOrdinal, GlobalOrdinal, Node> Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::crs_graph_type |
Parent class.
Definition at line 102 of file Tpetra_FECrsGraph_decl.hpp.
typedef LocalOrdinal Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::local_ordinal_type |
This class' first template parameter; the type of local indices.
Definition at line 105 of file Tpetra_FECrsGraph_decl.hpp.
typedef GlobalOrdinal Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::global_ordinal_type |
This class' second template parameter; the type of global indices.
Definition at line 107 of file Tpetra_FECrsGraph_decl.hpp.
typedef Node Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::node_type |
This class' Kokkos Node type.
Definition at line 109 of file Tpetra_FECrsGraph_decl.hpp.
typedef CrsGraph<LocalOrdinal, GlobalOrdinal, Node>::device_type Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::device_type |
The Kokkos device type.
Definition at line 112 of file Tpetra_FECrsGraph_decl.hpp.
typedef CrsGraph<LocalOrdinal, GlobalOrdinal, Node>::execution_space Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::execution_space |
The Kokkos execution space.
Definition at line 114 of file Tpetra_FECrsGraph_decl.hpp.
typedef CrsGraph<LocalOrdinal, GlobalOrdinal, Node>::local_graph_device_type Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::local_graph_device_type |
The type of the part of the sparse graph on each MPI process.
Definition at line 117 of file Tpetra_FECrsGraph_decl.hpp.
using Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::map_type = ::Tpetra::Map<LocalOrdinal, GlobalOrdinal, Node> |
The Map specialization used by this class.
Definition at line 120 of file Tpetra_FECrsGraph_decl.hpp.
using Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::import_type = ::Tpetra::Import<LocalOrdinal, GlobalOrdinal, Node> |
The Import specialization used by this class.
Definition at line 122 of file Tpetra_FECrsGraph_decl.hpp.
using Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::export_type = ::Tpetra::Export<LocalOrdinal, GlobalOrdinal, Node> |
The Export specialization used by this class.
Definition at line 124 of file Tpetra_FECrsGraph_decl.hpp.
|
inherited |
The type of the part of the sparse graph on each MPI process.
Definition at line 229 of file Tpetra_CrsGraph_decl.hpp.
|
inherited |
The Kokkos::View type for views of local ordinals on device and host.
Definition at line 260 of file Tpetra_CrsGraph_decl.hpp.
|
inherited |
The Kokkos::View type for views of global ordinals on device and host.
Definition at line 268 of file Tpetra_CrsGraph_decl.hpp.
|
inherited |
Kokkos::Device specialization for communication buffers.
See #1088 for why this is not just device_type::device_type
.
Definition at line 1174 of file Tpetra_CrsGraph_decl.hpp.
|
inherited |
Type of each entry of the DistObject communication buffer.
Definition at line 1176 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Row offsets for "1-D" storage.
This is only allocated if "1-D" storage is active. In that case, if beg = k_rowPtrs_(i_lcl) and end = k_rowPtrs_(i_lcl+1) for local row index i_lcl, then
Only the first k_numRowEntries_(i_lcl) of these entries are actual valid column indices. Any remaining entries are "extra space." If the graph's storage is packed, then there is no extra space, and the k_numRowEntries_ array is invalid.
If it is allocated, k_rowPtrs_ has length getLocalNumRows()+1. The k_numRowEntries_ array has has length getLocalNumRows(), again if it is allocated. The type of k_numRowEntries_ (see below).
This View gets used only on host. However, making this literally a host View (of Kokkos::HostSpace) causes inexplicable test failures only on CUDA. Thus, I left it as a HostMirror, which means (given Trilinos' current UVM requirement) that it will be a UVM allocation.
Definition at line 2430 of file Tpetra_CrsGraph_decl.hpp.
Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::FECrsGraph | ( | const Teuchos::RCP< const map_type > & | ownedRowMap, |
const Teuchos::RCP< const map_type > & | ownedPlusSharedRowMap, | ||
const size_t | maxNumEntriesPerRow, | ||
const Teuchos::RCP< const import_type > & | ownedPlusSharedToOwnedimporter = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | domainMap = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | ownedRangeMap = Teuchos::null , |
||
const Teuchos::RCP< Teuchos::ParameterList > & | params = Teuchos::null |
||
) |
Constructorfor globally-indexed assembly specifying a single upper bound for the number of entries in all rows on the calling process.
ownedRowMap | [in] Distribution of rows of the owned graph. |
ownedPlusSharedRowMap | [in] ownedMap plus the list of shared rows to which off-processor insertion is allowed |
maxNumEntriesPerRow | [in] Maximum number of graph entries per row. You cannot exceed this number of entries in any row. |
ownedPlusSharedToOwnedimporter | [in] Optional importer between the ownedMap and ownedPlusSharedMap This will be calculated by FECrsGraph if it is not provided |
domainMap | [in] Optional domain map for both owned and owned+shared graphs. If this is null, then ownedMap will be used as domain map for both graphs. |
ownedRangeMap | [in] Optional range map for the owned graph. If this is not provided, then ownedMap will be used as range map for the owned graph. |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 24 of file Tpetra_FECrsGraph_def.hpp.
Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::FECrsGraph | ( | const Teuchos::RCP< const map_type > & | ownedRowMap, |
const Teuchos::RCP< const map_type > & | ownedPlusSharedRowMap, | ||
const size_t | maxNumEntriesPerRow, | ||
const Teuchos::RCP< const map_type > & | ownedPlusSharedDomainMap, | ||
const Teuchos::RCP< const import_type > & | ownedPlusSharedToOwnedimporter = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | ownedDomainMap = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | ownedRangeMap = Teuchos::null , |
||
const Teuchos::RCP< Teuchos::ParameterList > & | params = Teuchos::null |
||
) |
Constructorfor globally-indexed assembly specifying a single upper bound for the number of entries in all rows on the calling process.
ownedRowMap | [in] Distribution of rows of the owned graph. |
ownedPlusSharedRowMap | [in] ownedMap plus the list of shared rows to which off-processor insertion is allowed |
maxNumEntriesPerRow | [in] Maximum number of graph entries per row. You cannot exceed this number of entries in any row. |
ownedPlusSharedDomainMap | [in] Domain map for the owned+shared graph. If this is null, then ownedPlusSharedRowMap will be used as domain map for the owned+shared graph. |
ownedPlusSharedToOwnedimporter | [in] Optional importer between the ownedMap and ownedPlusSharedMap This will be calculated by FECrsGraph if it is not provided |
ownedDomainMap | [in] Optional domain map for the owned graph. If this is null, then ownedMap will be used as domain map for the owned graph. |
ownedRangeMap | [in] Optional range map for the owned graph. If this is not provided, then ownedMap will be used as range map for the owned graph. |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 41 of file Tpetra_FECrsGraph_def.hpp.
Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::FECrsGraph | ( | const Teuchos::RCP< const map_type > & | ownedRowMap, |
const Teuchos::RCP< const map_type > & | ownedPlusSharedRowMap, | ||
const Kokkos::DualView< const size_t *, device_type > & | numEntPerRow, | ||
const Teuchos::RCP< const import_type > & | ownedPlusSharedToOwnedimporter = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | domainMap = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | ownedRangeMap = Teuchos::null , |
||
const Teuchos::RCP< Teuchos::ParameterList > & | params = Teuchos::null |
||
) |
Constructor for globally-indexed assembly specifying a (possibly different) upper bound for the number of entries in each row.
ownedRowMap | [in] Distribution of rows of the owned graph. |
ownedPlusSharedRowMap | [in] ownedMap plus the list of shared rows to which off-processor insertion is allowed |
numEntPerRow | [in] Maximum number of graph entries to allocate for each row. You cannot exceed the allocated number of entries for any row. |
ownedPlusSharedToOwnedimporter | [in] Optional importer between the ownedMap and ownedPlusSharedMap This will be calculated by FECrsGraph if it is not provided |
domainMap | [in] Optional domain map for both owned and owned+shared graphs. If this is null, then ownedMap will be used as domain map for both graphs. |
ownedRangeMap | [in] Optional range map for the owned graph. If this is not provided, then ownedMap will be used as range map for the owned graph. |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 61 of file Tpetra_FECrsGraph_def.hpp.
Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::FECrsGraph | ( | const Teuchos::RCP< const map_type > & | ownedRowMap, |
const Teuchos::RCP< const map_type > & | ownedPlusSharedRowMap, | ||
const Kokkos::DualView< const size_t *, device_type > & | numEntPerRow, | ||
const Teuchos::RCP< const map_type > & | ownedPlusSharedDomainMap, | ||
const Teuchos::RCP< const import_type > & | ownedPlusSharedToOwnedimporter = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | ownedDomainMap = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | ownedRangeMap = Teuchos::null , |
||
const Teuchos::RCP< Teuchos::ParameterList > & | params = Teuchos::null |
||
) |
Constructor for globally-indexed assembly specifying a (possibly different) upper bound for the number of entries in each row.
ownedRowMap | [in] Distribution of rows of the owned graph. |
ownedPlusSharedRowMap | [in] ownedMap plus the list of shared rows to which off-processor insertion is allowed |
numEntPerRow | [in] Maximum number of graph entries to allocate for each row. You cannot exceed the allocated number of entries for any row. |
ownedPlusSharedDomainMap | [in] Domain map for the owned+shared graph. If this is null, then ownedPlusSharedRowMap will be used in the call to endFill() |
ownedPlusSharedToOwnedimporter | [in] Optional importer between the ownedMap and ownedPlusSharedMap This will be calculated by FECrsGraph if it is not provided |
ownedDomainMap | [in] Optional domain map for the owned graph. If this is not provided, then ownedMap will be used as domain map for the owned graph. |
ownedRangeMap | [in] Optional range map for the owned graph. If this is not provided, then ownedMap will be used as range map for the owned graph. |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 77 of file Tpetra_FECrsGraph_def.hpp.
Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::FECrsGraph | ( | const Teuchos::RCP< const map_type > & | ownedRowMap, |
const Teuchos::RCP< const map_type > & | ownedPlusSharedRowMap, | ||
const Teuchos::RCP< const map_type > & | ownedPlusSharedColMap, | ||
const size_t | maxNumEntriesPerRow, | ||
const Teuchos::RCP< const import_type > & | ownedPlusSharedToOwnedimporter = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | domainMap = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | ownedRangeMap = Teuchos::null , |
||
const Teuchos::RCP< Teuchos::ParameterList > & | params = Teuchos::null |
||
) |
Constructor for locally-indexed assembly specifying a single upper bound for the number of entries in all rows on the calling process.
ownedRowMap | [in] Distribution of rows of the owned graph. |
ownedPlusSharedRowMap | [in] ownedMap plus the list of shared rows to which off-processor insertion is allowed |
ownedPlusSharedColMap | [in] list of owned and shared columns into which assertion is allowed. |
maxNumEntriesPerRow | [in] Maximum number of graph entries per row. You cannot exceed this number of entries in any row. |
ownedPlusSharedToOwnedimporter | [in] Optional importer between the ownedMap and ownedPlusSharedMap This will be calculated by FECrsGraph if it is not provided |
domainMap | [in] Optional domain map for the both owned and owned+shared graphs. If this is not provided, then ownedMap will be used as domain map for both graphs. |
ownedRangeMap | [in] Optional range map for the owned graph. If this is not provided, then ownedMap will be used as range map for the owned graph |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 97 of file Tpetra_FECrsGraph_def.hpp.
Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::FECrsGraph | ( | const Teuchos::RCP< const map_type > & | ownedRowMap, |
const Teuchos::RCP< const map_type > & | ownedPlusSharedRowMap, | ||
const Teuchos::RCP< const map_type > & | ownedPlusSharedColMap, | ||
const size_t | maxNumEntriesPerRow, | ||
const Teuchos::RCP< const map_type > & | ownedPlusSharedDomainMap, | ||
const Teuchos::RCP< const import_type > & | ownedPlusSharedToOwnedimporter = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | ownedDomainMap = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | ownedRangeMap = Teuchos::null , |
||
const Teuchos::RCP< Teuchos::ParameterList > & | params = Teuchos::null |
||
) |
Constructor for locally-indexed assembly specifying a single upper bound for the number of entries in all rows on the calling process.
ownedRowMap | [in] Distribution of rows of the owned graph. |
ownedPlusSharedRowMap | [in] ownedMap plus the list of shared rows to which off-processor insertion is allowed |
ownedPlusSharedColMap | [in] list of owned and shared columns into which assertion is allowed. |
maxNumEntriesPerRow | [in] Maximum number of graph entries per row. You cannot exceed this number of entries in any row. |
ownedPlusSharedDomainMap | [in] Domain map for the owned+shared graph. If this is null, then ownedPlusSharedRowMap will be used as domain map for the owned+shared graph. |
ownedPlusSharedToOwnedimporter | [in] Optional importer between the ownedMap and ownedPlusSharedMap This will be calculated by FECrsGraph if it is not provided |
ownedDomainMap | [in] Optional domain map for the owned graph. If this is not provided, then ownedMap will be used as domain map for the owned graph. |
ownedRangeMap | [in] Optional range map for the owned graph. If this is not provided, then ownedMap will be used as range map for the owned graph. |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 114 of file Tpetra_FECrsGraph_def.hpp.
Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::FECrsGraph | ( | const Teuchos::RCP< const map_type > & | ownedRowMap, |
const Teuchos::RCP< const map_type > & | ownedPlusSharedRowMap, | ||
const Teuchos::RCP< const map_type > & | ownedPlusSharedColMap, | ||
const Kokkos::DualView< const size_t *, device_type > & | numEntPerRow, | ||
const Teuchos::RCP< const import_type > & | ownedPlusSharedToOwnedimporter = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | domainMap = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | ownedRangeMap = Teuchos::null , |
||
const Teuchos::RCP< Teuchos::ParameterList > & | params = Teuchos::null |
||
) |
Constructor for locally-indexed assembly specifying a (possibly different) upper bound for the number of entries in each row.
ownedRowMap | [in] Distribution of rows of the owned graph. |
ownedPlusSharedRowMap | [in] ownedMap plus the list of shared rows to which off-processor insertion is allowed |
numEntPerRow | [in] Maximum number of graph entries to allocate for each row. You cannot exceed the allocated number of entries for any row. |
ownedPlusSharedToOwnedimporter | [in] Optional importer between the ownedMap and ownedPlusSharedMap This will be calculated by FECrsGraph if it is not provided |
domainMap | [in] Optional domain map for both the owned and owned+shared graphs. If this is not provided, then ownedMap will be used as domain map for both graphs. |
ownedRangeMap | [in] Optional range map for the owned graph. If this is not provided, then ownedMap will be used as range map for the owned graph |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 134 of file Tpetra_FECrsGraph_def.hpp.
Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::FECrsGraph | ( | const Teuchos::RCP< const map_type > & | ownedRowMap, |
const Teuchos::RCP< const map_type > & | ownedPlusSharedRowMap, | ||
const Teuchos::RCP< const map_type > & | ownedPlusSharedColMap, | ||
const Kokkos::DualView< const size_t *, device_type > & | numEntPerRow, | ||
const Teuchos::RCP< const map_type > & | ownedPlusSharedDomainMap, | ||
const Teuchos::RCP< const import_type > & | ownedPlusSharedToOwnedimporter = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | ownedDomainMap = Teuchos::null , |
||
const Teuchos::RCP< const map_type > & | ownedRangeMap = Teuchos::null , |
||
const Teuchos::RCP< Teuchos::ParameterList > & | params = Teuchos::null |
||
) |
Constructor for locally-indexed assembly specifying a (possibly different) upper bound for the number of entries in each row.
ownedRowMap | [in] Distribution of rows of the owned graph. |
ownedPlusSharedRowMap | [in] ownedMap plus the list of shared rows to which off-processor insertion is allowed |
numEntPerRow | [in] Maximum number of graph entries to allocate for each row. You cannot exceed the allocated number of entries for any row. |
ownedPlusSharedDomainMap | [in] Domain map for the owned+shared graph. If this is null, then ownedPlusSharedRowMap |
ownedPlusSharedToOwnedimporter | [in] Optional importer between the ownedMap and ownedPlusSharedMap This will be calculated by FECrsGraph if it is not provided |
ownedDomainMap | [in] Optional domain map for the owned graph. If this is not provided, then ownedMap will be used as domain map for the owned graph. |
ownedRangeMap | [in] Optional range map for the owned graph. If this is not provided, then ownedMap will be used as range map for the owned graph. |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 151 of file Tpetra_FECrsGraph_def.hpp.
|
delete |
Copy constructor (forbidden).
|
delete |
Move constructor (forbidden).
|
virtualdefault |
Destructor (virtual for memory safety of derived classes).
=delete
declarations for copy construction, move construction, copy assignment, and move assignment.
|
delete |
Copy assignment (forbidden).
|
delete |
Move assignment (forbidden).
|
override |
Default parameter list suitable for validation.
Definition at line 413 of file Tpetra_FECrsGraph_def.hpp.
void Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::endAssembly | ( | ) |
Migrates data to the owned mode.
Definition at line 385 of file Tpetra_FECrsGraph_def.hpp.
void Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::beginAssembly | ( | ) |
Activates the owned+shared mode for assembly.
Definition at line 373 of file Tpetra_FECrsGraph_def.hpp.
|
inline |
Tell the graph that you are done changing its structure.
This tells the graph to optimize its data structures for computational kernels, and to prepare (MPI) communication patterns.
Off-process indices are distributed (via globalAssemble()), indices are sorted, redundant indices are eliminated, and global indices are transformed to local indices.
This method must be called collectively (that is, like any MPI collective) over all processes in the graph's communicator.
isFillActive() && ! isFillComplete()
! isFillActive() && isFillComplete()
ownedDomainMap | [in] The graph's domain Map. MUST be one to one! |
ownedRangeMap | [in] The graph's range Map. MUST be one to one! May be, but need not be, the same as the domain Map. |
params | [in/out] List of parameters controlling this method's behavior. See below for valid parameters. |
List of valid parameters in params
:
bool
): Default is false. If true, then isStorageOptimized() returns true after this method finishes. See isStorageOptimized() for consequences. Definition at line 481 of file Tpetra_FECrsGraph_decl.hpp.
|
inline |
Tell the graph that you are done changing its structure; set default domain and range Maps.
See above three-argument version of fillComplete for full documentation. If the graph does not yet have domain and range Maps (i.e., if fillComplete has not yet been called on this graph at least once), then this method uses the graph's row Map (result of this->getRowMap()) as both the domain Map and the range Map. Otherwise, this method uses the graph's existing domain and range Maps.
This method must be called collectively (that is, like any MPI collective) over all processes in the graph's communicator.
params | [in/out] List of parameters controlling this method's behavior. See documentation of the three-argument version of fillComplete (above) for valid parameters. |
Definition at line 517 of file Tpetra_FECrsGraph_decl.hpp.
void Tpetra::FECrsGraph< LocalOrdinal, GlobalOrdinal, Node >::switchActiveCrsGraph | ( | ) |
Switches which CrsGraph is active (without migrating data)
Definition at line 298 of file Tpetra_FECrsGraph_def.hpp.
|
protected |
Insert global indices, using an input local row index.
rowInfo | [in] Result of getRowInfo() on the row in which to insert. |
inputGblColInds | [in] Input global column indices. |
numInputInds | [in] The number of input global column indices. |
Definition at line 424 of file Tpetra_FECrsGraph_def.hpp.
|
protected |
Insert global indices, using an input RowInfo.
rowInfo | [in] Result of getRowInfo() on the row in which to insert. |
inputGblColInds | [in] Input global column indices. |
numInputInds | [in] The number of input global column indices. |
Definition at line 440 of file Tpetra_FECrsGraph_def.hpp.
|
inherited |
Create a cloned CrsGraph for a different Node type.
This method creates a new CrsGraph on a specified Kokkos Node type, with all of the entries of this CrsGraph object.
node2 | [in] Kokkos Node instance for constructing the clone CrsGraph and its constituent objects. |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. See the list below for valid options. |
Parameters accepted by this method:
true
, creates the clone with a static allocation profile. If false, a dynamic allocation profile is used.true
, fills clone using this graph's column map and local indices (requires that this graph have a column map.) If false, fills clone using global indices and does not provide a column map. By default, will use local indices only if this graph is using local indices.true
, calls fillComplete() on the cloned CrsGraph object, with parameters from params
sublist "CrsGraph". The domain map and range maps passed to fillComplete() are those of the map being cloned, if they exist. Otherwise, the row map is used. True if and only if CrsGraph
is identical to this CrsGraphThis performs exact matches on objects with in the graphs. That is, internal data structures such as arrays must match exactly in both content and order. This is not performing any sort of isomorphic search.
graph | [in] a CrsGraph to compare against this one. |
Definition at line 7417 of file Tpetra_CrsGraph_def.hpp.
|
overrideinherited |
Set the given list of parameters (must be nonnull).
Definition at line 816 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Insert global indices into the graph.
globalRow
is a valid index in the row Map. It need not be owned by the calling process. isLocallyIndexed() == false
isStorageOptimized() == false
indicesAreAllocated() == true
isGloballyIndexed() == true
If globalRow
does not belong to the graph on this process, then it will be communicated to the appropriate process when globalAssemble() is called. (That method will be called automatically during the next call to fillComplete().) Otherwise, the entries will be inserted into the part of the graph owned by the calling process.
If the graph row already contains entries at the indices corresponding to values in indices
, then the redundant indices will be eliminated. This may happen either at insertion or during the next call to fillComplete().
Definition at line 2581 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Epetra compatibility version of insertGlobalIndices (see above) that takes input as a raw pointer, rather than Teuchos::ArrayView.
Arguments are the same and in the same order as Epetra_CrsGraph::InsertGlobalIndices.
Definition at line 2504 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Insert local indices into the graph.
localRow
is a local row belonging to the graph on this process. isGloballyIndexed() == false
isStorageOptimized() == false
hasColMap() == true
indicesAreAllocated() == true
isLocallyIndexed() == true
indices
, then the redundant indices will be eliminated; this may happen at insertion or during the next call to fillComplete(). Definition at line 2423 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Epetra compatibility version of insertLocalIndices (see above) that takes input as a raw pointer, rather than Teuchos::ArrayView.
Arguments are the same and in the same order as Epetra_CrsGraph::InsertMyIndices.
Definition at line 2492 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Remove all graph indices from the specified local row.
localRow
is a local row of this graph. isGloballyIndexed() == false
isStorageOptimized() == false
getNumEntriesInLocalRow(localRow) == 0
indicesAreAllocated() == true
isLocallyIndexed() == true
Definition at line 2675 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Communicate nonlocal contributions to other processes.
This method is called automatically by fillComplete(). Most users do not need to call this themselves.
This method must be called collectively (that is, like any MPI collective) over all processes in the graph's communicator.
Definition at line 2899 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Resume fill operations.
After calling fillComplete(), resumeFill() must be called before initiating any changes to the graph.
resumeFill() may be called repeatedly.
isFillActive() == true
isFillComplete() == false
This method must be called collectively (that is, like any MPI collective) over all processes in the graph's communicator.
Definition at line 3117 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Perform a fillComplete on a graph that already has data, via setAllIndices().
The graph must already have filled local 1-D storage. If the graph has been constructed in any other way, this method will throw an exception. This routine is needed to support other Trilinos packages and should not be called by ordinary users.
This method must be called collectively (that is, like any MPI collective) over all processes in the graph's communicator.
domainMap | [in] The graph's domain Map. MUST be one to one! |
rangeMap | [in] The graph's range Map. MUST be one to one! May be, but need not be, the same as the domain Map. |
importer | [in] Import from the graph's domain Map to its column Map. If no Import is necessary (i.e., if the domain and column Maps are the same, in the sense of Tpetra::Map::isSameAs), then this may be Teuchos::null. |
exporter | [in] Export from the graph's row Map to its range Map. If no Export is necessary (i.e., if the row and range Maps are the same, in the sense of Tpetra::Map::isSameAs), then this may be Teuchos::null. |
params | [in/out] List of parameters controlling this method's behavior. |
Definition at line 3381 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the communicator.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 1128 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the Map that describes the row distribution in this graph.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 878 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the Map that describes the column distribution in this graph.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 886 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the Map associated with the domain of this graph.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 894 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the Map associated with the domain of this graph.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 902 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the importer associated with this graph.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 910 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the exporter associated with this graph.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 918 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the number of global rows in the graph.
Undefined if isFillActive().
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 827 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the number of global columns in the graph.
Returns the number of entries in the domain map of the matrix. Undefined if isFillActive().
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 835 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the number of graph rows owned on the calling node.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 849 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the number of columns connected to the locally owned rows of this graph.
Throws std::runtime_error if hasColMap() == false
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 860 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the index base for global indices for this graph.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 1136 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the global number of entries in the graph.
Undefined if isFillActive ().
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 950 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
The local number of entries in the graph.
"Local" means "local to the calling (MPI) process."
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 965 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Returns the current number of entries on this node in the specified global row.
Returns OrdinalTraits<size_t>::invalid() if the specified global row does not belong to this graph.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 2170 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Get the number of entries in the given row (local index).
Teuchos::OrdinalTraits<size_t>::invalid()
. Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 2185 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
The local number of indices allocated for the graph, over all rows on the calling (MPI) process.
"Local" means "local to the calling (MPI) process."
This is the allocation available to the user. Actual allocation may be larger, for example, after calling fillComplete(). Thus, this does not necessarily reflect the graph's memory consumption.
Tpetra::Details::OrdinalTraits<size_t>::invalid()
. Definition at line 1083 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Current number of allocated entries in the given row on the calling (MPI) process, using a global row index.
Tpetra::Details::OrdinalTraits<size_t>::invalid()
. Definition at line 2200 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Current number of allocated entries in the given row on the calling (MPI) process, using a local row index.
Tpetra::Details::OrdinalTraits<size_t>::invalid()
. Definition at line 2215 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Maximum number of entries in any row of the graph, over all processes in the graph's communicator.
! isFillActive()
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 1028 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Maximum number of entries in any row of the graph, on this process.
! isFillActive()
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 1042 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Whether the graph has a column Map.
A CrsGraph has a column Map either because it was given to its constructor, or because it was constructed in fillComplete(). Calling fillComplete() always makes a column Map if the graph does not already have one.
A column Map lets the graph
The latter is mainly useful for a graph associated with a CrsMatrix.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 926 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Whether the graph's column indices are stored as local indices.
Weird quirk inherited from Epetra: ! isLocallyIndexed() && ! isGloballyIndexed()
means that there are no graph entries on the calling process. Please don't rely on this behavior, but note that it's possible.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 1067 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Whether the graph's column indices are stored as global indices.
Weird quirk inherited from Epetra: ! isLocallyIndexed() && ! isGloballyIndexed()
means that there are no graph entries on the calling process. Please don't rely on this behavior, but note that it's possible.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 1075 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Whether fillComplete() has been called and the graph is in compute mode.
Implements Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 1050 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Whether resumeFill() has been called and the graph is in edit mode.
Definition at line 1058 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Whether graph indices in all rows are known to be sorted.
A fill-complete graph is always sorted, as is a newly constructed graph. A graph is sorted immediately after calling resumeFill(), but any changes to the graph may result in the sorting status becoming unknown (and therefore, presumed unsorted).
Definition at line 1152 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Returns true
if storage has been optimized.
Optimized storage means that the allocation of each row is equal to the number of entries. The effect is that a pass through the matrix, i.e., during a mat-vec, requires minimal memory traffic. One limitation of optimized storage is that no new indices can be added to the graph.
Definition at line 934 of file Tpetra_CrsGraph_def.hpp.
|
overrideinherited |
Get a copy of the given row, using global indices.
gblRow | [in] Global index of the row. |
gblColInds | [out] On output: Global column indices. |
numColInds | [out] Number of indices returned. |
Definition at line 2309 of file Tpetra_CrsGraph_def.hpp.
|
pure virtualinherited |
Get a copy of the global column indices in a given row of the graph.
Given the global index of a row of the graph, get a copy of all the global column indices in that row that the calling process stores.
gblRow | [in] Global index of the row. |
gblColInds | [in/out] On output: All the global column indices in that row on the calling process. |
numColInds | [out] Number of indices in the row on the calling process. |
getRowMap()->isNodeGlobalElement(gblRow) is true
.
gblColInds.size() >= getNumEntriesInGlobalRow(gblRow)
is true
.
|
overrideinherited |
Get a copy of the given row, using local indices.
lclRow | [in] Local index of the row. |
lclColInds | [out] On output: Local column indices. |
numColInds | [out] Number of indices returned. |
hasColMap()
Definition at line 2263 of file Tpetra_CrsGraph_def.hpp.
|
pure virtualinherited |
Get a copy of the local column indices in a given row of the graph.
Given the local index of a row of the graph, get a copy of all the local column indices in that row that the calling process stores.
lclRow | [in] Local index of the row. |
lclColInds | [in/out] On output: All the local column indices in that row on the calling process. |
numColInds | [out] Number of indices in the row on the calling process. |
hasColMap()
is true
. getRowMap()->isNodeLocalElement(lclRow) is true
.
lclColInds.size() >= getNumEntriesInLocalRow(lclRow)
is true
.
|
overrideinherited |
Get a const view of the given global row's global column indices.
gblRow | [in] Global index of the row. |
gblColInds | [out] Global column indices in the row. If the given row is not a valid row index on the calling process, then the result has no entries (its size is zero). |
! isLocallyIndexed()
gblColInds.size() == getNumEntriesInGlobalRow(gblRow)
Definition at line 2385 of file Tpetra_CrsGraph_def.hpp.
|
pure virtualinherited |
Get a const, non-persisting view of the given global row's global column indices, as a Teuchos::ArrayView.
gblRow | [in] Global index of the row. |
gblColInds | [out] Global column indices in the row. If the given row is not a valid row index on the calling process, then the result has no entries (its size is zero). |
! isLocallyIndexed()
gblColInds.size() == getNumEntriesInGlobalRow(gblRow)
Subclasses are expected to implement this method. We would have made this method pure virtual, but that would have broken backwards compatibility, since we added the method at least one major release after introducing this class.
|
overridevirtualinherited |
Whether this class implements getLocalRowView() and getGlobalRowView() (it does).
Reimplemented from Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 6662 of file Tpetra_CrsGraph_def.hpp.
|
overrideinherited |
Get a const view of the given local row's local column indices.
lclRow | [in] Local index of the row. |
lclColInds | [out] Local column indices in the row. If the given row is not a valid row index on the calling process, then the result has no entries (its size is zero). |
! isGloballyIndexed()
lclColInds.size() == getNumEntriesInLocalRow(lclRow)
Definition at line 2346 of file Tpetra_CrsGraph_def.hpp.
|
pure virtualinherited |
Get a constant, nonpersisting, locally indexed view of the given row of the graph.
The returned views of the column indices are not guaranteed to persist beyond the lifetime of this
. Furthermore, some RowGraph implementations allow changing the values, or the indices and values. Any such changes invalidate the returned views.
This method only gets the entries in the given row that are stored on the calling process. Note that if the graph has an overlapping row Map, it is possible that the calling process does not store all the entries in that row.
isLocallyIndexed () && supportsRowViews ()
indices.size () == getNumEntriesInGlobalRow (LocalRow)
lclRow | [in] Local index of the row. |
lclColInds | [out] Local indices of the columns in the row. If the given row is not a valid row index on the calling process, then the result has no entries (its size is zero). |
Subclasses are expected to implement this method. We would have made this method pure virtual, but that would have broken backwards compatibility, since we added the method at least one major release after introducing this class.
|
overridevirtualinherited |
Return a one-line human-readable description of this object.
Reimplemented from Tpetra::DistObject< GlobalOrdinal, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 4635 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Print this object to the given output stream with the given verbosity level.
Reimplemented from Tpetra::DistObject< GlobalOrdinal, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 4658 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Compare the source and target (this) objects for compatibility.
Implements Tpetra::DistObject< GlobalOrdinal, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 4781 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
DistObject copyAndPermute has multiple overloads – use copyAndPermutes for anything we don't override
Definition at line 4793 of file Tpetra_CrsGraph_def.hpp.
|
protectedvirtualinherited |
Perform copies and permutations that are local to the calling (MPI) process.
Subclasses must reimplement this function. Its default implementation does nothing. Note that the <t>target object of the Export or Import, namely *this
, packs the source object's data.
permuteToLIDs.need_sync_host()
, permuteToLIDs.need_sync_device()
, permuteFromLIDs.need_sync_host()
, and permuteFromLIDs.need_sync_device()
are all false.source | [in] On entry, the source object of the Export or Import operation. |
numSameIDs | [in] The number of elements that are the same on the source and target objects. These elements live on the same process in both the source and target objects. |
permuteToLIDs | [in] List of the elements that are permuted. They are listed by their local index (LID) in the destination object. |
permuteFromLIDs | [in] List of the elements that are permuted. They are listed by their local index (LID) in the source object. |
CM | [in] CombineMode to be used during copyAndPermute; may or may not be used by the particular object being called; behavior with respect to CombineMode may differ by object. |
|
protectedvirtualinherited |
Same as copyAndPermute, but do operations in space
.
|
protectedvirtualinherited |
Pack data and metadata for communication (sends).
Subclasses must reimplement this function. Its default implementation does nothing. Note that the <t>target object of the Export or Import, namely *this
, packs the source object's data.
exportLIDs.need_sync_host ()
and exportLIDs.need_sync_device()
are both false.source | [in] Source object for the redistribution. |
exportLIDs | [in] List of the entries (as local IDs in the source object) that Tpetra will send to other processes. |
exports | [out] On exit, the packed data to send. Implementations must reallocate this as needed (prefer reusing the existing allocation if possible), and may modify and/or sync this wherever they like. |
numPacketsPerLID | [out] On exit, the implementation of this method must do one of two things: either set numPacketsPerLID[i] to the number of packets to be packed for exportLIDs[i] and set constantNumPackets to zero, or set constantNumPackets to a nonzero value. If the latter, the implementation must not modify the entries of numPacketsPerLID . If the former, the implementation may sync numPacketsPerLID this wherever it likes, either to host or to device. The allocation belongs to DistObject, not to subclasses; don't be tempted to change this to pass by reference. |
constantNumPackets | [out] On exit, 0 if the number of packets per LID could differ, else (if nonzero) the number of packets per LID (which must be constant). |
|
protectedvirtualinherited |
Same as packAndPrepare, but in an execution space instance.
|
overridevirtualinherited |
< DistObject overloads packAndPrepare. Explicitly use DistObject's packAndPrepare for anything we don't override
Reimplemented from Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 5592 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
< DistObject has overloaded unpackAndCombine, use the DistObject's implementation for anything we don't override.
Definition at line 6035 of file Tpetra_CrsGraph_def.hpp.
|
protectedvirtualinherited |
Perform any unpacking and combining after communication.
Subclasses must reimplement this function. Its default implementation does nothing. Note that the <t>target object of the Export or Import, namely *this
, unpacks the received data into itself, possibly modifying its entries.
importLIDs.need_sync_host ()
and importLIDs.need_sync_device()
are both false.importLIDs | [in] List of the entries (as LIDs in the destination object) we received from other processes. |
imports | [in/out] On input: Buffer of received data to unpack. DistObject promises nothing about where this is sync'd. Implementations may sync this wherever they like, either to host or to device. The allocation belongs to DistObject, not to subclasses; don't be tempted to change this to pass by reference. |
numPacketsPerLID | [in/out] On input: If constantNumPackets is zero, then numPacketsPerLID[i] contains the number of packets imported for importLIDs[i]. DistObject promises nothing about where this is sync'd. Implementations may sync this wherever they like, either to host or to device. The allocation belongs to DistObject, not to subclasses; don't be tempted to change this to pass by reference. |
constantNumPackets | [in] If nonzero, then the number of packets per LID is the same for all entries ("constant") and constantNumPackets is that number. If zero, then numPacketsPerLID[i] is the number of packets to unpack for LID importLIDs[i] . |
combineMode | [in] The CombineMode to use when combining the imported entries with existing entries. |
|
inherited |
Get offsets of the diagonal entries in the graph.
This method helps users optimize Tpetra::CrsMatrix::getLocalDiagCopy and Tpetra::Experimental::BlockCrsMatrix::getLocalDiagCopy, for several calls when the graph's structure does not change. The method fills an array of offsets of the local diagonal entries in the matrix. getLocalDiagCopy uses the offsets to extract the diagonal entries directly, without needing to search for them using Map lookups and search in each row of the graph.
The output array's contents are not defined in any other context other than for use in getLocalDiagCopy. For example, you should not rely on offsets(i)
being the index of the diagonal entry in the views returned by Tpetra::CrsMatrix::getLocalRowView. This may be the case, but it need not be. (For example, we may choose to optimize the lookups down to the optimized storage level, in which case the offsets will be computed with respect to the underlying storage format, rather than with respect to the views.)
Changes to the graph's structure, or calling fillComplete on the graph (if its structure is not already fixed), may make the output array's contents invalid. "Invalid" means that you must call this method again to recompute the offsets.
offsets.extent(0) >= this->getLocalNumRows()
offsets | [out] Output array of offsets. This method does NOT allocate the array; the caller must allocate. Must have getLocalNumRows() entries on the calling process. (This may be different on different processes.) |
Definition at line 6298 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Backwards compatibility overload of the above method.
This method takes a Teuchos::ArrayRCP instead of a Kokkos::View. It also reallocates the output array if it is not long enough.
offsets | [out] Output array of offsets. This method reallocates the array if it is not long enough. This is why the method takes the array by reference. |
Definition at line 6624 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Get offsets of the off-rank entries in the graph.
Definition at line 6492 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Set the graph's data directly, using 1-D storage.
hasColMap() == true
rowPointers.size() == getLocalNumRows()+1
Definition at line 2709 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Set the graph's data directly, using 1-D storage.
hasColMap() == true
rowPointers.size() == getLocalNumRows()+1
Definition at line 2824 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Get a host view of the packed row offsets.
Definition at line 2230 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Get a device view of the packed row offsets.
Definition at line 2238 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Get a host view of the packed column indicies.
Definition at line 2247 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Get a device view of the packed column indicies.
Definition at line 2255 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Replace the graph's current column Map with the given Map.
This only replaces the column Map. It does not change the graph's current column indices, or otherwise apply a permutation. For example, suppose that before calling this method, the calling process owns a row containing local column indices [0, 2, 4]. These indices do not change, nor does their order change, as a result of calling this method.
newColMap | [in] New column Map. Must be nonnull. Within Tpetra, there are no particular restrictions on the column map. However, if this graph will be used in Xpetra, Ifpack2, or MueLu, the column map's list of global indices must follow "Aztec ordering": locally owned GIDs (same order as in domain map), followed by remote GIDs (in order of owning proc, and sorted within each proc). |
It is strongly recommended to use Tpetra::Details::makeColMap()
to create the column map. makeColMap() follows Aztec ordering by default.
Definition at line 3783 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Reindex the column indices in place, and replace the column Map. Optionally, replace the Import object as well.
newColMap | [in] New column Map. Must be nonnull. |
newImport | [in] New Import object. Optional; computed if not provided or if null. Computing an Import is expensive, so it is worth providing this if you can. |
sortIndicesInEachRow | [in] If true, sort the indices in each row after reindexing. |
Definition at line 3802 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Replace the current domain Map with the given objects.
The Graph's Import object will be recomputed if needed.
isFillComplete() == true
isFillActive() == false
Definition at line 4030 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Replace the current domain Map and Import with the given parameters.
isFillComplete() == true
isFillActive() == false
Either the given Import object is null, or the target Map of the given Import is the same as this graph's column Map.
Either the given Import object is null, or the source Map of the given Import is the same as this graph's domain Map.
Definition at line 4051 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Replace the current Range Map with the given objects.
The Graph's Export object will be recomputed if needed.
isFillComplete() == true
isFillActive() == false
Definition at line 4093 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Replace the current Range Map and Export with the given parameters.
isFillComplete() == true
isFillActive() == false
Either the given Export object is null, or the target Map of the given Export is the same as this graph's Range Map.
Either the given Export object is null, or the source Map of the given Export is the same as this graph's Row Map.
Definition at line 4114 of file Tpetra_CrsGraph_def.hpp.
|
overridevirtualinherited |
Remove processes owning zero rows from the Maps and their communicator.
newMap | [in] This must be the result of calling the removeEmptyProcesses() method on the row Map. If it is not, this method's behavior is undefined. This pointer will be null on excluded processes. |
This method satisfies the strong exception guarantee, as long the destructors of Export, Import, and Map do not throw exceptions. This means that either the method returns normally (without throwing an exception), or there are no externally visible side effects. However, this does not guarantee no deadlock when the graph's original communicator contains more than one process. In order to prevent deadlock, you must still wrap this call in a try/catch block and do an all-reduce over all processes in the original communicator to test whether the call succeeded. This safety measure should usually be unnecessary, since the method call should only fail on user error or failure to allocate memory.
Definition at line 6200 of file Tpetra_CrsGraph_def.hpp.
|
virtualinherited |
Remove processes which contain no entries in this object's Map.
On input, this object is distributed over the Map returned by getMap() (the "original Map," with its communicator, the "original communicator"). The input newMap
of this method must be the same as the result of calling getMap()->removeEmptyProcesses()
. On processes in the original communicator which contain zero entries ("excluded processes," as opposed to "included processes"), the input newMap
must be Teuchos::null
(which is what getMap()->removeEmptyProcesses()
returns anyway).
On included processes, reassign this object's Map (that would be returned by getMap()) to the input newMap
, and do any work that needs to be done to restore correct semantics. On excluded processes, free any data that needs freeing, and do any other work that needs to be done to restore correct semantics.
This method has collective semantics over the original communicator. On exit, the only method of this object which is safe to call on excluded processes is the destructor. This implies that subclasses' destructors must not contain communication operations.
|
inherited |
Import from this
to the given destination graph, and make the result fill complete.
If destGraph.is_null(), this creates a new graph as the destination. (This is why destGraph is passed in by nonconst reference to RCP.) Otherwise it checks for "pristine" status and throws if that is not the case. "Pristine" means that the graph has no entries and is not fill complete.
Use of the "non-member constructor" version of this method, exportAndFillCompleteCrsGraph, is preferred for user applications.
Definition at line 7311 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Import from this
to the given destination graph, and make the result fill complete.
If destGraph.is_null(), this creates a new graph as the destination. (This is why destGraph is passed in by nonconst reference to RCP.) Otherwise it checks for "pristine" status and throws if that is not the case. "Pristine" means that the graph has no entries and is not fill complete.
Use of the "non-member constructor" version of this method, exportAndFillCompleteCrsGraph, is preferred for user applications.
Definition at line 7323 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Export from this
to the given destination graph, and make the result fill complete.
If destGraph.is_null(), this creates a new graph as the destination. (This is why destGraph is passed in by nonconst reference to RCP.) Otherwise it checks for "pristine" status and throws if that is not the case. "Pristine" means that the graph has no entries and is not fill complete.
Use of the "non-member constructor" version of this method, exportAndFillCompleteCrsGraph, is preferred for user applications.
Definition at line 7336 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Export from this
to the given destination graph, and make the result fill complete.
If destGraph.is_null(), this creates a new graph as the destination. (This is why destGraph is passed in by nonconst reference to RCP.) Otherwise it checks for "pristine" status and throws if that is not the case. "Pristine" means that the graph has no entries and is not fill complete.
Use of the "non-member constructor" version of this method, exportAndFillCompleteCrsGraph, is preferred for user applications.
Definition at line 7348 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Make and set the graph's column Map.
This method makes the column Map, even if the graph already has one. It is the caller's responsibility not to call this method unnecessarily.
remotePIDs | [out] The process ranks corresponding to the column Map's "remote" (not on the calling process in the domain Map) indices. |
Definition at line 4412 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Convert column indices from global to local.
verbose | [in] Whether to print verbose debugging output. This exists because CrsMatrix may want to control output independently of the CrsGraph that it owns. |
First return value is the number of column indices on this process, counting duplicates, that could not be converted to local indices, because they were not in the column Map on the calling process. If some error occurred before conversion happened, then this is Tpetra::Details::OrdinalTraits<size_t>::invalid()
.
Second return value is a human-readable error string. If the first return value is zero, then the string may be empty.
Definition at line 4254 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Make the Import and Export objects, if needed.
remotePIDs | [in/out] On input: the output of makeColMap(). May be modified on output. |
useRemotePIDs | [in] Whether to use remotePIDs. Use it if we called makeColMap with this as the output argument, else don't use it. |
Definition at line 4567 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Insert indices into the given row.
! (lg == LocalIndices && I == GlobalIndices)
. It does not make sense to give this method local column indices (meaning that the graph has a column Map), yet to ask it to store global indices.This method does no allocation; it just inserts the indices.
rowInfo | [in/out] On input: Result of CrsGraph's getRowInfo() or updateAllocAndValues() methods, for the locally owned row (whose local index is rowInfo.localRow ) for which you want to insert indices. On output: numEntries field is updated. |
newInds | [in] View of the column indices to insert. If lg == GlobalIndices , then newInds.ginds, a Teuchos::ArrayView<const global_ordinal_type> , contains the (global) column indices to insert. Otherwise, if lg == LocalIndices , then newInds.linds, a Teuchos::ArrayView<const local_ordinal_type> , contains the (local) column indices to insert. |
lg | If lg == GlobalIndices , then the input indices (in newInds ) are global indices. Otherwise, if lg == LocalIndices , the input indices are local indices. |
I | If lg == GlobalIndices , then this method will store the input indices as global indices. Otherwise, if I == LocalIndices , this method will store the input indices as local indices. |
Definition at line 1586 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Finds indices in the given row.
This method does no insertion; it just finds indices and calls a callback for each found index
row | [in] Row of interest |
indices | [in] Column indices to find in row |
fun | Call back function called at each found index. Called as fun(k, start, offset); where k is the index in to indices, start is offset to the start of the row, and offset is the relative offset of indices[k] in the graphs indices. |
Definition at line 1831 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Like insertGlobalIndices(), but with column Map filtering.
"Column Map filtering" means that any column indices not in the column Map on the calling process, get silently dropped.
lclRow | [in] Local index of the row in which to insert. This row MUST be in the row Map on the calling process. |
gblColInds | [in] The global column indices to insert into that row. |
numGblColInds | [in] The number of global column indices to insert into that row. |
Definition at line 2592 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Implementation of insertGlobalIndices for nonowned rows.
A global row index is nonowned when it is not in the column Map on the calling process.
gblRow | [in] Global index of the row in which to insert. This row must NOT be in the row Map on the calling process. |
gblColInds | [in] The global column indices to insert into that row. |
numGblColInds | [in] The number of global column indices to insert into that row. |
Definition at line 2656 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Whether duplicate column indices in each row have been merged.
Definition at line 1160 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Report that we made a local modification to its structure.
Call this after making a local change to the graph's structure. Changing the structure locally invalidates the "is sorted" and "is merged" states.
Definition at line 1168 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Sort and merge duplicate column indices in the given row.
isGloballyIndexed() == false
. isStorageOptimized() == false
Definition at line 1868 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Set the domain and range Maps, and invalidate the Import and/or Export objects if necessary.
If the domain Map has changed, invalidate the Import object (if there is one). Likewise, if the range Map has changed, invalidate the Export object (if there is one).
Definition at line 1905 of file Tpetra_CrsGraph_def.hpp.
|
inlineinherited |
Returns true if globalConstants have been computed; false otherwise.
Definition at line 2019 of file Tpetra_CrsGraph_decl.hpp.
|
inherited |
Compute global constants, if they have not yet been computed.
Global constants include:
Always compute the following:
Definition at line 4177 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Compute local constants, if they have not yet been computed.
Local constants include:
Always compute the following:
computeGlobalConstants calls this method, if global constants have not yet been computed.
Definition at line 4223 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Get information about the locally owned row with local index myRow.
Definition at line 1437 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Get information about the locally owned row with global index gblRow.
If gblRow
is not locally owned, the localRow
field of the returned struct is Teuchos::OrdinalTraits<size_t>::invalid()
.
The point of this method is to fuse the global-to-local row index lookup for checking whether gblRow
is locally owned, with other error checking that getRowInfo() does. This avoids an extra global-to-local index lookup in methods like CrsMatrix::replaceGlobalValues().
Definition at line 1484 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Get the local graph.
This is only a valid representation of the local graph if the (global) graph is fill complete.
Definition at line 4157 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Throw an exception if the internal state is not consistent.
Definition at line 1936 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Swaps the data from *this with the data and maps from graph.
graph | [in/out] a crsGraph |
Definition at line 7362 of file Tpetra_CrsGraph_def.hpp.
|
inlineprotectedinherited |
Get the unpacked row pointers on device.
Definition at line 2187 of file Tpetra_CrsGraph_decl.hpp.
|
inlineprotectedinherited |
Get the unpacked row pointers on host. Lazily make a copy from device.
Definition at line 2193 of file Tpetra_CrsGraph_decl.hpp.
|
inlineprotectedinherited |
Get the packed row pointers on device.
Definition at line 2230 of file Tpetra_CrsGraph_decl.hpp.
|
inlineprotectedinherited |
Get the packed row pointers on host. Lazily make a copy from device.
Definition at line 2236 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Get a const, locally indexed view of the locally owned row myRow, such that rowinfo = getRowInfo(myRow).
Definition at line 1367 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Get a const, locally indexed view of the locally owned row myRow, such that rowinfo = getRowInfo(myRow).
Definition at line 1409 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Get a const, globally indexed view of the locally owned row myRow, such that rowinfo = getRowInfo(myRow).
Definition at line 1395 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Get a const, globally indexed view of the locally owned row myRow, such that rowinfo = getRowInfo(myRow).
Definition at line 1423 of file Tpetra_CrsGraph_def.hpp.
|
protectedinherited |
Get a ReadWrite locally indexed view of the locally owned row myRow, such that rowinfo = getRowInfo(myRow).
Definition at line 1381 of file Tpetra_CrsGraph_def.hpp.
|
inherited |
Import data into this object using an Import object ("forward mode").
The input DistObject is always the source of the data redistribution operation, and the *this
object is always the target.
If you don't know the difference between forward and reverse mode, then you probably want forward mode. Use this method with your precomputed Import object if you want to do an Import, else use doExport() with a precomputed Export object.
"Restricted Mode" does two things:
*this
, in a "locallyFitted" sense. This cannot be used if (2) is not true, OR there are permutes. The "source" maps still need to match.
source | [in] The "source" object for redistribution. |
importer | [in] Precomputed data redistribution plan. Its source Map must be the same as the input DistObject's Map, and its target Map must be the same as this->getMap() . |
CM | [in] How to combine incoming data with the same global index. |
|
inherited |
Import data into this object using an Export object ("reverse mode").
The input DistObject is always the source of the data redistribution operation, and the *this
object is always the target.
If you don't know the difference between forward and reverse mode, then you probably want forward mode. Use the version of doImport() that takes a precomputed Import object in that case.
"Restricted Mode" does two things:
*this
, in a "locallyFitted" sense. This cannot be used if (2) is not true, OR there are permutes. The "source" maps still need to match.
source | [in] The "source" object for redistribution. |
exporter | [in] Precomputed data redistribution plan. Its target Map must be the same as the input DistObject's Map, and its source Map must be the same as this->getMap() . (Note the difference from forward mode.) |
CM | [in] How to combine incoming data with the same global index. |
|
inherited |
Export data into this object using an Export object ("forward mode").
The input DistObject is always the source of the data redistribution operation, and the *this
object is always the target.
If you don't know the difference between forward and reverse mode, then you probably want forward mode. Use this method with your precomputed Export object if you want to do an Export, else use doImport() with a precomputed Import object.
"Restricted Mode" does two things:
*this
, in a "locallyFitted" sense. This cannot be used if (2) is not true, OR there are permutes. The "source" maps still need to match.
source | [in] The "source" object for redistribution. |
exporter | [in] Precomputed data redistribution plan. Its source Map must be the same as the input DistObject's Map, and its target Map must be the same as this->getMap() . |
CM | [in] How to combine incoming data with the same global index. |
|
inherited |
Export data into this object using an Import object ("reverse mode").
The input DistObject is always the source of the data redistribution operation, and the *this
object is always the target.
If you don't know the difference between forward and reverse mode, then you probably want forward mode. Use the version of doExport() that takes a precomputed Export object in that case.
"Restricted Mode" does two things:
*this
, in a "locallyFitted" sense. This cannot be used if (2) is not true, OR there are permutes. The "source" maps still need to match.
source | [in] The "source" object for redistribution. |
importer | [in] Precomputed data redistribution plan. Its target Map must be the same as the input DistObject's Map, and its source Map must be the same as this->getMap() . (Note the difference from forward mode.) |
CM | [in] How to combine incoming data with the same global index. |
|
inherited |
Whether the data from an import/export operation has arrived, and is ready for the unpack and combine step.
|
inherited |
Whether this is a globally distributed object.
For a definition of "globally distributed" (and its opposite, "locally replicated"), see the documentation of Map's isDistributed() method.
|
inlinevirtualinherited |
The Map describing the parallel distribution of this object.
Note that some Tpetra objects might be distributed using multiple Map objects. For example, CrsMatrix has both a row Map and a column Map. It is up to the subclass to decide which Map to use when invoking the DistObject constructor.
Definition at line 559 of file Tpetra_DistObject_decl.hpp.
|
inherited |
Print this object to the given output stream.
We generally assume that all MPI processes can print to the given stream.
|
protectedvirtualinherited |
Whether the implementation's instance promises always to have a constant number of packets per LID (local index), and if so, how many packets per LID there are.
If this method returns zero, the instance says that it might possibly have a different number of packets for each LID (local index) to send or receive. If it returns nonzero, the instance promises that the number of packets is the same for all LIDs, and that the return value is this number of packets per LID.
The default implementation of this method returns zero. This does not affect the behavior of doTransfer() in any way. If a nondefault implementation returns nonzero, doTransfer() will use this information to avoid unnecessary allocation and / or resizing of arrays.
|
protectedvirtualinherited |
Redistribute data across (MPI) processes.
src | [in] The source object, to redistribute into the target object, which is *this object. |
transfer | [in] The Export or Import object representing the communication pattern. (Details::Transfer is the common base class of these two objects.) |
modeString | [in] Human-readable string, for verbose debugging output and error output, explaining what function called this method. Example: "doImport (forward)", "doExport (reverse)". |
revOp | [in] Whether to do a forward or reverse mode redistribution. |
CM | [in] The combine mode that describes how to combine values that map to the same global ID on the same process. |
|
protectedvirtualinherited |
Reallocate numExportPacketsPerLID_ and/or numImportPacketsPerLID_, if necessary.
numExportLIDs | [in] Number of entries in the exportLIDs input array argument of doTransfer(). |
numImportLIDs | [in] Number of entries in the remoteLIDs input array argument of doTransfer(). |
|
protectedinherited |
Implementation detail of doTransfer.
LID DualViews come from the Transfer object given to doTransfer. They are always sync'd on both host and device. Users must never attempt to modify or sync them.
|
protectedvirtualinherited |
Reallocate imports_ if needed.
This unfortunately must be declared protected, for the same reason that imports_ is declared protected.
newSize | [in] New size of imports_. |
verbose | [in] Whether to print verbose debugging output to stderr on every (MPI) process in the communicator. |
prefix | [in] If verbose is true , then this is a nonnull prefix to print at the beginning of each line of verbose debugging output. Otherwise, not used. |
We don't need a "reallocExportsIfNeeded" method, because exports_
always gets passed into packAndPrepare() by nonconst reference. Thus, that method can resize the DualView without needing to call other DistObject methods.
|
related |
Nonmember CrsGraph constructor that fuses Import and fillComplete().
CrsGraphType | A specialization of CrsGraph. |
A common use case is to create an empty destination CrsGraph, redistribute from a source CrsGraph (by an Import or Export operation), then call fillComplete() on the destination CrsGraph. This constructor fuses these three cases, for an Import redistribution.
Fusing redistribution and fillComplete() exposes potential optimizations. For example, it may make constructing the column Map faster, and it may avoid intermediate unoptimized storage in the destination CrsGraph.
The resulting graph is fill complete (in the sense of isFillComplete()) and has optimized storage (in the sense of isStorageOptimized()). By default, its domain Map is the domain Map of the source graph, and its range Map is the range Map of the source graph.
sourceGraph | [in] The source graph from which to import. The source of an Import must have a nonoverlapping distribution. |
importer | [in] The Import instance containing a precomputed redistribution plan. The source Map of the Import must be the same as the rowMap of sourceGraph unless the "Reverse Mode" option on the params list, in which case the targetMap of Import must match the rowMap of the sourceGraph |
domainMap | [in] Domain Map of the returned graph. If null, we use the default, which is the domain Map of the source graph. |
rangeMap | [in] Range Map of the returned graph. If null, we use the default, which is the range Map of the source graph. |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 2616 of file Tpetra_CrsGraph_decl.hpp.
|
related |
Nonmember CrsGraph constructor that fuses Import and fillComplete().
CrsGraphType | A specialization of CrsGraph. |
A common use case is to create an empty destination CrsGraph, redistribute from a source CrsGraph (by an Import or Export operation), then call fillComplete() on the destination CrsGraph. This constructor fuses these three cases, for an Import redistribution.
Fusing redistribution and fillComplete() exposes potential optimizations. For example, it may make constructing the column Map faster, and it may avoid intermediate unoptimized storage in the destination CrsGraph.
The resulting graph is fill complete (in the sense of isFillComplete()) and has optimized storage (in the sense of isStorageOptimized()). By default, its domain Map is the domain Map of the source graph, and its range Map is the range Map of the source graph.
sourceGraph | [in] The source graph from which to import. The source of an Import must have a nonoverlapping distribution. |
rowImporter | [in] The Import instance containing a precomputed redistribution plan. The source Map of the Import must be the same as the rowMap of sourceGraph unless the "Reverse Mode" option on the params list, in which case the targetMap of Import must match the rowMap of the sourceGraph |
domainImporter | [in] The Import instance containing a precomputed redistribution plan. The source Map of the Import must be the same as the domainMap of sourceGraph unless the "Reverse Mode" option on the params list, in which case the targetMap of Import must match the domainMap of the sourceGraph |
domainMap | [in] Domain Map of the returned graph. |
rangeMap | [in] Range Map of the returned graph. |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 2685 of file Tpetra_CrsGraph_decl.hpp.
|
related |
Nonmember CrsGraph constructor that fuses Export and fillComplete().
CrsGraphType | A specialization of CrsGraph. |
For justification, see the documentation of importAndFillCompleteCrsGraph() (which is the Import analog of this function).
The resulting graph is fill complete (in the sense of isFillComplete()) and has optimized storage (in the sense of isStorageOptimized()). By default, its domain Map is the domain Map of the source graph, and its range Map is the range Map of the source graph.
sourceGraph | [in] The source graph from which to export. Its row Map may be overlapping, since the source of an Export may be overlapping. |
exporter | [in] The Export instance containing a precomputed redistribution plan. The source Map of the Export must be the same as the row Map of sourceGraph. |
domainMap | [in] Domain Map of the returned graph. If null, we use the default, which is the domain Map of the source graph. |
rangeMap | [in] Range Map of the returned graph. If null, we use the default, which is the range Map of the source graph. |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 2740 of file Tpetra_CrsGraph_decl.hpp.
|
related |
Nonmember CrsGraph constructor that fuses Export and fillComplete().
CrsGraphType | A specialization of CrsGraph. |
For justification, see the documentation of importAndFillCompleteCrsGraph() (which is the Import analog of this function).
The resulting graph is fill complete (in the sense of isFillComplete()) and has optimized storage (in the sense of isStorageOptimized()). By default, its domain Map is the domain Map of the source graph, and its range Map is the range Map of the source graph.
sourceGraph | [in] The source graph from which to export. Its row Map may be overlapping, since the source of an Export may be overlapping. |
rowExporter | [in] The Export instance containing a precomputed redistribution plan. The source Map of the Export must be the same as the row Map of sourceGraph. |
domainExporter | [in] The Export instance containing a precomputed redistribution plan. The source Map of the Export must be the same as the domain Map of sourceGraph. |
domainMap | [in] Domain Map of the returned graph. |
rangeMap | [in] Range Map of the returned graph. |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 2792 of file Tpetra_CrsGraph_decl.hpp.
|
related |
Nonmember function to create an empty CrsGraph given a row Map and the max number of entries allowed locally per row.
Definition at line 2552 of file Tpetra_CrsGraph_decl.hpp.
|
staticprotectedinherited |
Whether transformLocalValues should use atomic updates by default.
Definition at line 1956 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
The Map describing the distribution of rows of the graph.
Definition at line 2111 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
The Map describing the distribution of columns of the graph.
Definition at line 2113 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
The Map describing the range of the (matrix corresponding to the) graph.
Definition at line 2115 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
The Map describing the domain of the (matrix corresponding to the) graph.
Definition at line 2117 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
Local maximum of the number of entries in each row.
Computed in computeLocalConstants; only valid when isFillComplete() is true.
Definition at line 2138 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Global number of entries in the graph.
Only valid when isFillComplete() is true.
Definition at line 2144 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Global maximum of the number of entries in each row.
Computed in computeGlobalConstants(); only valid when isFillComplete() is true.
Definition at line 2151 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Local ordinals of column indices for all rows Valid when isLocallyIndexed is true If OptimizedStorage, storage is PACKED after fillComplete If not OptimizedStorate, storage is UNPACKED after fillComplete; that is, the views have storage equal to sizes provided in CrsGraph constructor.
This is allocated only if
UVM Removal Note: Device view takes place of k_lclInds1D_
Definition at line 2293 of file Tpetra_CrsGraph_decl.hpp.
|
mutableprotectedinherited |
Local ordinals of column indices for all rows Valid when isLocallyIndexed is true Built during fillComplete or non-fillComplete constructors Storage is PACKED after fillComplete that is, the views have storage equal to sizes provided in CrsGraph constructor.
This is allocated only if
UVM Removal Note: Device view takes place of lclGraph_.entries
Definition at line 2308 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Global ordinals of column indices for all rows.
Global ordinals of column indices for all rows
This is allocated only if
UVM Removal Note: Device view takes place of k_gblInds1D_
Definition at line 2323 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
The maximum number of entries to allow in each locally owned row, per row.
This comes in as an argument to some of the graph's constructors. Either this or numAllocForAllRows_ is used, but not both. allocateIndices(), setAllIndices(), and expertStaticFillComplete() all deallocate this array once they are done with it.
This is a host View because it is only ever used on the host. It has the HostMirror type for backwards compatibility; this used to be a DualView with default layout, so making this a HostMirror ensures that we can still take it directly by assignment from the constructors that take DualView, without a deep copy.
This array only exists on a process before the graph's indices are allocated on that process. After that point, it is discarded, since the graph's allocation implicitly or explicitly represents the same information.
FIXME (mfh 07 Aug 2014) We want graph's constructors to allocate, rather than doing lazy allocation at first insert. This will make both k_numAllocPerRow_ and numAllocForAllRows_ obsolete.
Definition at line 2385 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
The maximum number of entries to allow in each locally owned row.
This is an argument to some of the graph's constructors. Either this or k_numAllocPerRow_ is used, but not both.
FIXME (mfh 07 Aug 2014) We want graph's constructors to allocate, rather than doing lazy allocation at first insert. This will make both k_numAllocPerRow_ and numAllocForAllRows_ obsolete.
Definition at line 2396 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
The number of local entries in each locally owned row.
This is deallocated in fillComplete() if fillComplete()'s "Optimize Storage" parameter is set to true
.
This may also exist with 1-D storage, if storage is unpacked.
Definition at line 2448 of file Tpetra_CrsGraph_decl.hpp.
|
mutableprotectedinherited |
The offsets for off-rank entries.
When off-rank entries are sorted last, this rowPtr-lile view contains the offsets. It is compute on the first call to getLocalOffRankOffsets().
Definition at line 2455 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Status of the graph's storage, when not in a fill-complete state.
The phrase "When not in a fill-complete state" is important. When the graph is fill complete, it always uses 1-D "packed" storage. However, if the "Optimize Storage" parameter to fillComplete was false, the graph may keep unpacked 1-D storage around and resume it on the next resumeFill call.
Definition at line 2468 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Whether the graph's indices are sorted in each row, on this process.
Definition at line 2477 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Whether the graph's indices are non-redundant (merged) in each row, on this process.
Definition at line 2480 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Whether this process has computed local constants.
Definition at line 2482 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Whether all processes have computed global constants.
Definition at line 2484 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Nonlocal data given to insertGlobalIndices.
Definition at line 2491 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
Whether to require makeColMap() (and therefore fillComplete()) to order column Map GIDs associated with each remote process in ascending order.
makeColMap() always groups remote GIDs by process rank, so that all remote GIDs with the same owning rank occur contiguously. By default, it always sorts remote GIDs in increasing order within those groups. This behavior differs from Epetra, which does not sort remote GIDs with the same owning process.
This is true
by default, which means "sort remote GIDs." If you don't want to sort (for compatibility with Epetra), call sortGhostColumnGIDsWithinProcessBlock(false).
Definition at line 2507 of file Tpetra_CrsGraph_decl.hpp.
|
protectedinherited |
The Map over which this object is distributed.
Definition at line 968 of file Tpetra_DistObject_decl.hpp.
|
protectedinherited |
Buffer into which packed data are imported (received from other processes).
Unfortunately, I had to declare these protected, because CrsMatrix uses them at one point. Please, nobody else use them.
Definition at line 981 of file Tpetra_DistObject_decl.hpp.
|
protectedinherited |
Number of packets to receive for each receive operation.
This array is used in Distributor::doPosts() (and doReversePosts()) when starting the ireceive operation.
This may be ignored in doTransfer() if constantNumPackets is nonzero, indicating a constant number of packets per LID. (For example, MultiVector sets the constantNumPackets output argument of packAndPrepare() to the number of columns in the multivector.)
Unfortunately, I had to declare this protected, because CrsMatrix uses it at one point. Please, nobody else use it.
Definition at line 1021 of file Tpetra_DistObject_decl.hpp.
|
protectedinherited |
Buffer from which packed data are exported (sent to other processes).
Unfortunately, I had to declare this protected, because CrsMatrix uses it at one point. Please, nobody else use it.
Definition at line 1028 of file Tpetra_DistObject_decl.hpp.
|
protectedinherited |
Number of packets to send for each send operation.
This array is used in Distributor::doPosts() (and doReversePosts()) for preparing for the send operation.
This may be ignored in doTransfer() if constantNumPackets is nonzero, indicating a constant number of packets per LID. (For example, MultiVector sets the constantNumPackets output argument of packAndPrepare() to the number of columns in the multivector.)
Unfortunately, I had to declare this protected, because CrsMatrix uses them at one point. Please, nobody else use it.
Definition at line 1043 of file Tpetra_DistObject_decl.hpp.