MueLu  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node > Class Template Reference

Matrix-free tentative restrictor operator. More...

#include <MueLu_MatrixFreeTentativeP_decl.hpp>

Inheritance diagram for MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >:
Xpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > Teuchos::Describable Teuchos::LabeledObject

Public Types

typedef LocalOrdinal local_ordinal_type
 
typedef GlobalOrdinal global_ordinal_type
 
typedef Node::execution_space execution_space
 
typedef Kokkos::RangePolicy
< local_ordinal_type,
execution_space
range_type
 
typedef Kokkos::MDRangePolicy
< local_ordinal_type,
execution_space, Kokkos::Rank< 2 > > 
md_range_type
 
typedef Node node_type
 
typedef Teuchos::ScalarTraits
< Scalar >::coordinateType 
real_type
 

Public Member Functions

void apply (const MultiVector &X, MultiVector &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=Teuchos::ScalarTraits< Scalar >::one(), Scalar beta=Teuchos::ScalarTraits< Scalar >::zero()) const override
 
void residual (const MultiVector &X, const MultiVector &B, MultiVector &R) const override
 
const Teuchos::RCP< const MapgetRangeMap () const override
 
const Teuchos::RCP< const MapgetDomainMap () const override
 
Teuchos::RCP< const AggregatesgetAggregates () const
 
- Public Member Functions inherited from Xpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node >
virtual void removeEmptyProcessesInPlace (const RCP< const Map > &)
 
- Public Member Functions inherited from Teuchos::Describable
virtual std::string description () const
 
virtual void describe (FancyOStream &out, const EVerbosityLevel verbLevel=verbLevel_default) const
 
void describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const
 
virtual ~Describable ()
 
 LabeledObject ()
 
virtual ~LabeledObject ()
 
virtual void setObjectLabel (const std::string &objectLabel)
 
virtual std::string getObjectLabel () const
 
DescribableStreamManipulatorState describe (const Describable &describable, const EVerbosityLevel verbLevel=Describable::verbLevel_default)
 
std::ostream & operator<< (std::ostream &os, const DescribableStreamManipulatorState &d)
 

Private Attributes

const Teuchos::RCP< const Mapfine_map_
 
const Teuchos::RCP< const Mapcoarse_map_
 
const Teuchos::RCP< const
Aggregates
aggregates_
 

Constructors/Destructors.

 MatrixFreeTentativeP (Teuchos::RCP< const Map > coarse_map, Teuchos::RCP< const Map > fine_map, Teuchos::RCP< const Aggregates > aggregates)
 Constructor. More...
 
 ~MatrixFreeTentativeP ()=default
 Destructor. More...
 

Additional Inherited Members

- Static Public Attributes inherited from Teuchos::Describable
static const EVerbosityLevel verbLevel_default
 

Detailed Description

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
class MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >

Matrix-free tentative restrictor operator.

Definition at line 73 of file MueLu_MatrixFreeTentativeP_decl.hpp.

Member Typedef Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
typedef LocalOrdinal MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::local_ordinal_type

Definition at line 75 of file MueLu_MatrixFreeTentativeP_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
typedef GlobalOrdinal MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::global_ordinal_type

Definition at line 76 of file MueLu_MatrixFreeTentativeP_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
typedef Node::execution_space MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::execution_space

Definition at line 77 of file MueLu_MatrixFreeTentativeP_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
typedef Kokkos::RangePolicy<local_ordinal_type, execution_space> MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::range_type

Definition at line 78 of file MueLu_MatrixFreeTentativeP_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
typedef Kokkos::MDRangePolicy<local_ordinal_type, execution_space, Kokkos::Rank<2> > MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::md_range_type

Definition at line 79 of file MueLu_MatrixFreeTentativeP_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
typedef Node MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::node_type

Definition at line 80 of file MueLu_MatrixFreeTentativeP_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
typedef Teuchos::ScalarTraits<Scalar>::coordinateType MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::real_type

Definition at line 81 of file MueLu_MatrixFreeTentativeP_decl.hpp.

Constructor & Destructor Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::MatrixFreeTentativeP ( Teuchos::RCP< const Map coarse_map,
Teuchos::RCP< const Map fine_map,
Teuchos::RCP< const Aggregates aggregates 
)
inline

Constructor.

Definition at line 92 of file MueLu_MatrixFreeTentativeP_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::~MatrixFreeTentativeP ( )
default

Destructor.

Member Function Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::apply ( const MultiVector X,
MultiVector Y,
Teuchos::ETransp  mode = Teuchos::NO_TRANS,
Scalar  alpha = Teuchos::ScalarTraits<Scalar>::one(),
Scalar  beta = Teuchos::ScalarTraits<Scalar>::zero() 
) const
overridevirtual
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::residual ( const MultiVector X,
const MultiVector B,
MultiVector R 
) const
override

Definition at line 117 of file MueLu_MatrixFreeTentativeP_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
const Teuchos::RCP<const Map> MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getRangeMap ( ) const
inlineoverridevirtual
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
const Teuchos::RCP<const Map> MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getDomainMap ( ) const
inlineoverridevirtual
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<const Aggregates> MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getAggregates ( ) const
inline

Definition at line 118 of file MueLu_MatrixFreeTentativeP_decl.hpp.

Member Data Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
const Teuchos::RCP<const Map> MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::fine_map_
private

Definition at line 124 of file MueLu_MatrixFreeTentativeP_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
const Teuchos::RCP<const Map> MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::coarse_map_
private

Definition at line 127 of file MueLu_MatrixFreeTentativeP_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
const Teuchos::RCP<const Aggregates> MueLu::MatrixFreeTentativeP< Scalar, LocalOrdinal, GlobalOrdinal, Node >::aggregates_
private

Definition at line 130 of file MueLu_MatrixFreeTentativeP_decl.hpp.


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