/usr/include/trilinos/Tpetra_RowMatrix_decl.hpp is in libtrilinos-tpetra-dev 12.10.1-3.
This file is owned by root:root, with mode 0o644.
The actual contents of the file can be viewed below.
1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 27 28 29 30 31 32 33 34 35 36 37 38 39 40 41 42 43 44 45 46 47 48 49 50 51 52 53 54 55 56 57 58 59 60 61 62 63 64 65 66 67 68 69 70 71 72 73 74 75 76 77 78 79 80 81 82 83 84 85 86 87 88 89 90 91 92 93 94 95 96 97 98 99 100 101 102 103 104 105 106 107 108 109 110 111 112 113 114 115 116 117 118 119 120 121 122 123 124 125 126 127 128 129 130 131 132 133 134 135 136 137 138 139 140 141 142 143 144 145 146 147 148 149 150 151 152 153 154 155 156 157 158 159 160 161 162 163 164 165 166 167 168 169 170 171 172 173 174 175 176 177 178 179 180 181 182 183 184 185 186 187 188 189 190 191 192 193 194 195 196 197 198 199 200 201 202 203 204 205 206 207 208 209 210 211 212 213 214 215 216 217 218 219 220 221 222 223 224 225 226 227 228 229 230 231 232 233 234 235 236 237 238 239 240 241 242 243 244 245 246 247 248 249 250 251 252 253 254 255 256 257 258 259 260 261 262 263 264 265 266 267 268 269 270 271 272 273 274 275 276 277 278 279 280 281 282 283 284 285 286 287 288 289 290 291 292 293 294 295 296 297 298 299 300 301 302 303 304 305 306 307 308 309 310 311 312 313 314 315 316 317 318 319 320 321 322 323 324 325 326 327 328 329 330 331 332 333 334 335 336 337 338 339 340 341 342 343 344 345 346 347 348 349 350 351 352 353 354 355 356 357 358 359 360 361 362 363 364 365 366 367 368 369 370 371 372 373 374 375 376 377 378 379 380 381 382 383 384 385 386 387 388 389 390 391 392 393 394 395 396 397 398 399 400 401 402 403 404 405 406 407 408 409 410 411 412 413 414 415 416 417 418 419 420 421 422 423 424 425 426 427 428 429 430 431 432 433 434 435 436 437 438 439 440 441 442 443 444 445 446 447 448 449 450 451 452 453 454 455 456 457 458 459 460 461 462 463 464 465 466 467 468 469 470 471 472 473 474 475 476 477 478 479 480 481 482 483 484 485 486 487 488 489 490 491 492 493 494 495 496 497 498 499 500 501 502 503 504 505 506 507 508 509 510 511 512 513 514 515 516 517 518 519 520 521 522 523 524 525 526 527 528 529 530 531 532 533 534 535 | // @HEADER
// ***********************************************************************
//
// Tpetra: Templated Linear Algebra Services Package
// Copyright (2008) Sandia Corporation
//
// Under the terms of Contract DE-AC04-94AL85000 with Sandia Corporation,
// the U.S. Government retains certain rights in this software.
//
// Redistribution and use in source and binary forms, with or without
// modification, are permitted provided that the following conditions are
// met:
//
// 1. Redistributions of source code must retain the above copyright
// notice, this list of conditions and the following disclaimer.
//
// 2. Redistributions in binary form must reproduce the above copyright
// notice, this list of conditions and the following disclaimer in the
// documentation and/or other materials provided with the distribution.
//
// 3. Neither the name of the Corporation nor the names of the
// contributors may be used to endorse or promote products derived from
// this software without specific prior written permission.
//
// THIS SOFTWARE IS PROVIDED BY SANDIA CORPORATION "AS IS" AND ANY
// EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE
// IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR
// PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL SANDIA CORPORATION OR THE
// CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL,
// EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO,
// PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR
// PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF
// LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING
// NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS
// SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
//
// Questions? Contact Michael A. Heroux (maherou@sandia.gov)
//
// ************************************************************************
// @HEADER
#ifndef TPETRA_ROWMATRIX_DECL_HPP
#define TPETRA_ROWMATRIX_DECL_HPP
#include <Teuchos_Describable.hpp>
#include <Kokkos_DefaultNode.hpp>
#include "Tpetra_ConfigDefs.hpp"
#include "Tpetra_Vector_decl.hpp"
#include "Tpetra_Operator.hpp"
#include "Tpetra_RowGraph.hpp"
#include "Tpetra_Packable.hpp"
#include "Tpetra_SrcDistObject.hpp"
namespace Tpetra {
//
// Forward declarations. The "doxygen" bit simply tells Doxygen
// (our automatic documentation generation system) to skip forward
// declarations.
//
#ifndef DOXYGEN_SHOULD_SKIP_THIS
template<class LocalOrdinal, class GlobalOrdinal, class Node>
class Map;
#endif // DOXYGEN_SHOULD_SKIP_THIS
/// \class RowMatrix
/// \brief A read-only, row-oriented interface to a sparse matrix.
///
/// \tparam Scalar The type of the entries in the sparse matrix.
/// Same as the \c Scalar typedef of Operator.
/// \tparam LocalOrdinal The type of local indices. See the
/// documentation of Map for requirements.
/// \tparam GlobalOrdinal The type of global indices. See the
/// documentation of Map for requirements.
/// \tparam Node The Kokkos Node type. See the documentation of Map
/// for requirements.
///
/// RowMatrix provides a read-only, row-oriented interface to view
/// the entries of a sparse matrix, which is distributed over one or
/// more (MPI) processes. "Read only" means that you may view the
/// entries, but not modify them. "Row-oriented" means that you may
/// view all the entries owned by the calling process, in any
/// particular row of the matrix that is owned by the calling
/// process.
///
/// CrsMatrix implements this interface, but also lets you add or
/// modify entries of the sparse matrix. Ifpack2 provides other
/// implementations of RowMatrix, which do useful things like
/// wrapping an existing matrix to view only certain desired
/// entries.
template <class Scalar = ::Tpetra::Details::DefaultTypes::scalar_type,
class LocalOrdinal = ::Tpetra::Details::DefaultTypes::local_ordinal_type,
class GlobalOrdinal = ::Tpetra::Details::DefaultTypes::global_ordinal_type,
class Node = ::Tpetra::Details::DefaultTypes::node_type>
class RowMatrix :
virtual public Operator<Scalar, LocalOrdinal, GlobalOrdinal, Node>,
virtual public SrcDistObject,
public Packable<char, LocalOrdinal> {
public:
//! @name Typedefs
//@{
//! The type of the entries in the sparse matrix.
typedef Scalar scalar_type;
//! The type of local indices.
typedef LocalOrdinal local_ordinal_type;
//! The type of global indices.
typedef GlobalOrdinal global_ordinal_type;
//! The Kokkos Node type.
typedef Node node_type;
/// \brief Type of a norm result.
///
/// This is usually the same as the type of the magnitude
/// (absolute value) of <tt>Scalar</tt>, but may differ for
/// certain <tt>Scalar</tt> types.
typedef typename Tpetra::MultiVector<Scalar, LocalOrdinal, GlobalOrdinal, Node>::mag_type mag_type;
//@}
//! @name Destructor
//@{
//! Destructor (virtual for memory safety of derived classes).
virtual ~RowMatrix();
//@}
//! @name Matrix query methods
//@{
//! The communicator over which this matrix is distributed.
virtual Teuchos::RCP<const Teuchos::Comm<int> > getComm() const = 0;
//! The Kokkos Node instance.
virtual Teuchos::RCP<Node> getNode() const = 0;
//! The Map that describes the distribution of rows over processes.
virtual Teuchos::RCP<const Map<LocalOrdinal,GlobalOrdinal,Node> > getRowMap() const = 0;
//! The Map that describes the distribution of columns over processes.
virtual Teuchos::RCP<const Map<LocalOrdinal,GlobalOrdinal,Node> > getColMap() const = 0;
//! The RowGraph associated with this matrix.
virtual Teuchos::RCP<const RowGraph<LocalOrdinal,GlobalOrdinal,Node> > getGraph() const = 0;
//! The global number of rows of this matrix.
virtual global_size_t getGlobalNumRows() const = 0;
//! The global number of columns of this matrix.
virtual global_size_t getGlobalNumCols() const = 0;
//! The number of rows owned by the calling process.
virtual size_t getNodeNumRows() const = 0;
/// \brief The number of columns needed to apply the forward operator on this node.
///
/// This is the same as the number of elements listed in the
/// column Map. It is <i>not</i> necessarily the same as the
/// number of domain Map elements owned by the calling process.
virtual size_t getNodeNumCols() const = 0;
//! The index base for global indices in this matrix.
virtual GlobalOrdinal getIndexBase() const = 0;
//! The global number of stored (structurally nonzero) entries.
virtual global_size_t getGlobalNumEntries() const = 0;
//! The local number of stored (structurally nonzero) entries.
virtual size_t getNodeNumEntries() const = 0;
/// \brief The current number of entries on the calling process in the specified global row.
///
/// Note that if the row Map is overlapping, then the calling
/// process might not necessarily store all the entries in the
/// row. Some other process might have the rest of the entries.
///
/// \return <tt>Teuchos::OrdinalTraits<size_t>::invalid()</tt> if
/// the specified global row does not belong to this graph, else
/// the number of entries.
virtual size_t getNumEntriesInGlobalRow (GlobalOrdinal globalRow) const = 0;
/// \brief The current number of entries on the calling process in the specified local row.
///
/// Note that if the row Map is overlapping, then the calling
/// process might not necessarily store all the entries in the
/// row. Some other process might have the rest of the entries.
///
/// \return <tt>Teuchos::OrdinalTraits<size_t>::invalid()</tt> if
/// the specified local row is not valid for this graph, else
/// the number of entries.
virtual size_t getNumEntriesInLocalRow(LocalOrdinal localRow) const = 0;
//! The number of global diagonal entries, based on global row/column index comparisons.
virtual global_size_t getGlobalNumDiags() const = 0;
//! The number of local diagonal entries, based on global row/column index comparisons.
virtual size_t getNodeNumDiags() const = 0;
//! The maximum number of entries across all rows/columns on all nodes.
virtual size_t getGlobalMaxNumRowEntries() const = 0;
//! The maximum number of entries across all rows/columns on this node.
virtual size_t getNodeMaxNumRowEntries() const = 0;
//! Whether this matrix has a well-defined column map.
virtual bool hasColMap() const = 0;
//! Whether this matrix is lower triangular.
virtual bool isLowerTriangular() const = 0;
//! Whether this matrix is upper triangular.
virtual bool isUpperTriangular() const = 0;
/// \brief Whether matrix indices are locally indexed.
///
/// A RowMatrix may store column indices either as global indices
/// (of type <tt>GlobalOrdinal</tt>), or as local indices (of type
/// <tt>LocalOrdinal</tt>). In some cases (for example, if the
/// column Map has not been computed), it is not possible to
/// switch from global to local indices without extra work.
/// Furthermore, some operations only work for one or the other
/// case.
virtual bool isLocallyIndexed() const = 0;
/// \brief Whether matrix indices are globally indexed.
///
/// A RowMatrix may store column indices either as global indices
/// (of type <tt>GlobalOrdinal</tt>), or as local indices (of type
/// <tt>LocalOrdinal</tt>). In some cases (for example, if the
/// column Map has not been computed), it is not possible to
/// switch from global to local indices without extra work.
/// Furthermore, some operations only work for one or the other
/// case.
virtual bool isGloballyIndexed() const = 0;
//! Whether fillComplete() has been called.
virtual bool isFillComplete() const = 0;
//! Whether this object implements getLocalRowView() and getGlobalRowView().
virtual bool supportsRowViews() const = 0;
//@}
//! @name Extraction Methods
//@{
/// \brief Get a copy of the given global row's entries.
///
/// This method only gets the entries in the given row that are
/// stored on the calling process. Note that if the matrix has an
/// overlapping row Map, it is possible that the calling process
/// does not store all the entries in that row.
///
/// \param GlobalRow [in] Global index of the row.
/// \param Indices [out] Global indices of the columns
/// corresponding to values.
/// \param Values [out] Matrix values.
/// \param NumEntries [out] Number of stored entries on the
/// calling process; length of Indices and Values.
///
/// This method throws <tt>std::runtime_error</tt> if either
/// Indices or Values is not large enough to hold the data
/// associated with row GlobalRow. If GlobalRow does not belong to
/// the calling process, then the method sets NumIndices to
/// <tt>Teuchos::OrdinalTraits<size_t>::invalid()</tt>, and does
/// not modify Indices or Values.
virtual void
getGlobalRowCopy (GlobalOrdinal GlobalRow,
const Teuchos::ArrayView<GlobalOrdinal> &Indices,
const Teuchos::ArrayView<Scalar> &Values,
size_t &NumEntries) const = 0;
/// \brief Get a copy of the given local row's entries.
///
/// This method only gets the entries in the given row that are
/// stored on the calling process. Note that if the matrix has an
/// overlapping row Map, it is possible that the calling process
/// does not store all the entries in that row.
///
/// \param LocalRow [in] Local index of the row.
/// \param Indices [out] Local indices of the columns
/// corresponding to values.
/// \param Values [out] Matrix values.
/// \param NumEntries [out] Number of stored entries on the
/// calling process; length of Indices and Values.
///
/// This method throws <tt>std::runtime_error</tt> if either
/// Indices or Values is not large enough to hold the data
/// associated with row LocalRow. If LocalRow does not belong to
/// the calling process, then the method sets NumIndices to
/// <tt>Teuchos::OrdinalTraits<size_t>::invalid()</tt>, and does
/// not modify Indices or Values.
virtual void
getLocalRowCopy (LocalOrdinal LocalRow,
const Teuchos::ArrayView<LocalOrdinal> &Indices,
const Teuchos::ArrayView<Scalar> &Values,
size_t &NumEntries) const = 0;
/// \brief Get a constant, nonpersisting, globally indexed view of
/// the given row of the matrix.
///
/// The returned views of the column indices and values are not
/// guaranteed to persist beyond the lifetime of <tt>this</tt>.
/// Furthermore, some RowMatrix implementations allow changing the
/// values, or the indices and values. Any such changes
/// invalidate the returned views.
///
/// This method only gets the entries in the given row that are
/// stored on the calling process. Note that if the matrix has an
/// overlapping row Map, it is possible that the calling process
/// does not store all the entries in that row.
///
/// \pre <tt>isGloballyIndexed () && supportsRowViews ()</tt>
/// \post <tt>indices.size () == getNumEntriesInGlobalRow (GlobalRow)</tt>
///
/// \param GlobalRow [in] Global index of the row.
/// \param Indices [out] Global indices of the columns
/// corresponding to values.
/// \param Values [out] Matrix values.
///
/// If \c GlobalRow does not belong to this node, then \c indices
/// is set to \c null.
virtual void
getGlobalRowView (GlobalOrdinal GlobalRow,
Teuchos::ArrayView<const GlobalOrdinal> &indices,
Teuchos::ArrayView<const Scalar> &values) const = 0;
/// \brief Get a constant, nonpersisting, locally indexed view of
/// the given row of the matrix.
///
/// The returned views of the column indices and values are not
/// guaranteed to persist beyond the lifetime of <tt>this</tt>.
/// Furthermore, some RowMatrix implementations allow changing the
/// values, or the indices and values. Any such changes
/// invalidate the returned views.
///
/// This method only gets the entries in the given row that are
/// stored on the calling process. Note that if the matrix has an
/// overlapping row Map, it is possible that the calling process
/// does not store all the entries in that row.
///
/// \pre <tt>isLocallyIndexed () && supportsRowViews ()</tt>
/// \post <tt>indices.size () == getNumEntriesInGlobalRow (LocalRow)</tt>
///
/// \param LocalRow [in] Local index of the row.
/// \param Indices [out] Local indices of the columns
/// corresponding to values.
/// \param Values [out] Matrix values.
///
/// If \c LocalRow does not belong to this node, then \c indices
/// is set to \c null.
virtual void
getLocalRowView (LocalOrdinal LocalRow,
Teuchos::ArrayView<const LocalOrdinal>& indices,
Teuchos::ArrayView<const Scalar>& values) const = 0;
/// \brief Get a constant, nonpersisting, locally indexed view of
/// the given row of the matrix, using "raw" pointers instead of
/// Teuchos::ArrayView.
///
/// The returned views of the column indices and values are not
/// guaranteed to persist beyond the lifetime of <tt>this</tt>.
/// Furthermore, some RowMatrix implementations allow changing the
/// values, or the indices and values. Any such changes
/// invalidate the returned views.
///
/// This method only gets the entries in the given row that are
/// stored on the calling process. Note that if the matrix has an
/// overlapping row Map, it is possible that the calling process
/// does not store all the entries in that row.
///
/// \pre <tt>isLocallyIndexed () && supportsRowViews ()</tt>
/// \post <tt>numEnt == getNumEntriesInGlobalRow (LocalRow)</tt>
///
/// \param lclRow [in] Local index of the row.
/// \param numEnt [out] Number of entries in the row that are
/// stored on the calling process.
/// \param lclColInds [out] Local indices of the columns
/// corresponding to values.
/// \param vals [out] Matrix values.
///
/// \return Error code; zero on no error.
virtual LocalOrdinal
getLocalRowViewRaw (const LocalOrdinal lclRow,
LocalOrdinal& numEnt,
const LocalOrdinal*& lclColInds,
const Scalar*& vals) const;
/// \brief Get a copy of the diagonal entries, distributed by the row Map.
///
/// On input, the Vector's Map must be the same as the row Map of the matrix.
/// (That is, <tt>this->getRowMap ()->isSameAs (* (diag.getMap ())) == true</tt>.)
///
/// On return, the entries of \c diag are filled with the diagonal
/// entries of the matrix stored on this process. Note that if
/// the row Map is overlapping, multiple processes may own the
/// same diagonal element. You may combine these overlapping
/// diagonal elements by doing an Export from the row Map Vector
/// to a range Map Vector.
virtual void getLocalDiagCopy (Vector<Scalar, LocalOrdinal, GlobalOrdinal, Node, Node::classic> &diag) const = 0;
//@}
//! \name Mathematical methods
//@{
/**
* \brief Scale the RowMatrix on the left with the given Vector x.
*
* On return, for all entries i,j in the matrix, \f$A(i,j) = x(i)*A(i,j)\f$.
*/
virtual void leftScale (const Vector<Scalar, LocalOrdinal, GlobalOrdinal, Node, Node::classic>& x) = 0;
/**
* \brief Scale the RowMatrix on the right with the given Vector x.
*
* On return, for all entries i,j in the matrix, \f$A(i,j) = x(j)*A(i,j)\f$.
*/
virtual void rightScale (const Vector<Scalar, LocalOrdinal, GlobalOrdinal, Node, Node::classic>& x) = 0;
/// \brief The Frobenius norm of the matrix.
///
/// This method computes and returns the Frobenius norm of the
/// matrix. The Frobenius norm \f$\|A\|_F\f$ for the matrix
/// \f$A\f$ is defined as
/// \f$\|A\|_F = \sqrt{ \sum_{i,j} |\a_{ij}|^2 }\f$.
/// It has the same value as the Euclidean norm of a vector made
/// by stacking the columns of \f$A\f$.
virtual mag_type getFrobeniusNorm() const = 0;
/// \brief Return a new RowMatrix which is the result of <tt>beta*this + alpha*A</tt>.
///
/// The new RowMatrix is actually a CrsMatrix (which see). Note
/// that RowMatrix is a read-only interface (not counting the left
/// and right scale methods), so it is impossible to implement an
/// in-place add using just that interface.
///
/// For brevity, call this matrix B, and the result matrix C. C's
/// row Map will be identical to B's row Map. It is correct,
/// though less efficient, for A and B not to have the same row
/// Maps. We could make C's row Map the union of the two row Maps
/// in that case. However, we don't want row Maps to grow for a
/// repeated sequence of additions with matrices with different
/// row Maps. Furthermore, the fact that the user called this
/// method on B, rather than on A, suggests a preference for using
/// B's distribution. The most reasonable thing to do, then, is
/// to use B's row Map for C.
///
/// A and B must have identical or congruent communicators. This
/// method must be called as a collective over B's communicator.
///
/// The parameters are optional and may be null. Here are the
/// parameters that this function accepts:
/// - "Call fillComplete" (\c bool): If true, call fillComplete on
/// the result matrix C. This is \c true by default.
/// - "Constructor parameters" (sublist): If provided, give these
/// parameters to C's constructor.
/// - "fillComplete parameters" (sublist): If provided, and if
/// "Call fillComplete" is true, then give these parameters to
/// C's fillComplete call.
///
/// It is not strictly necessary that a RowMatrix always have a
/// domain and range Map. For example, a CrsMatrix does not have
/// a domain and range Map until after its first fillComplete
/// call. Neither A nor B need to have a domain and range Map in
/// order to call add(). If at least one of them has a domain and
/// range Map, you need not supply a domain and range Map to this
/// method. If you ask this method to call fillComplete on C (it
/// does by default), it will supply the any missing domain or
/// range Maps from either B's or A's (in that order) domain and
/// range Maps. If neither A nor B have a domain and range Map,
/// and if you ask this method to call fillComplete, then you
/// <i>must</i> supply both a domain Map and a range Map to this
/// method.
///
/// This method comes with a default implementation, since the
/// RowMatrix interface suffices for implementing it. Subclasses
/// (like CrsMatrix) may override this implementation, for example
/// to improve its performance, given additional knowledge about
/// the subclass. Subclass implementations may need to do a
/// dynamic cast on A in order to know its type.
virtual Teuchos::RCP<RowMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node> >
add (const Scalar& alpha,
const RowMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>& A,
const Scalar& beta,
const Teuchos::RCP<const Map<LocalOrdinal, GlobalOrdinal, Node> >& domainMap = Teuchos::null,
const Teuchos::RCP<const Map<LocalOrdinal, GlobalOrdinal, Node> >& rangeMap = Teuchos::null,
const Teuchos::RCP<Teuchos::ParameterList>& params = Teuchos::null) const;
//@}
//! \name Implementation of Packable interface
//@{
private:
bool
packRow (char* const numEntOut,
char* const valOut,
char* const indOut,
const size_t numEnt,
const LocalOrdinal lclRow) const;
// TODO (mfh 25 Jan 2015) Could just make this "protected" and let
// CrsMatrix use it, since it's exactly the same there.
void
allocatePackSpace (Teuchos::Array<char>& exports,
size_t& totalNumEntries,
const Teuchos::ArrayView<const LocalOrdinal>& exportLIDs) const;
/// \brief Pack this object's data for an Import or Export.
///
/// \warning To be called only by the default implementation of
/// pack() (see below).
void
packImpl (const Teuchos::ArrayView<const LocalOrdinal>& exportLIDs,
Teuchos::Array<char>& exports,
const Teuchos::ArrayView<size_t>& numPacketsPerLID,
size_t& constantNumPackets,
Distributor& distor) const;
public:
/// \brief Pack this object's data for an Import or Export.
///
/// \warning To be called only by the packAndPrepare method of
/// appropriate classes of DistObject.
///
/// Subclasses may override this method to speed up or otherwise
/// improve the implementation by exploiting more specific details
/// of the subclass.
virtual void
pack (const Teuchos::ArrayView<const LocalOrdinal>& exportLIDs,
Teuchos::Array<char>& exports,
const Teuchos::ArrayView<size_t>& numPacketsPerLID,
size_t& constantNumPackets,
Distributor& distor) const;
//@}
}; // class RowMatrix
} // namespace Tpetra
#endif // TPETRA_ROWMATRIX_DECL_HPP
|