Tpetra parallel linear algebra
Version of the Day
|
Matrix Market file reader for CrsMatrix and MultiVector. More...
#include <MatrixMarket_Tpetra.hpp>
Public Types | |
typedef SparseMatrixType | sparse_matrix_type |
This class' template parameter; a specialization of CrsMatrix. More... | |
typedef SparseMatrixType::scalar_type | scalar_type |
typedef SparseMatrixType::local_ordinal_type | local_ordinal_type |
typedef SparseMatrixType::global_ordinal_type | global_ordinal_type |
typedef SparseMatrixType::node_type | node_type |
The fourth template parameter of CrsMatrix and MultiVector. More... | |
typedef CrsGraph< local_ordinal_type, global_ordinal_type, node_type > | sparse_graph_type |
The CrsGraph specialization associated with SparseMatrixType. More... | |
typedef MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > | multivector_type |
The MultiVector specialization associated with SparseMatrixType. More... | |
typedef Vector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > | vector_type |
The Vector specialization associated with SparseMatrixType. More... | |
Static Public Member Functions | |
static Teuchos::RCP< sparse_graph_type > | readSparseGraphFile (const std::string &filename, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) |
Read sparse graph from the given Matrix Market file. More... | |
static Teuchos::RCP< sparse_graph_type > | readSparseGraphFile (const std::string &filename, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< node_type > &pNode, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) |
Variant of readSparseGraph that takes a Node object. More... | |
static Teuchos::RCP< sparse_graph_type > | readSparseGraphFile (const std::string &filename, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< Teuchos::ParameterList > &constructorParams, const Teuchos::RCP< Teuchos::ParameterList > &fillCompleteParams, const bool tolerant=false, const bool debug=false) |
Read sparse graph from the given Matrix Market file. More... | |
static Teuchos::RCP< sparse_graph_type > | readSparseGraphFile (const std::string &filename, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< node_type > &pNode, const Teuchos::RCP< Teuchos::ParameterList > &constructorParams, const Teuchos::RCP< Teuchos::ParameterList > &fillCompleteParams, const bool tolerant=false, const bool debug=false) |
Variant of readSparseFile above that takes a Node object. More... | |
static Teuchos::RCP< sparse_graph_type > | readSparseGraphFile (const std::string &filename, const Teuchos::RCP< const map_type > &rowMap, Teuchos::RCP< const map_type > &colMap, const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) |
Read sparse graph from the given Matrix Market file, with provided Maps. More... | |
static Teuchos::RCP< sparse_graph_type > | readSparseGraph (std::istream &in, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) |
Read sparse graph from the given Matrix Market input stream. More... | |
static Teuchos::RCP< sparse_graph_type > | readSparseGraph (std::istream &in, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< node_type > &pNode, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) |
Variant of readSparseGraph() above that takes a Node object. More... | |
static Teuchos::RCP< sparse_graph_type > | readSparseGraph (std::istream &in, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< Teuchos::ParameterList > &constructorParams, const Teuchos::RCP< Teuchos::ParameterList > &fillCompleteParams, const bool tolerant=false, const bool debug=false) |
Read sparse graph from the given Matrix Market input stream. More... | |
static Teuchos::RCP< sparse_graph_type > | readSparseGraph (std::istream &in, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< node_type > &pNode, const Teuchos::RCP< Teuchos::ParameterList > &constructorParams, const Teuchos::RCP< Teuchos::ParameterList > &fillCompleteParams, const bool tolerant=false, const bool debug=false) |
Variant of the above readSparseGraph() method that takes a Kokkos Node. More... | |
static Teuchos::RCP< sparse_graph_type > | readSparseGraph (std::istream &in, const Teuchos::RCP< const map_type > &rowMap, Teuchos::RCP< const map_type > &colMap, const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) |
Read sparse matrix from the given Matrix Market input stream, with provided Maps. More... | |
static Teuchos::RCP< sparse_matrix_type > | readSparseFile (const std::string &filename, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) |
Read sparse matrix from the given Matrix Market file. More... | |
static Teuchos::RCP< sparse_matrix_type > | readSparseFile (const std::string &filename, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< node_type > &pNode, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) |
Variant of readSparseFile that takes a Node object. More... | |
static Teuchos::RCP< sparse_matrix_type > | readSparseFile (const std::string &filename, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< Teuchos::ParameterList > &constructorParams, const Teuchos::RCP< Teuchos::ParameterList > &fillCompleteParams, const bool tolerant=false, const bool debug=false) |
Read sparse matrix from the given Matrix Market file. More... | |
static Teuchos::RCP< sparse_matrix_type > | readSparseFile (const std::string &filename, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< node_type > &pNode, const Teuchos::RCP< Teuchos::ParameterList > &constructorParams, const Teuchos::RCP< Teuchos::ParameterList > &fillCompleteParams, const bool tolerant=false, const bool debug=false) |
Variant of readSparseFile above that takes a Node object. More... | |
static Teuchos::RCP< sparse_matrix_type > | readSparseFile (const std::string &filename, const Teuchos::RCP< const map_type > &rowMap, Teuchos::RCP< const map_type > &colMap, const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) |
Read sparse matrix from the given Matrix Market file, with provided Maps. More... | |
static Teuchos::RCP< sparse_matrix_type > | readSparse (std::istream &in, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) |
Read sparse matrix from the given Matrix Market input stream. More... | |
static Teuchos::RCP< sparse_matrix_type > | readSparse (std::istream &in, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< node_type > &pNode, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) |
Variant of readSparse() above that takes a Node object. More... | |
static Teuchos::RCP< sparse_matrix_type > | readSparse (std::istream &in, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< Teuchos::ParameterList > &constructorParams, const Teuchos::RCP< Teuchos::ParameterList > &fillCompleteParams, const bool tolerant=false, const bool debug=false) |
Read sparse matrix from the given Matrix Market input stream. More... | |
static Teuchos::RCP< sparse_matrix_type > | readSparse (std::istream &in, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< node_type > &pNode, const Teuchos::RCP< Teuchos::ParameterList > &constructorParams, const Teuchos::RCP< Teuchos::ParameterList > &fillCompleteParams, const bool tolerant=false, const bool debug=false) |
Variant of the above readSparse() method that takes a Kokkos Node. More... | |
static Teuchos::RCP< sparse_matrix_type > | readSparse (std::istream &in, const Teuchos::RCP< const map_type > &rowMap, Teuchos::RCP< const map_type > &colMap, const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) |
Read sparse matrix from the given Matrix Market input stream, with provided Maps. More... | |
static Teuchos::RCP< multivector_type > | readDenseFile (const std::string &filename, const Teuchos::RCP< const comm_type > &comm, Teuchos::RCP< const map_type > &map, const bool tolerant=false, const bool debug=false) |
Read dense matrix (as a MultiVector) from the given Matrix Market file. More... | |
static Teuchos::RCP< multivector_type > | readDenseFile (const std::string &filename, const Teuchos::RCP< const comm_type > &comm, const Teuchos::RCP< node_type > &node, Teuchos::RCP< const map_type > &map, const bool tolerant=false, const bool debug=false) |
Variant of readDenseMatrix (see above) that takes a Node. More... | |
static Teuchos::RCP< vector_type > | readVectorFile (const std::string &filename, const Teuchos::RCP< const comm_type > &comm, Teuchos::RCP< const map_type > &map, const bool tolerant=false, const bool debug=false) |
Read a Vector from the given Matrix Market file. More... | |
static Teuchos::RCP< vector_type > | readVectorFile (const std::string &filename, const Teuchos::RCP< const comm_type > &comm, const Teuchos::RCP< node_type > &node, Teuchos::RCP< const map_type > &map, const bool tolerant=false, const bool debug=false) |
Like readVectorFile() (see above), but with a supplied Node object. More... | |
static Teuchos::RCP< multivector_type > | readDense (std::istream &in, const Teuchos::RCP< const comm_type > &comm, Teuchos::RCP< const map_type > &map, const bool tolerant=false, const bool debug=false) |
Read dense matrix (as a MultiVector) from the given Matrix Market input stream. More... | |
static Teuchos::RCP< multivector_type > | readDense (std::istream &in, const Teuchos::RCP< const comm_type > &comm, const Teuchos::RCP< node_type > &node, Teuchos::RCP< const map_type > &map, const bool tolerant=false, const bool debug=false) |
Variant of readDense (see above) that takes a Node. More... | |
static Teuchos::RCP< vector_type > | readVector (std::istream &in, const Teuchos::RCP< const comm_type > &comm, Teuchos::RCP< const map_type > &map, const bool tolerant=false, const bool debug=false) |
Read Vector from the given Matrix Market input stream. More... | |
static Teuchos::RCP< vector_type > | readVector (std::istream &in, const Teuchos::RCP< const comm_type > &comm, const Teuchos::RCP< node_type > &node, Teuchos::RCP< const map_type > &map, const bool tolerant=false, const bool debug=false) |
Read Vector from the given Matrix Market input stream, with a supplied Node. More... | |
static Teuchos::RCP< const map_type > | readMapFile (const std::string &filename, const Teuchos::RCP< const comm_type > &comm, const bool tolerant=false, const bool debug=false) |
Read Map (as a MultiVector) from the given Matrix Market file. More... | |
static Teuchos::RCP< const map_type > | readMapFile (const std::string &filename, const Teuchos::RCP< const comm_type > &comm, const Teuchos::RCP< node_type > &node, const bool tolerant=false, const bool debug=false) |
Variant of readMapFile (above) that takes an explicit Node instance. More... | |
static Teuchos::RCP< const map_type > | readMap (std::istream &in, const Teuchos::RCP< const comm_type > &comm, const bool tolerant=false, const bool debug=false) |
Read Map (as a MultiVector) from the given input stream. More... | |
static Teuchos::RCP< const map_type > | readMap (std::istream &in, const Teuchos::RCP< const comm_type > &comm, const Teuchos::RCP< node_type > &node, const bool tolerant=false, const bool debug=false) |
Variant of readMap (above) that takes an explicit Node instance. More... | |
static Teuchos::RCP< const map_type > | readMap (std::istream &in, const Teuchos::RCP< const comm_type > &comm, const Teuchos::RCP< Teuchos::FancyOStream > &err, const bool tolerant=false, const bool debug=false) |
Read Map (as a MultiVector) from the given input stream, with optional debugging output stream. More... | |
static Teuchos::RCP< const map_type > | readMap (std::istream &in, const Teuchos::RCP< const comm_type > &comm, const Teuchos::RCP< node_type > &node, const Teuchos::RCP< Teuchos::FancyOStream > &err, const bool tolerant=false, const bool debug=false) |
Variant of readMap (above) that takes an explicit Node instance. More... | |
Matrix Market file reader for CrsMatrix and MultiVector.
The Matrix Market (see its web site for details) defines a human-readable text file format for storing sparse and dense matrices. This class defines methods for reading sparse and dense matrices from a Matrix Market file or input stream. It represents sparse matrices as CrsMatrix and dense vectors and matrices as MultiVector. Reader can also read a Map (in the format produced by Writer) from a file or input stream.
All methods of this class only open files or read from input streams on MPI Process 0, with respect to the MPI communicator over which the given CrsMatrix or MultiVector is to be distributed.
We define the MultiVector type returned by readDense() and readDenseFile() using the scalar_type, local_ordinal_type, global_ordinal_type, and node_type typedefs in SparseMatrixType. This ensures that the multivectors returned by those methods have a type compatible with the CrsMatrix sparse matrices returned by readSparse() and readSparseFile(). We do this because the typical use case of Matrix Market files in Trilinos is to test sparse matrix methods, which usually involves reading a sparse matrix A and perhaps also a dense right-hand side b.
SparseMatrixType | A specialization of CrsMatrix. |
Templating on the specialization of CrsMatrix means that the Reader expects matrix data of a type compatible with the CrsMatrix's scalar_type. In general, Matrix Market files may contain data of integer, real, or complex type. However, the reader methods have to return a CrsMatrix of a specific type, so we require that you declare a Reader with the CrsMatrix type that you want and that you expect the file(s) to contain.
We didn't find any of the alternatives to this approach acceptable. One possibility would have been to have the reader methods return a "container that can hold anything," like a boost::any. However, then you would have to know all five template arguments of the CrsMatrix in order to get the actual CrsMatrix object out. C++ doesn't have algebraic data types (see the Wikipedia entry for a good definition) that are disjoint unions of different types. Thus, we couldn't have had the readers return a CrsMatrix with scalar_type = "int or double or complex<double>." While you can implement such a type in C++ (see e.g., boost::variant), it would not be interchangeable for its component types. This is because it may not have the same memory layout (e.g., copying an array of boost::variant<int, double, complex<double> > bitwise into an array of int may not work).
Definition at line 164 of file MatrixMarket_Tpetra.hpp.
typedef SparseMatrixType Tpetra::MatrixMarket::Reader< SparseMatrixType >::sparse_matrix_type |
This class' template parameter; a specialization of CrsMatrix.
Definition at line 167 of file MatrixMarket_Tpetra.hpp.
typedef SparseMatrixType::scalar_type Tpetra::MatrixMarket::Reader< SparseMatrixType >::scalar_type |
Type of the entries of the sparse matrix. The first template parameter of CrsMatrix and MultiVector.
Definition at line 172 of file MatrixMarket_Tpetra.hpp.
typedef SparseMatrixType::local_ordinal_type Tpetra::MatrixMarket::Reader< SparseMatrixType >::local_ordinal_type |
Type of the local indices of the sparse matrix. The second template parameter of CrsMatrix and MultiVector.
Definition at line 175 of file MatrixMarket_Tpetra.hpp.
typedef SparseMatrixType::global_ordinal_type Tpetra::MatrixMarket::Reader< SparseMatrixType >::global_ordinal_type |
Type of the global indices of the sparse matrix.
The third template parameter of CrsMatrix and MultiVector. This is also the type of indices as read from the Matrix Market file. Indices of the sparse matrix are read in as global ordinals, since Matrix Market files represent the whole matrix and don't have a notion of distribution.
Definition at line 184 of file MatrixMarket_Tpetra.hpp.
typedef SparseMatrixType::node_type Tpetra::MatrixMarket::Reader< SparseMatrixType >::node_type |
The fourth template parameter of CrsMatrix and MultiVector.
Definition at line 186 of file MatrixMarket_Tpetra.hpp.
typedef CrsGraph<local_ordinal_type, global_ordinal_type, node_type> Tpetra::MatrixMarket::Reader< SparseMatrixType >::sparse_graph_type |
The CrsGraph specialization associated with SparseMatrixType.
Definition at line 191 of file MatrixMarket_Tpetra.hpp.
typedef MultiVector<scalar_type, local_ordinal_type, global_ordinal_type, node_type> Tpetra::MatrixMarket::Reader< SparseMatrixType >::multivector_type |
The MultiVector specialization associated with SparseMatrixType.
Definition at line 197 of file MatrixMarket_Tpetra.hpp.
typedef Vector<scalar_type, local_ordinal_type, global_ordinal_type, node_type> Tpetra::MatrixMarket::Reader< SparseMatrixType >::vector_type |
The Vector specialization associated with SparseMatrixType.
Definition at line 203 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read sparse graph from the given Matrix Market file.
Open the given file on MPI Rank 0 (with respect to the given communicator). The file should contain Matrix Market "coordinate" format sparse matrix data. Read that data on Rank 0, and distribute it to all processors. Return the resulting distributed CrsMatrix.
filename | [in] Name of the Matrix Market file. |
pComm | [in] Communicator containing all processor(s) over which the sparse matrix will be distributed. |
callFillComplete | [in] Whether to call fillComplete() on the Tpetra::CrsMatrix, after adding all the entries read in from the input stream. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 1646 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of readSparseGraph that takes a Node object.
Definition at line 1657 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read sparse graph from the given Matrix Market file.
This is a variant of readSparseGraph() that lets you pass parameters to the CrsGraph's constructor and to its fillComplete() method.
Open the given file on Process 0 in the given communicator. The file must contain Matrix Market "coordinate" format sparse matrix data. Read that data on Process 0, and distribute it to all processes. Return the resulting distributed CrsMatrix.
filename | [in] Name of the Matrix Market file. |
pComm | [in] Communicator containing all process(es) over which the sparse matrix will be distributed. |
constructorParams | [in/out] Parameters for the CrsMatrix constructor. |
fillCompleteParams | [in/out] Parameters for CrsMatrix's fillComplete call. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 1712 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of readSparseFile above that takes a Node object.
Definition at line 1726 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read sparse graph from the given Matrix Market file, with provided Maps.
This version of readSparseGraph() requires you to provide a row Map, domain Map, and range Map. You may, if you wish, provide a column Map as well, but this is not required.
Open the given file on Process 0 (with respect to the given Maps' communicator). The file should contain Matrix Market "coordinate" format sparse matrix data. Read that data on Process 0, and distribute it to all processors. Return the resulting distributed CrsMatrix.
filename | [in] Name of the Matrix Market file. |
rowMap | [in] The Map over which to distribute rows of the sparse matrix. This must be nonnull. |
colMap | [in/out] If nonnull: the Map over which to distribute columns of the sparse matrix. If null and if callFillComplete is true, we create this for you. |
domainMap | [in] The sparse matrix's domain Map. This must be nonnull. It may equal (pointer equality) the row Map, if that would be appropriate for this matrix. |
rangeMap | [in] The sparse matrix's range Map. This must be nonnull. It may equal (pointer equality) the row Map, if that would be appropriate for this matrix. |
callFillComplete | [in] Whether to call fillComplete() on the Tpetra::CrsGraph, after adding all the entries read in from the input stream. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 1780 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read sparse graph from the given Matrix Market input stream.
The given input stream need only be readable by MPI Rank 0 (with respect to the given communicator). The input stream should contain Matrix Market "coordinate" format sparse matrix data. Read that data on Rank 0, and distribute it to all processors. Return the resulting distributed CrsMatrix.
in | [in] The input stream from which to read. |
pComm | [in] Communicator containing all processor(s) over which the sparse matrix will be distributed. |
callFillComplete | [in] Whether to call fillComplete() on the Tpetra::CrsMatrix, after adding all the entries read in from the input stream. (Not calling fillComplete() may be useful if you want to change the matrix after reading it from a file.) |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 1851 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of readSparseGraph() above that takes a Node object.
Definition at line 1862 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read sparse graph from the given Matrix Market input stream.
This is a variant of readSparse() that lets you pass parameters to the CrsMatrix's constructor and to its fillComplete() method.
The given input stream need only be readable by Process 0 in the given communicator. The input stream must contain Matrix Market "coordinate" format sparse matrix data. Read that data on Process 0, and distribute it to all Processes. Return the resulting distributed CrsMatrix.
in | [in] The input stream from which to read. |
pComm | [in] Communicator containing all process(es) over which the sparse matrix will be distributed. |
constructorParams | [in/out] Parameters for the CrsMatrix constructor. |
fillCompleteParams | [in/out] Parameters for CrsMatrix's fillComplete call. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 1904 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of the above readSparseGraph() method that takes a Kokkos Node.
Definition at line 1917 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read sparse matrix from the given Matrix Market input stream, with provided Maps.
This version of readSparse() requires you to provide a row Map, domain Map, and range Map. You may, if you wish, provide a column Map as well, but this is not required.
The given input stream need only be readable by Process 0 (with respect to the given Maps' communicator). The input stream must contain Matrix Market "coordinate" format sparse matrix data. Read that data on Process 0, and distribute it to all processors. Return the resulting distributed CrsMatrix.
in | [in/out] The input stream from which to read. |
rowMap | [in] The Map over which to distribute rows of the sparse matrix. This must be nonnull. |
colMap | [in/out] If nonnull: the Map over which to distribute columns of the sparse matrix. If null and if callFillComplete is true, we create this for you. |
domainMap | [in] The sparse matrix's domain Map. This must be nonnull. It may equal (pointer equality) the row Map, if that would be appropriate for this matrix. |
rangeMap | [in] The sparse matrix's range Map. This must be nonnull. It may equal (pointer equality) the row Map, if that would be appropriate for this matrix. |
callFillComplete | [in] Whether to call fillComplete() on the Tpetra::CrsMatrix, after adding all the entries read in from the input stream. (Not calling fillComplete() may be useful if you want to change the matrix after reading it from a file.) |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 1972 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read sparse matrix from the given Matrix Market file.
Open the given file on MPI Rank 0 (with respect to the given communicator). The file should contain Matrix Market "coordinate" format sparse matrix data. Read that data on Rank 0, and distribute it to all processors. Return the resulting distributed CrsMatrix.
filename | [in] Name of the Matrix Market file. |
pComm | [in] Communicator containing all processor(s) over which the sparse matrix will be distributed. |
callFillComplete | [in] Whether to call fillComplete() on the Tpetra::CrsMatrix, after adding all the entries read in from the input stream. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 2012 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of readSparseFile that takes a Node object.
Definition at line 2023 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read sparse matrix from the given Matrix Market file.
This is a variant of readSparseFile() that lets you pass parameters to the CrsMatrix's constructor and to its fillComplete() method.
Open the given file on Process 0 in the given communicator. The file must contain Matrix Market "coordinate" format sparse matrix data. Read that data on Process 0, and distribute it to all processes. Return the resulting distributed CrsMatrix.
filename | [in] Name of the Matrix Market file. |
pComm | [in] Communicator containing all process(es) over which the sparse matrix will be distributed. |
constructorParams | [in/out] Parameters for the CrsMatrix constructor. |
fillCompleteParams | [in/out] Parameters for CrsMatrix's fillComplete call. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 2078 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of readSparseFile above that takes a Node object.
Definition at line 2092 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read sparse matrix from the given Matrix Market file, with provided Maps.
This version of readSparseFile() requires you to provide a row Map, domain Map, and range Map. You may, if you wish, provide a column Map as well, but this is not required.
Open the given file on Process 0 (with respect to the given Maps' communicator). The file should contain Matrix Market "coordinate" format sparse matrix data. Read that data on Process 0, and distribute it to all processors. Return the resulting distributed CrsMatrix.
filename | [in] Name of the Matrix Market file. |
rowMap | [in] The Map over which to distribute rows of the sparse matrix. This must be nonnull. |
colMap | [in/out] If nonnull: the Map over which to distribute columns of the sparse matrix. If null and if callFillComplete is true, we create this for you. |
domainMap | [in] The sparse matrix's domain Map. This must be nonnull. It may equal (pointer equality) the row Map, if that would be appropriate for this matrix. |
rangeMap | [in] The sparse matrix's range Map. This must be nonnull. It may equal (pointer equality) the row Map, if that would be appropriate for this matrix. |
callFillComplete | [in] Whether to call fillComplete() on the Tpetra::CrsMatrix, after adding all the entries read in from the input stream. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 2146 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read sparse matrix from the given Matrix Market input stream.
The given input stream need only be readable by MPI Rank 0 (with respect to the given communicator). The input stream should contain Matrix Market "coordinate" format sparse matrix data. Read that data on Rank 0, and distribute it to all processors. Return the resulting distributed CrsMatrix.
in | [in] The input stream from which to read. |
pComm | [in] Communicator containing all processor(s) over which the sparse matrix will be distributed. |
callFillComplete | [in] Whether to call fillComplete() on the Tpetra::CrsMatrix, after adding all the entries read in from the input stream. (Not calling fillComplete() may be useful if you want to change the matrix after reading it from a file.) |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 2217 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of readSparse() above that takes a Node object.
Definition at line 2228 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read sparse matrix from the given Matrix Market input stream.
This is a variant of readSparse() that lets you pass parameters to the CrsMatrix's constructor and to its fillComplete() method.
The given input stream need only be readable by Process 0 in the given communicator. The input stream must contain Matrix Market "coordinate" format sparse matrix data. Read that data on Process 0, and distribute it to all Processes. Return the resulting distributed CrsMatrix.
in | [in] The input stream from which to read. |
pComm | [in] Communicator containing all process(es) over which the sparse matrix will be distributed. |
constructorParams | [in/out] Parameters for the CrsMatrix constructor. |
fillCompleteParams | [in/out] Parameters for CrsMatrix's fillComplete call. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 2781 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of the above readSparse() method that takes a Kokkos Node.
Definition at line 2794 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read sparse matrix from the given Matrix Market input stream, with provided Maps.
This version of readSparse() requires you to provide a row Map, domain Map, and range Map. You may, if you wish, provide a column Map as well, but this is not required.
The given input stream need only be readable by Process 0 (with respect to the given Maps' communicator). The input stream must contain Matrix Market "coordinate" format sparse matrix data. Read that data on Process 0, and distribute it to all processors. Return the resulting distributed CrsMatrix.
in | [in/out] The input stream from which to read. |
rowMap | [in] The Map over which to distribute rows of the sparse matrix. This must be nonnull. |
colMap | [in/out] If nonnull: the Map over which to distribute columns of the sparse matrix. If null and if callFillComplete is true, we create this for you. |
domainMap | [in] The sparse matrix's domain Map. This must be nonnull. It may equal (pointer equality) the row Map, if that would be appropriate for this matrix. |
rangeMap | [in] The sparse matrix's range Map. This must be nonnull. It may equal (pointer equality) the row Map, if that would be appropriate for this matrix. |
callFillComplete | [in] Whether to call fillComplete() on the Tpetra::CrsMatrix, after adding all the entries read in from the input stream. (Not calling fillComplete() may be useful if you want to change the matrix after reading it from a file.) |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 3350 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read dense matrix (as a MultiVector) from the given Matrix Market file.
Open the given file on MPI Process 0 (with respect to the given communicator). The file should contain Matrix Market "array" format dense matrix data. Read that data on Process 0, and distribute it to all processors. Return the resulting distributed MultiVector.
See documentation of readDense() for details.
filename | [in] Name of the Matrix Market file from which to read. Both the filename and the file itself are only accessed on Rank 0 of the given communicator. |
comm | [in] Communicator containing all process(es) over which the dense matrix will be distributed. |
node | [in] Kokkos Node object. |
map | [in/out] On input: if nonnull, the map describing how to distribute the vector (not modified). In this case, the map's communicator and node must equal comm resp. node . If null on input, then on output, a sensible (contiguous and uniformly distributed over the given communicator) map describing the distribution of the output multivector. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 3967 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of readDenseMatrix (see above) that takes a Node.
Definition at line 3982 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read a Vector from the given Matrix Market file.
Same as readDenseFile() but will work with 1D data only.
Open the given file on MPI Process 0 (with respect to the given communicator). The file should contain Matrix Market "array" format dense matrix data with number of columns==1. Read that data on Process 0, and distribute it to all processors. Return the resulting distributed Vector.
See documentation of readVector() for details.
filename | [in] Name of the Matrix Market file from which to read. Both the filename and the file itself are only accessed on Rank 0 of the given communicator. |
comm | [in] Communicator containing all process(es) over which the dense matrix will be distributed. |
map | [in/out] On input: if nonnull, the map describing how to distribute the vector (not modified). In this case, the map's communicator and node must equal comm resp. node . If null on input, then on output, a sensible (contiguous and uniformly distributed over the given communicator) map describing the distribution of the output multivector. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 4026 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Like readVectorFile() (see above), but with a supplied Node object.
Definition at line 4042 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read dense matrix (as a MultiVector) from the given Matrix Market input stream.
The given input stream need only be readable by MPI Rank 0 (with respect to the given communicator). The input stream should contain Matrix Market "array" format dense matrix data. Read that data on Process 0, and distribute it to all processes in the communicator. Return the resulting distributed MultiVector.
Unlike readSparse(), this method allows callers to supply a Map over which to distribute the resulting MultiVector. The Map argument is optional; if null, we construct our own reasonable Map. We let users supply their own Map, because a common case in Tpetra is to read in or construct a sparse matrix first, and then create dense (multi)vectors distributed with the sparse matrix's domain or range Map.
in | [in] The input stream from which to read. The stream is only accessed on Process 0 of the given communicator. |
comm | [in] Communicator containing all process(es) over which the dense matrix will be distributed. |
node | [in] Kokkos Node object. |
map | [in/out] On input: if nonnull, the map describing how to distribute the vector (not modified). In this case, the map's communicator and node must equal comm resp. node. If null on input, then on output, a sensible (contiguous and uniformly distributed over the given communicator) map describing the distribution of the output multivector. |
tolerant | [in] Whether to read the data tolerantly from the stream. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 4124 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of readDense (see above) that takes a Node.
Definition at line 4135 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read Vector from the given Matrix Market input stream.
Definition at line 4150 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read Vector from the given Matrix Market input stream, with a supplied Node.
Definition at line 4164 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read Map (as a MultiVector) from the given Matrix Market file.
Open the given file on MPI Process 0 (with respect to the given communicator). The file should contain Matrix Market "array" format dense matrix data with two columns, as generated by Writer::writeMap() or Writer::writeMapFile(). Read that data on Process 0, and distribute it to all processes. Return the resulting Map.
filename | [in] Name of the Matrix Market file from which to read. Both the filename and the file itself are only accessed on Process 0 of the given communicator. |
comm | [in] Communicator containing all process(es) over which the Map will be distributed. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 4198 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of readMapFile (above) that takes an explicit Node instance.
Definition at line 4209 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read Map (as a MultiVector) from the given input stream.
Read the given input stream on MPI Process 0 (with respect to the given communicator). The stream should contain Matrix Market "array" format dense matrix data with two columns, as generated by Writer::writeMap() or Writer::writeMapFile(). Distribute the data from Process 0 to all processes. Return the resulting Map.
in | [in/out] Input stream of Matrix Market data from which to read. This is only accessed on Process 0 of the given communicator. |
comm | [in] Communicator containing all process(es) over which the Map will be distributed. |
node | [in] Kokkos Node object. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] Whether to produce copious status output useful for Tpetra developers, but probably not useful for anyone else. |
Definition at line 5286 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of readMap (above) that takes an explicit Node instance.
Definition at line 5299 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Read Map (as a MultiVector) from the given input stream, with optional debugging output stream.
Read the given input stream on MPI Process 0 (with respect to the given communicator). The stream should contain Matrix Market "array" format dense matrix data with two columns, as generated by Writer::writeMap() or Writer::writeMapFile(). Distribute the data from Process 0 to all processes. Return the resulting Map.
in | [in/out] Input stream of Matrix Market data from which to read. This is only accessed on Process 0 of the given communicator. |
comm | [in] Communicator containing all process(es) over which the Map will be distributed. |
err | [in] Optional output stream for debugging output. This is only referenced if debug is true. |
tolerant | [in] Whether to read the data tolerantly from the file. |
debug | [in] If true, write copious debugging output to err on all processes in comm . |
Definition at line 5336 of file MatrixMarket_Tpetra.hpp.
|
inlinestatic |
Variant of readMap (above) that takes an explicit Node instance.
Definition at line 5348 of file MatrixMarket_Tpetra.hpp.