Xpetra Version of the Day
|
#include <Xpetra_EpetraCrsGraph.hpp>
Private Types | |
typedef int | LocalOrdinal |
typedef int | GlobalOrdinal |
typedef EpetraNode | Node |
typedef Map< LocalOrdinal, GlobalOrdinal, Node > | map_type |
The specialization of Map used by this class. | |
typedef Xpetra::CrsGraph< LocalOrdinal, GlobalOrdinal, Node >::local_graph_type | local_graph_type |
typedef Xpetra::CrsGraph< LocalOrdinal, GlobalOrdinal, Node >::node_type | node_type |
typedef node_type::execution_space | execution_space |
Xpetra specific | |
RCP< Epetra_CrsGraph > | graph_ |
EpetraCrsGraphT (const Teuchos::RCP< Epetra_CrsGraph > &graph) | |
EpetraCrsGraphT constructor to wrap a Epetra_CrsGraph object. | |
RCP< const Epetra_CrsGraph > | getEpetra_CrsGraph () const |
Get the underlying Epetra graph. | |
Constructor/Destructor Methods | |
EpetraCrsGraphT (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap) | |
Constructor for empty DynamicProfile graph (no space is preallocated). | |
EpetraCrsGraphT (const RCP< const map_type > &rowMap, size_t maxNumEntriesPerRow, const RCP< Teuchos::ParameterList > &=Teuchos::null) | |
Constructor specifying fixed number of entries for each row. | |
EpetraCrsGraphT (const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &colMap, size_t maxNumEntriesPerRow, const Teuchos::RCP< Teuchos::ParameterList > &=null) | |
Constructor specifying column Map and fixed number of entries for each row. | |
EpetraCrsGraphT (const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &colMap, const ArrayRCP< const size_t > &NumEntriesPerRowToAlloc, const RCP< ParameterList > &=null) | |
EpetraCrsGraphT (const RCP< const CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > &sourceGraph, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap=Teuchos::null, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap=Teuchos::null, const RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
EpetraCrsGraphT (const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &, const typename local_graph_type::row_map_type &, const typename local_graph_type::entries_type::non_const_type &, const RCP< Teuchos::ParameterList > &=Teuchos::null) | |
Constructor specifying column Map, number of entries in each row and column indices in each row. | |
EpetraCrsGraphT (const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &, const local_graph_type &, const RCP< Teuchos::ParameterList > &=Teuchos::null) | |
Constructor specifying column Map, number of entries in each row and column indices in each row. | |
EpetraCrsGraphT (const local_graph_type &, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &, const Teuchos::RCP< const map_type > &=Teuchos::null, const Teuchos::RCP< const map_type > &=Teuchos::null, const RCP< Teuchos::ParameterList > &=Teuchos::null) | |
Constructor specifying column Map, number of entries in each row and column indices in each row. | |
virtual | ~EpetraCrsGraphT () |
Destructor. | |
Insertion/Removal Methods | |
void | insertGlobalIndices (GlobalOrdinal globalRow, const ArrayView< const GlobalOrdinal > &indices) |
Insert global indices into the graph. | |
void | insertLocalIndices (const LocalOrdinal localRow, const ArrayView< const LocalOrdinal > &indices) |
Insert local indices into the graph. | |
void | removeLocalIndices (LocalOrdinal localRow) |
Remove all graph indices from the specified local row. | |
void | allocateAllIndices (size_t numNonZeros, ArrayRCP< size_t > &rowptr, ArrayRCP< LocalOrdinal > &colind) |
Allocates and returns ArrayRCPs of the Crs arrays — This is an Xpetra-only routine. | |
void | setAllIndices (const ArrayRCP< size_t > &rowptr, const ArrayRCP< LocalOrdinal > &colind) |
Sets the 1D pointer arrays of the graph. | |
void | getAllIndices (ArrayRCP< const size_t > &rowptr, ArrayRCP< const LocalOrdinal > &colind) const |
Gets the 1D pointer arrays of the graph. | |
Transformational Methods | |
void | fillComplete (const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap, const RCP< ParameterList > ¶ms=null) |
Signal that data entry is complete, specifying domain and range maps. | |
void | fillComplete (const RCP< ParameterList > ¶ms=null) |
Signal that data entry is complete. | |
void | expertStaticFillComplete (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap, const Teuchos::RCP< const Import< LocalOrdinal, GlobalOrdinal, Node > > &importer=Teuchos::null, const Teuchos::RCP< const Export< LocalOrdinal, GlobalOrdinal, Node > > &exporter=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
Expert version of fillComplete. | |
Methods implementing RowGraph. | |
RCP< const Comm< int > > | getComm () const |
Returns the communicator. | |
RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > | getRowMap () const |
Returns the Map that describes the row distribution in this graph. | |
RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > | getColMap () const |
Returns the Map that describes the column distribution in this graph. | |
RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > | getDomainMap () const |
Returns the Map associated with the domain of this graph. | |
RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > | getRangeMap () const |
Returns the Map associated with the domain of this graph. | |
RCP< const Import< LocalOrdinal, GlobalOrdinal, Node > > | getImporter () const |
Returns the importer associated with this graph. | |
RCP< const Export< LocalOrdinal, GlobalOrdinal, Node > > | getExporter () const |
Returns the exporter associated with this graph. | |
global_size_t | getGlobalNumRows () const |
Returns the number of global rows in the graph. | |
global_size_t | getGlobalNumCols () const |
Returns the number of global columns in the graph. | |
size_t | getLocalNumRows () const |
Returns the number of graph rows owned on the calling node. | |
size_t | getLocalNumCols () const |
Returns the number of columns connected to the locally owned rows of this graph. | |
GlobalOrdinal | getIndexBase () const |
Returns the index base for global indices for this graph. | |
global_size_t | getGlobalNumEntries () const |
Returns the global number of entries in the graph. | |
size_t | getLocalNumEntries () const |
Returns the local number of entries in the graph. | |
size_t | getNumEntriesInGlobalRow (GlobalOrdinal globalRow) const |
Returns the current number of entries on this node in the specified global row. | |
size_t | getNumEntriesInLocalRow (LocalOrdinal localRow) const |
Returns the current number of entries on this node in the specified local row. | |
size_t | getNumAllocatedEntriesInGlobalRow (GlobalOrdinal globalRow) const |
Returns the current number of allocated entries for this node in the specified global row . | |
size_t | getNumAllocatedEntriesInLocalRow (LocalOrdinal localRow) const |
Returns the current number of allocated entries on this node in the specified local row. | |
size_t | getGlobalMaxNumRowEntries () const |
Maximum number of entries in all rows over all processes. | |
size_t | getLocalMaxNumRowEntries () const |
Maximum number of entries in all rows owned by the calling process. | |
bool | hasColMap () const |
Whether the graph has a column Map. | |
bool | isLocallyIndexed () const |
Whether column indices are stored using local indices on the calling process. | |
bool | isGloballyIndexed () const |
Whether column indices are stored using global indices on the calling process. | |
bool | isFillComplete () const |
Whether fillComplete() has been called and the graph is in compute mode. | |
bool | isStorageOptimized () const |
Returns true if storage has been optimized. | |
void | getGlobalRowView (GlobalOrdinal GlobalRow, ArrayView< const GlobalOrdinal > &Indices) const |
Return a const, nonpersisting view of global indices in the given row. | |
void | getLocalRowView (LocalOrdinal LocalRow, ArrayView< const LocalOrdinal > &indices) const |
Return a const, nonpersisting view of local indices in the given row. | |
local_graph_type::HostMirror | getLocalGraphHost () const |
Get the local graph. | |
local_graph_type | getLocalGraphDevice () const |
void | computeGlobalConstants () |
Force the computation of global constants if we don't have them. | |
Additional Inherited Members | |
![]() | |
typedef int | local_ordinal_type |
typedef int | global_ordinal_type |
typedef EpetraNode | node_type |
typedef node_type::execution_space | execution_space |
typedef node_type::device_type | device_type |
typedef Kokkos::StaticCrsGraph< int, Kokkos::LayoutLeft, device_type, void, size_t > | local_graph_type |
![]() | |
virtual | ~CrsGraph () |
Destructor. | |
![]() | |
virtual | ~DistObject () |
Destructor. | |
virtual void | doImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)=0 |
Import data into this object using an Import object ("forward mode"). | |
virtual void | beginImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
Import data into this object using an Import object ("forward mode"). | |
virtual void | endImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
Import data into this object using an Import object ("forward mode"). | |
virtual void | doExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)=0 |
Export data into this object using an Export object ("forward mode"). | |
virtual void | beginExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
Export data into this object using an Export object ("forward mode"). | |
virtual void | endExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
Export data into this object using an Export object ("forward mode"). | |
virtual void | doImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)=0 |
Import data into this object using an Export object ("reverse mode"). | |
virtual void | beginImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
Import data into this object using an Export object ("reverse mode"). | |
virtual void | endImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
Import data into this object using an Export object ("reverse mode"). | |
virtual void | doExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)=0 |
Export data into this object using an Import object ("reverse mode"). | |
virtual void | beginExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
Export data into this object using an Import object ("reverse mode"). | |
virtual void | endExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
Export data into this object using an Import object ("reverse mode"). | |
![]() | |
void | describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const |
virtual | ~Describable () |
DescribableStreamManipulatorState | describe (const Describable &describable, const EVerbosityLevel verbLevel=Describable::verbLevel_default) |
std::ostream & | operator<< (std::ostream &os, const DescribableStreamManipulatorState &d) |
void | describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const |
virtual | ~Describable () |
![]() | |
LabeledObject () | |
virtual | ~LabeledObject () |
virtual void | setObjectLabel (const std::string &objectLabel) |
virtual std::string | getObjectLabel () const |
![]() | |
static const EVerbosityLevel | verbLevel_default |
Definition at line 385 of file Xpetra_EpetraCrsGraph.hpp.
|
private |
Definition at line 388 of file Xpetra_EpetraCrsGraph.hpp.
|
private |
Definition at line 389 of file Xpetra_EpetraCrsGraph.hpp.
|
private |
Definition at line 390 of file Xpetra_EpetraCrsGraph.hpp.
|
private |
The specialization of Map used by this class.
Definition at line 393 of file Xpetra_EpetraCrsGraph.hpp.
|
private |
Definition at line 396 of file Xpetra_EpetraCrsGraph.hpp.
|
private |
Definition at line 397 of file Xpetra_EpetraCrsGraph.hpp.
|
private |
Definition at line 398 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Constructor for empty DynamicProfile graph (no space is preallocated).
Definition at line 407 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Constructor specifying fixed number of entries for each row.
Definition at line 411 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Constructor specifying column Map and fixed number of entries for each row.
Definition at line 420 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Definition at line 425 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Definition at line 431 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Constructor specifying column Map, number of entries in each row and column indices in each row.
Definition at line 456 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Constructor specifying column Map, number of entries in each row and column indices in each row.
Definition at line 466 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Constructor specifying column Map, number of entries in each row and column indices in each row.
Definition at line 475 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Destructor.
Definition at line 487 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
EpetraCrsGraphT constructor to wrap a Epetra_CrsGraph object.
Definition at line 845 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Insert global indices into the graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 495 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Insert local indices into the graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 503 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Remove all graph indices from the specified local row.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 511 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Allocates and returns ArrayRCPs of the Crs arrays — This is an Xpetra-only routine.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 515 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Sets the 1D pointer arrays of the graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 536 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Gets the 1D pointer arrays of the graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 559 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Signal that data entry is complete, specifying domain and range maps.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 587 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Signal that data entry is complete.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 597 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Expert version of fillComplete.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 608 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the communicator.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 627 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the Map that describes the row distribution in this graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 633 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the Map that describes the column distribution in this graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 636 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the Map associated with the domain of this graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 639 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the Map associated with the domain of this graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 642 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the importer associated with this graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 645 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the exporter associated with this graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 648 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the number of global rows in the graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 651 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the number of global columns in the graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 654 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the number of graph rows owned on the calling node.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 657 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the number of columns connected to the locally owned rows of this graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 660 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the index base for global indices for this graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 663 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the global number of entries in the graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 666 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the local number of entries in the graph.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 669 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the current number of entries on this node in the specified global row.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 672 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the current number of entries on this node in the specified local row.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 675 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the current number of allocated entries for this node in the specified global row .
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 678 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns the current number of allocated entries on this node in the specified local row.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 681 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Maximum number of entries in all rows over all processes.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 684 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Maximum number of entries in all rows owned by the calling process.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 687 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Whether the graph has a column Map.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 690 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Whether column indices are stored using local indices on the calling process.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 693 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Whether column indices are stored using global indices on the calling process.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 696 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Whether fillComplete() has been called and the graph is in compute mode.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 699 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Returns true if storage has been optimized.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 702 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Return a const, nonpersisting view of global indices in the given row.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 705 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Return a const, nonpersisting view of local indices in the given row.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 718 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Get the local graph.
This is only a valid representation of the local graph if the (global) graph is fill complete.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 731 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 743 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Force the computation of global constants if we don't have them.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 755 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Return a simple one-line description of this object.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 766 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Print the object with some verbosity level to an FancyOStream object.
Implements Xpetra::CrsGraph< int, int, EpetraNode >.
Definition at line 769 of file Xpetra_EpetraCrsGraph.hpp.
|
inlinevirtual |
Implements DistObject interface.
Access function for the Tpetra::Map this DistObject was constructed with.
Implements Xpetra::DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 785 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Definition at line 788 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Definition at line 801 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Import (using an Exporter).
Definition at line 814 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Export (using an Importer).
Definition at line 828 of file Xpetra_EpetraCrsGraph.hpp.
|
inline |
Get the underlying Epetra graph.
Definition at line 850 of file Xpetra_EpetraCrsGraph.hpp.
|
private |
Definition at line 856 of file Xpetra_EpetraCrsGraph.hpp.