Xpetra  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Macros Pages
Xpetra::TpetraOperator< double, int, long long, EpetraNode > Class Template Reference

#include <Xpetra_TpetraOperator.hpp>

Inheritance diagram for Xpetra::TpetraOperator< double, int, long long, EpetraNode >:
Xpetra::Operator< double, int, long long, EpetraNode >

Public Types

typedef double Scalar
 
typedef long long GlobalOrdinal
 
typedef int LocalOrdinal
 
typedef EpetraNode Node
 
- Public Types inherited from Xpetra::Operator< double, int, long long, EpetraNode >
typedef double scalar_type
 The type of the entries of the input and output multivectors. More...
 
typedef int local_ordinal_type
 The local index type. More...
 
typedef long long global_ordinal_type
 The global index type. More...
 
typedef EpetraNode node_type
 The Kokkos Node type. More...
 
virtual Teuchos::RCP< const
Xpetra::Map< LocalOrdinal,
GlobalOrdinal, Node > > 
getDomainMap () const
 The Map associated with the domain of this operator, which must be compatible with X.getMap(). More...
 
virtual Teuchos::RCP< const
Xpetra::Map< LocalOrdinal,
GlobalOrdinal, Node > > 
getRangeMap () const
 The Map associated with the range of this operator, which must be compatible with Y.getMap(). More...
 
virtual void apply (const Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &X, Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=Teuchos::ScalarTraits< Scalar >::one(), Scalar beta=Teuchos::ScalarTraits< Scalar >::zero()) const
 Computes the operator-multivector application. More...
 
virtual bool hasTransposeApply () const
 Whether this operator supports applying the transpose or conjugate transpose. More...
 

Overridden from Teuchos::Describable

std::string description () const
 A simple one-line description of this object. More...
 
void describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
 Print the object with the given verbosity level to a FancyOStream. More...
 

Xpetra specific

 TpetraOperator (const Teuchos::RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &op)
 TpetraOperator constructor to wrap a Tpetra::Operator object. More...
 
RCP< Tpetra::Operator< Scalar,
LocalOrdinal, GlobalOrdinal,
Node > > 
getOperator ()
 Gets the operator out. More...
 
void residual (const Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &X, const Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &B, Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &R) const
 

Additional Inherited Members

- Public Member Functions inherited from Xpetra::Operator< double, int, long long, EpetraNode >
virtual ~Operator ()
 
virtual void removeEmptyProcessesInPlace (const RCP< const Map > &)
 
virtual void residual (const MultiVector &X, const MultiVector &B, MultiVector &R) const =0
 Compute a residual R = B - (*this) * X. More...
 
virtual void apply (const MultiVector &X, MultiVector &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, doublealpha=Teuchos::ScalarTraits< double >::one(), doublebeta=Teuchos::ScalarTraits< double >::zero()) const =0
 Computes the operator-multivector application. More...
 

Detailed Description

template<>
class Xpetra::TpetraOperator< double, int, long long, EpetraNode >

Definition at line 221 of file Xpetra_TpetraOperator.hpp.

Member Typedef Documentation

typedef double Xpetra::TpetraOperator< double, int, long long, EpetraNode >::Scalar

Definition at line 224 of file Xpetra_TpetraOperator.hpp.

typedef long long Xpetra::TpetraOperator< double, int, long long, EpetraNode >::GlobalOrdinal

Definition at line 225 of file Xpetra_TpetraOperator.hpp.

typedef int Xpetra::TpetraOperator< double, int, long long, EpetraNode >::LocalOrdinal

Definition at line 226 of file Xpetra_TpetraOperator.hpp.

typedef EpetraNode Xpetra::TpetraOperator< double, int, long long, EpetraNode >::Node

Definition at line 227 of file Xpetra_TpetraOperator.hpp.

Constructor & Destructor Documentation

Xpetra::TpetraOperator< double, int, long long, EpetraNode >::TpetraOperator ( const Teuchos::RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &  op)
inline

TpetraOperator constructor to wrap a Tpetra::Operator object.

Definition at line 274 of file Xpetra_TpetraOperator.hpp.

Member Function Documentation

virtual Teuchos::RCP<const Xpetra::Map<LocalOrdinal,GlobalOrdinal,Node> > Xpetra::TpetraOperator< double, int, long long, EpetraNode >::getDomainMap ( ) const
inlinevirtual

The Map associated with the domain of this operator, which must be compatible with X.getMap().

Implements Xpetra::Operator< double, int, long long, EpetraNode >.

Definition at line 232 of file Xpetra_TpetraOperator.hpp.

virtual Teuchos::RCP<const Xpetra::Map<LocalOrdinal,GlobalOrdinal,Node> > Xpetra::TpetraOperator< double, int, long long, EpetraNode >::getRangeMap ( ) const
inlinevirtual

The Map associated with the range of this operator, which must be compatible with Y.getMap().

Implements Xpetra::Operator< double, int, long long, EpetraNode >.

Definition at line 237 of file Xpetra_TpetraOperator.hpp.

virtual void Xpetra::TpetraOperator< double, int, long long, EpetraNode >::apply ( const Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  X,
Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  Y,
Teuchos::ETransp  mode = Teuchos::NO_TRANS,
Scalar  alpha = Teuchos::ScalarTraits<Scalar>::one(),
Scalar  beta = Teuchos::ScalarTraits<Scalar>::zero() 
) const
inlinevirtual

Computes the operator-multivector application.

Loosely, performs \(Y = \alpha \cdot A^{\textrm{mode}} \cdot X + \beta \cdot Y\). However, the details of operation vary according to the values of alpha and beta. Specifically

  • if beta == 0, apply() must overwrite Y, so that any values in Y (including NaNs) are ignored.
  • if alpha == 0, apply() may short-circuit the operator, so that any values in X (including NaNs) are ignored.

Definition at line 248 of file Xpetra_TpetraOperator.hpp.

virtual bool Xpetra::TpetraOperator< double, int, long long, EpetraNode >::hasTransposeApply ( ) const
inlinevirtual

Whether this operator supports applying the transpose or conjugate transpose.

Reimplemented from Xpetra::Operator< double, int, long long, EpetraNode >.

Definition at line 255 of file Xpetra_TpetraOperator.hpp.

std::string Xpetra::TpetraOperator< double, int, long long, EpetraNode >::description ( ) const
inline

A simple one-line description of this object.

Definition at line 263 of file Xpetra_TpetraOperator.hpp.

void Xpetra::TpetraOperator< double, int, long long, EpetraNode >::describe ( Teuchos::FancyOStream &  out,
const Teuchos::EVerbosityLevel  verbLevel = Teuchos::Describable::verbLevel_default 
) const
inline

Print the object with the given verbosity level to a FancyOStream.

Definition at line 266 of file Xpetra_TpetraOperator.hpp.

RCP<Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node> > Xpetra::TpetraOperator< double, int, long long, EpetraNode >::getOperator ( )
inline

Gets the operator out.

Definition at line 277 of file Xpetra_TpetraOperator.hpp.

Definition at line 279 of file Xpetra_TpetraOperator.hpp.


The documentation for this class was generated from the following file: