|
Epetra_CrsGraph & | operator= (const Epetra_CrsGraph &Source) |
| Assignment operator. More...
|
|
|
| Epetra_CrsGraph (Epetra_DataAccess CV, const Epetra_BlockMap &RowMap, const int *NumIndicesPerRow, bool StaticProfile=false) |
| Epetra_CrsGraph constuctor with variable number of indices per row. More...
|
|
| Epetra_CrsGraph (Epetra_DataAccess CV, const Epetra_BlockMap &RowMap, int NumIndicesPerRow, bool StaticProfile=false) |
| Epetra_CrsGraph constuctor with fixed number of indices per row. More...
|
|
| Epetra_CrsGraph (Epetra_DataAccess CV, const Epetra_BlockMap &RowMap, const Epetra_BlockMap &ColMap, const int *NumIndicesPerRow, bool StaticProfile=false) |
| Epetra_CrsGraph constuctor with variable number of indices per row. More...
|
|
| Epetra_CrsGraph (Epetra_DataAccess CV, const Epetra_BlockMap &RowMap, const Epetra_BlockMap &ColMap, int NumIndicesPerRow, bool StaticProfile=false) |
| Epetra_CrsGraph constuctor with fixed number of indices per row. More...
|
|
| Epetra_CrsGraph (const Epetra_CrsGraph &Graph) |
| Copy constructor. More...
|
|
virtual | ~Epetra_CrsGraph () |
| Epetra_CrsGraph Destructor.
|
|
|
int | InsertGlobalIndices (int GlobalRow, int NumIndices, int *Indices) |
| Enter a list of elements in a specified global row of the graph. More...
|
|
int | InsertGlobalIndices (long long GlobalRow, int NumIndices, long long *Indices) |
|
int | RemoveGlobalIndices (int GlobalRow, int NumIndices, int *Indices) |
| Remove a list of elements from a specified global row of the graph. More...
|
|
int | RemoveGlobalIndices (long long GlobalRow, int NumIndices, long long *Indices) |
|
int | RemoveGlobalIndices (long long Row) |
| Remove all indices from a specified global row of the graph. More...
|
|
int | InsertMyIndices (int LocalRow, int NumIndices, int *Indices) |
| Enter a list of elements in a specified local row of the graph. More...
|
|
int | RemoveMyIndices (int LocalRow, int NumIndices, int *Indices) |
| Remove a list of elements from a specified local row of the graph. More...
|
|
int | RemoveMyIndices (int Row) |
| Remove all indices from a specified local row of the graph. More...
|
|
|
int | FillComplete () |
| Tranform to local index space. Perform other operations to allow optimal matrix operations. More...
|
|
int | FillComplete (const Epetra_BlockMap &DomainMap, const Epetra_BlockMap &RangeMap) |
| Transform to local index space using specified Domain/Range maps. Perform other operations to allow optimal matrix operations. More...
|
|
int | OptimizeStorage () |
| Make consecutive row index sections contiguous, minimize internal storage used for constructing graph. More...
|
|
|
int | ExtractGlobalRowCopy (int GlobalRow, int LenOfIndices, int &NumIndices, int *Indices) const |
| Extract a list of elements in a specified global row of the graph. Put into storage allocated by calling routine. More...
|
|
int | ExtractGlobalRowCopy (long long GlobalRow, int LenOfIndices, int &NumIndices, long long *Indices) const |
|
int | ExtractMyRowCopy (int LocalRow, int LenOfIndices, int &NumIndices, int *Indices) const |
| Extract a list of elements in a specified local row of the graph. Put into storage allocated by calling routine. More...
|
|
int | ExtractGlobalRowView (int GlobalRow, int &NumIndices, int *&Indices) const |
| Get a view of the elements in a specified global row of the graph. More...
|
|
int | ExtractGlobalRowView (long long GlobalRow, int &NumIndices, long long *&Indices) const |
|
int | ExtractMyRowView (int LocalRow, int &NumIndices, int *&Indices) const |
| Get a view of the elements in a specified local row of the graph. More...
|
|
|
bool | Filled () const |
| If FillComplete() has been called, this query returns true, otherwise it returns false.
|
|
bool | StorageOptimized () const |
| If OptimizeStorage() has been called, this query returns true, otherwise it returns false.
|
|
bool | IndicesAreGlobal () const |
| If column indices are in global range, this query returns true, otherwise it returns false.
|
|
bool | IndicesAreLocal () const |
| If column indices are in local range, this query returns true, otherwise it returns false.
|
|
bool | LowerTriangular () const |
| If graph is lower triangular in local index space, this query returns true, otherwise it returns false. More...
|
|
bool | UpperTriangular () const |
| If graph is upper triangular in local index space, this query returns true, otherwise it returns false. More...
|
|
bool | NoDiagonal () const |
| If graph has no diagonal entries in global index space, this query returns true, otherwise it returns false. More...
|
|
bool | MyGlobalRow (int GID) const |
| Returns true of GID is owned by the calling processor, otherwise it returns false.
|
|
bool | MyGlobalRow (long long GID) const |
|
bool | HaveColMap () const |
| Returns true if we have a well-defined ColMap, and returns false otherwise. More...
|
|
|
int | NumMyRows () const |
| Returns the number of matrix rows on this processor.
|
|
int | NumGlobalRows () const |
| Returns the number of matrix rows in global matrix.
|
|
long long | NumGlobalRows64 () const |
|
int | NumMyCols () const |
| Returns the number of entries in the set of column-indices that appear on this processor. More...
|
|
int | NumGlobalCols () const |
| Returns the number of matrix columns in global matrix. More...
|
|
long long | NumGlobalCols64 () const |
|
int | NumGlobalNonzeros () const |
| Returns the number of indices in the global graph. More...
|
|
long long | NumGlobalNonzeros64 () const |
|
int | NumGlobalDiagonals () const |
| Returns the number of diagonal entries in the global graph, based on global row/column index comparisons. More...
|
|
long long | NumGlobalDiagonals64 () const |
|
int | NumMyDiagonals () const |
| Returns the number of diagonal entries in the local graph, based on global row/column index comparisons. More...
|
|
int | NumMyBlockRows () const |
| Returns the number of block matrix rows on this processor.
|
|
int | NumGlobalBlockRows () const |
| Returns the number of Block matrix rows in global matrix.
|
|
long long | NumGlobalBlockRows64 () const |
|
int | NumMyBlockCols () const |
| Returns the number of Block matrix columns on this processor. More...
|
|
int | NumGlobalBlockCols () const |
| Returns the number of Block matrix columns in global matrix. More...
|
|
long long | NumGlobalBlockCols64 () const |
|
int | NumMyBlockDiagonals () const |
| Returns the number of Block diagonal entries in the local graph, based on global row/column index comparisons. More...
|
|
int | NumGlobalBlockDiagonals () const |
| Returns the number of Block diagonal entries in the global graph, based on global row/column index comparisons. More...
|
|
long long | NumGlobalBlockDiagonals64 () const |
|
int | NumGlobalEntries () const |
| Returns the number of entries in the global graph. More...
|
|
long long | NumGlobalEntries64 () const |
|
int | NumMyEntries () const |
| Returns the number of entries on this processor. More...
|
|
int | MaxRowDim () const |
| Returns the max row dimension of block entries on the processor. More...
|
|
int | GlobalMaxRowDim () const |
| Returns the max row dimension of block entries across all processors. More...
|
|
int | MaxColDim () const |
| Returns the max column dimension of block entries on the processor. More...
|
|
int | GlobalMaxColDim () const |
| Returns the max column dimension of block entries across all processors. More...
|
|
int | NumMyNonzeros () const |
| Returns the number of indices in the local graph. More...
|
|
int | NumGlobalIndices (long long Row) const |
| Returns the current number of nonzero entries in specified global row on this processor.
|
|
int | NumAllocatedGlobalIndices (long long Row) const |
| Returns the allocated number of nonzero entries in specified global row on this processor.
|
|
int | MaxNumIndices () const |
| Returns the maximum number of nonzero entries across all rows on this processor. More...
|
|
int | GlobalMaxNumIndices () const |
| Returns the maximun number of nonzero entries across all rows across all processors. More...
|
|
int | MaxNumNonzeros () const |
| Returns the maximum number of nonzero points across all rows on this processor. More...
|
|
int | GlobalMaxNumNonzeros () const |
| Returns the maximun number of nonzero points across all rows across all processors. More...
|
|
int | NumMyIndices (int Row) const |
| Returns the current number of nonzero entries in specified local row on this processor.
|
|
int | NumAllocatedMyIndices (int Row) const |
| Returns the allocated number of nonzero entries in specified local row on this processor.
|
|
int | IndexBase () const |
| Returns the index base for row and column indices for this graph. More...
|
|
long long | IndexBase64 () const |
|
const Epetra_BlockMap & | RowMap () const |
| Returns the RowMap associated with this graph.
|
|
int | ReplaceRowMap (const Epetra_BlockMap &newmap) |
|
int | ReplaceColMap (const Epetra_BlockMap &newmap) |
|
int | ReplaceDomainMapAndImporter (const Epetra_BlockMap &NewDomainMap, const Epetra_Import *NewImporter) |
| Replaces the current DomainMap & Importer with the user-specified map object. More...
|
|
int | RemoveEmptyProcessesInPlace (const Epetra_BlockMap *NewMap) |
| Remove processes owning zero rows from the Maps and their communicator. More...
|
|
const Epetra_BlockMap & | ColMap () const |
| Returns the Column Map associated with this graph. More...
|
|
const Epetra_BlockMap & | DomainMap () const |
| Returns the DomainMap associated with this graph. More...
|
|
const Epetra_BlockMap & | RangeMap () const |
| Returns the RangeMap associated with this graph. More...
|
|
const Epetra_Import * | Importer () const |
| Returns the Importer associated with this graph.
|
|
const Epetra_Export * | Exporter () const |
| Returns the Exporter associated with this graph.
|
|
const Epetra_Comm & | Comm () const |
| Returns a pointer to the Epetra_Comm communicator associated with this graph.
|
|
|
int | LRID (int GRID_in) const |
| Returns the local row index for given global row index, returns -1 if no local row for this global row.
|
|
int | LRID (long long GRID_in) const |
|
int | GRID (int LRID_in) const |
| Returns the global row index for give local row index, returns IndexBase-1 if we don't have this local row.
|
|
long long | GRID64 (int LRID_in) const |
|
int | LCID (int GCID_in) const |
| Returns the local column index for given global column index, returns -1 if no local column for this global column. More...
|
|
int | LCID (long long GCID_in) const |
|
int | GCID (int LCID_in) const |
| Returns the global column index for give local column index, returns IndexBase-1 if we don't have this local column. More...
|
|
long long | GCID64 (int LCID_in) const |
|
bool | MyGRID (int GRID_in) const |
| Returns true if the GRID passed in belongs to the calling processor in this map, otherwise returns false.
|
|
bool | MyGRID (long long GRID_in) const |
|
bool | MyLRID (int LRID_in) const |
| Returns true if the LRID passed in belongs to the calling processor in this map, otherwise returns false.
|
|
bool | MyGCID (int GCID_in) const |
| Returns true if the GCID passed in belongs to the calling processor in this map, otherwise returns false. More...
|
|
bool | MyGCID (long long GCID_in) const |
|
bool | MyLCID (int LCID_in) const |
| Returns true if the LRID passed in belongs to the calling processor in this map, otherwise returns false. More...
|
|
|
int * | operator[] (int Loc) |
| Inlined bracket operator for fast access to data. (Const and Non-const versions) More...
|
|
int * | operator[] (int Loc) const |
|
|
virtual void | Print (std::ostream &os) const |
| Print method.
|
|
void | PrintGraphData (std::ostream &os) const |
|
void | PrintGraphData (std::ostream &os, int level) const |
|
|
const Epetra_BlockMap & | ImportMap () const |
| Use ColMap() instead.
|
|
int | TransformToLocal () |
| Use FillComplete() instead.
|
|
int | TransformToLocal (const Epetra_BlockMap *DomainMap, const Epetra_BlockMap *RangeMap) |
| Use FillComplete(const Epetra_BlockMap& DomainMap, const Epetra_BlockMap& RangeMap) instead.
|
|
|
int | ReferenceCount () const |
| Returns the reference count of CrsGraphData. More...
|
|
const Epetra_CrsGraphData * | DataPtr () const |
| Returns a pointer to the CrsGraphData instance this CrsGraph uses. More...
|
|
void | SortGhostsAssociatedWithEachProcessor (bool Flag) |
| Forces FillComplete() to locally order ghostnodes associated with each remote processor in ascending order. More...
|
|
| Epetra_DistObject (const Epetra_BlockMap &Map) |
| Basic Epetra_DistObject constuctor. More...
|
|
| Epetra_DistObject (const Epetra_BlockMap &Map, const char *const Label) |
|
| Epetra_DistObject (const Epetra_DistObject &Source) |
| Epetra_DistObject copy constructor.
|
|
virtual | ~Epetra_DistObject () |
| Epetra_DistObject destructor.
|
|
int | Import (const Epetra_SrcDistObject &A, const Epetra_Import &Importer, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0) |
| Imports an Epetra_DistObject using the Epetra_Import object. More...
|
|
int | Import (const Epetra_SrcDistObject &A, const Epetra_Export &Exporter, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0) |
| Imports an Epetra_DistObject using the Epetra_Export object. More...
|
|
int | Export (const Epetra_SrcDistObject &A, const Epetra_Import &Importer, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0) |
| Exports an Epetra_DistObject using the Epetra_Import object. More...
|
|
int | Export (const Epetra_SrcDistObject &A, const Epetra_Export &Exporter, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0) |
| Exports an Epetra_DistObject using the Epetra_Export object. More...
|
|
const Epetra_BlockMap & | Map () const |
| Returns the address of the Epetra_BlockMap for this multi-vector.
|
|
const Epetra_Comm & | Comm () const |
| Returns the address of the Epetra_Comm for this multi-vector.
|
|
bool | DistributedGlobal () const |
| Returns true if this multi-vector is distributed global, i.e., not local replicated.
|
|
| Epetra_Object (int TracebackModeIn=-1, bool set_label=true) |
| Epetra_Object Constructor. More...
|
|
| Epetra_Object (const char *const Label, int TracebackModeIn=-1) |
| Epetra_Object Constructor. More...
|
|
| Epetra_Object (const Epetra_Object &Object) |
| Epetra_Object Copy Constructor. More...
|
|
virtual | ~Epetra_Object () |
| Epetra_Object Destructor. More...
|
|
virtual int | ReportError (const std::string Message, int ErrorCode) const |
| Error reporting method.
|
|
virtual void | SetLabel (const char *const Label) |
| Epetra_Object Label definition using char *. More...
|
|
virtual const char * | Label () const |
| Epetra_Object Label access funtion. More...
|
|
virtual | ~Epetra_SrcDistObject () |
| Epetra_SrcDistObject destructor.
|
|
|
int * | All_Indices () const |
|
int * | IndexOffset () const |
|
int * | NumIndicesPerRow () const |
|
int * | NumAllocatedIndicesPerRow () const |
|
int ** | Indices () const |
|
int * | Indices (int LocalRow) const |
|
template<typename int_type > |
int_type ** | TIndices () const |
|
template<typename int_type > |
int_type * | TIndices (int LocalRow) const |
|
bool | IndicesAreContiguous () const |
|
bool | StaticProfile () const |
|
bool | GlobalConstantsComputed () const |
|
bool | FindGlobalIndexLoc (int LocalRow, int Index, int Start, int &Loc) const |
|
bool | FindGlobalIndexLoc (int NumIndices, const int *Indices, int Index, int Start, int &Loc) const |
|
bool | FindGlobalIndexLoc (int LocalRow, long long Index, int Start, int &Loc) const |
|
bool | FindGlobalIndexLoc (int NumIndices, const long long *Indices, long long Index, int Start, int &Loc) const |
|
bool | FindMyIndexLoc (int LocalRow, int Index, int Start, int &Loc) const |
|
bool | FindMyIndexLoc (int NumIndices, const int *Indices, int Index, int Start, int &Loc) const |
|
int | InsertIndices (int Row, int NumIndices, int *Indices) |
|
int | InsertIndicesIntoSorted (int Row, int NumIndices, int *Indices) |
|
int | InsertIndices (int Row, int NumIndices, long long *Indices) |
|
int | InsertIndicesIntoSorted (int Row, int NumIndices, long long *Indices) |
|
int | MakeIndicesLocal (const Epetra_BlockMap &DomainMap, const Epetra_BlockMap &RangeMap) |
|
void | SetIndicesAreLocal (bool Flag) |
|
void | SetIndicesAreGlobal (bool Flag) |
|
void | SetSorted (bool Flag) |
|
int | SortIndices () |
| Sort column indices, row-by-row, in ascending order. More...
|
|
bool | Sorted () const |
| If SortIndices() has been called, this query returns true, otherwise it returns false.
|
|
int | RemoveRedundantIndices () |
| Removes any redundant column indices in the rows of the graph. More...
|
|
int | DetermineTriangular () |
|
bool | NoRedundancies () const |
| If RemoveRedundantIndices() has been called, this query returns true, otherwise it returns false.
|
|
virtual int | DoTransfer (const Epetra_SrcDistObject &A, Epetra_CombineMode CombineMode, int NumSameIDs, int NumPermuteIDs, int NumRemoteIDs, int NumExportIDs, int *PermuteToLIDs, int *PermuteFromLIDs, int *RemoteLIDs, int *ExportLIDs, int &LenExports, char *&Exports, int &LenImports, char *&Imports, Epetra_Distributor &Distor, bool DoReverse, const Epetra_OffsetIndex *Indexor) |
| Perform actual transfer (redistribution) of data across memory images, using Epetra_Distributor object.
|
|
std::string | toString (const int &x) const |
|
std::string | toString (const long long &x) const |
|
std::string | toString (const double &x) const |
|
Epetra_CrsGraph: A class for constructing and using sparse compressed row graphs.
Epetra_CrsGraph enables the piecewise construction and use of sparse matrix graphs (the integer structure without
values) where entries are intended for row access.
Epetra_CrsGraph is an attribute of all Epetra row-based matrix classes, defining their nonzero structure and also
holding their Epetra_Map attributes.
Constructing Epetra_CrsGraph objects
Constructing Epetra_CrsGraph objects is a multi-step process. The basic steps are as follows:
-
Create Epetra_CrsGraph instance, including some initial storage, via constructor. In addition to the copy constructor, Epetra_CrsGraph has four different constructors. All four of these constructors have an argument, StaticProfile, which by default is set to false. If it is set to true, then the profile (the number of indices per row as defined by NumIndicesPerRow) will be rigidly enforced. Although this takes away flexibility, it allows a single array to be allocated for all indices. This decreases memory fragmentation and improves performance across many operations. A more detailed discussion of the StaticProfile option is found below.
-
User-provided row map, variable nonzero profile: This constructor is used to define the row distribution of the graph and specify a varying number of nonzero entries per row. It is best to use this constructor when the user will be inserting entries using global index values and wants every column index to be included in the graph. Note that in this case, the column map will be built for the user when FillComplete() is called. This constructor is also appropriate for when there is a large variation in the number of indices per row. If this is not the case, the next constructor may be more convenient to use.
-
User-provided row map, fixed nonzero profile: This constructor is used to define the row distribution of the graph and specify a fixed number of nonzero entries per row. It is best to use this constructor when the user will be inserting entries using global index values and wants every column index to be included in the graph. Note that in this case, the column map will be built for the user when FillComplete() is called. This constructor is also appropriate for when there is little or no variation in the number of indices per row.
-
User-provided row map, user-provided column map and variable nonzero profile: This constructor is used to define the row and column distribution of the graph, and specify a varying number of nonzero entries per row. It is best to use this constructor when the user will be inserting entries and already knows which columns of the matrix should be included on each processor. Note that in this case, the column map will not be built for the user when FillComplete() is called. Also, if the user attempts to insert a column index whose GID is not part of the column map on that process, the index will be discarded. This property can be used to "filter out" column entries that should be ignored. This constructor is also appropriate for when there is a large variation in the number of indices per row. If this is not the case, the next constructor may be more convenient to use.
-
User-provided row map, user-provided column map and fixed nonzero profile: This constructor is used to define the row and column distribution of the graph, and specify a fixed number of nonzero entries per row. It is best to use this constructor when the user will be inserting entries and already knows which columns of the matrix should be included on each processor. Note that in this case, the column map will not be built for the user when FillComplete() is called. Also, if the user attempts to insert a column index whose GID is not part of the column map on that process, the index will be discarded. This constructor is also appropriate for when there is little or no variation in the number of indices per row.
-
Enter row and column entry information via calls to the InsertGlobalIndices method.
-
Complete construction via FillComplete call, which performs the following tasks:
-
Transforms indices to local index space (after this, IndicesAreLocal()==true)
-
Sorts column-indices within each row
-
Compresses out any redundant indices within rows
-
Computes global data such as num-nonzeros, maximum row-lengths, etc.
-
(Optional) Optimize the graph storage via a call to OptimizeStorage.
Performance Enhancement Issues
The Epetra_CrsGraph class attempts to address four basic types of situations, depending on the user's primary concern:
-
Simple, flexible construction over minimal memory use or control of column indices: In this case the user wants to provide only a row distribution of the graph and insert indices without worrying about memory allocation performance. This type of user is best served by the constructor that requires only a row map, and a fixed number of indices per row. In fact, setting NumIndicesPerRow=0 is probably the best option.
-
Stronger control over memory allocation performance and use over flexibility and simplicity: In this case the user explicitly set StaticProfile to true and will provide values, either a single global int or an array of int's, for NumIndicesPerRow, such that the actual number of indices submitted to the graph will not exceed the estimates. Because we know that NumIndicesPerRow will not be exceeded, we can pre-allocate all of the storage for the graph as a single array. This is typically much more efficient.
-
Explicit control over column indices: In this case the user prescribes the column map. Given the column map, any index that is submitted for entry into the graph will be included only if they are present in the list of GIDs for the column map on the processor that submits the index. This feature allows the user to define a filter such that only certain columns will be kept. The user also prescribes the local ordering via this technique, since the ordering of GIDs in the column map imposes the local ordering.
-
Construction using local indices only: In some situations, users may want to build a graph using local index values only. In this case, the user must explicitly assign GIDs. This is done by prescribing the column map, in the same way as the previous situation.
Notes:
-
In all but the most advanced uses, users will typically not specify the column map. In other words, graph entries will be submitted using GIDs not LIDs and all entries that are submitted are intended to be inserted into the graph.
-
If a user is not particularly worried about performance, or really needs the flexibility associated with the first situation, then there is no need to explicitly manage the NumIndicesPerRow values or set StaticProfile to true. In this case, it is best to set NumIndicesPerRow to zero.
-
Users who are concerned about performance should carefully manage NumIndicesPerRow and set StaticProfile to true. This will give the best performance and use the least amount of memory.
-
A compromise approach would be to not set StaticProfile to true, giving the user flexibility, but then calling OptimizeStorage() once FillComplete() has been called. This approach requires additional temporary memory because the graph will be copied into an efficient data structure and the old memory deleted. However, once the copy has been made, the resulting data structure is as efficient as when StaticProfile is used.
Epetra_Map attributes
Epetra_CrsGraph objects have four Epetra_Map attributes.
The Epetra_Map attributes can be obtained via these accessor methods:
-
RowMap() Describes the numbering and distribution of the rows of the graph. The row-map exists and is valid for the entire life of the graph, having been passed in as a constructor argument. The set of graph rows is defined by the row-map and may not be changed. Rows may not be inserted or deleted by the user. The only change that may be made is that the user can replace the row-map with a compatible row-map (which is the same except for re-numbering) by calling the ReplaceRowMap() method.
-
ColMap() Describes the set of column-indices that appear in the rows in each processor's portion of the graph. Unless provided by the user at construction time, a valid column-map doesn't exist until FillComplete() is called.
-
RangeMap() Describes the range of the matrix operator. e.g., for a matrix-vector product operation, the result vector's map must be compatible with the range-map of the matrix operator. The range-map is usually the same as the row-map. The range-map is set equal to the row-map at graph creation time, but may be specified by the user when FillComplete() is called.
-
DomainMap() Describes the domain of the matrix operator. The domain-map can be specified by the user when FillComplete() is called. Until then, it is set equal to the row-map.
It is important to note that while the row-map and the range-map are often the same, the column-map and the domain-map are almost never the same. The set of entries in a distributed column-map almost always form overlapping sets, with entries being associated with more than one processor. A domain-map, on the other hand, must be a 1-to-1 map, with entries being associated with only a single processor.
Global versus Local indices
After creation and before FillComplete() has been called, the column-indices of the graph are in the global space as received from the user. One of the tasks performed by FillComplete() is to transform the indices to a local index space. The query methods IndicesAreGlobal() and IndicesAreLocal() return true or false depending on whether this transformation has been performed or not.
Note the behavior of several graph methods:
Note that even after a graph is constructed, it is possible to add or remove entries. However, FillComplete must then be called again to restore the graph to a consistent state.