46 #ifndef XPETRA_TPETRAVECTOR_HPP 47 #define XPETRA_TPETRAVECTOR_HPP 62 #include "Tpetra_Vector.hpp" 67 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
68 RCP<Tpetra::Vector<Scalar,LocalOrdinal, GlobalOrdinal, Node> >
toTpetra(Vector<Scalar,LocalOrdinal, GlobalOrdinal, Node> &);
70 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
71 RCP<Tpetra::Vector<Scalar,LocalOrdinal, GlobalOrdinal, Node> >
toTpetra(
const Vector<Scalar,LocalOrdinal, GlobalOrdinal, Node> &);
73 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
74 RCP<const Vector<Scalar, LocalOrdinal, GlobalOrdinal, Node > >
toXpetra(RCP<
const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > vec);
76 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
77 RCP<Vector<Scalar, LocalOrdinal, GlobalOrdinal, Node > >
toXpetra(RCP<Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > vec);
82 template <class Scalar = Vector<>::scalar_type,
87 :
public virtual Vector<Scalar,LocalOrdinal,GlobalOrdinal,Node>,
88 public TpetraMultiVector<Scalar,LocalOrdinal,GlobalOrdinal,Node>
90 #undef XPETRA_TPETRAMULTIVECTOR_SHORT 114 :
TpetraMultiVector<Scalar,LocalOrdinal,GlobalOrdinal,Node> (map,A,map->getNodeNumElements(),1) { }
182 #ifdef HAVE_XPETRA_KOKKOS_REFACTOR 186 typename dual_view_type::t_host_um getHostLocalView ()
const {
190 typename dual_view_type::t_dev_um getDeviceLocalView()
const {
204 template<
class TargetDeviceType>
205 typename Kokkos::Impl::if_c<
206 Kokkos::Impl::is_same<
207 typename dual_view_type::t_dev_um::execution_space::memory_space,
208 typename TargetDeviceType::memory_space>::value,
209 typename dual_view_type::t_dev_um,
210 typename dual_view_type::t_host_um>::type
211 getLocalView ()
const {
220 #ifdef HAVE_XPETRA_EPETRA 222 #if ((defined(EPETRA_HAVE_OMP) && (!defined(HAVE_TPETRA_INST_OPENMP) || !defined(HAVE_TPETRA_INST_INT_INT))) || \ 223 (!defined(EPETRA_HAVE_OMP) && (!defined(HAVE_TPETRA_INST_SERIAL) || !defined(HAVE_TPETRA_INST_INT_INT)))) 226 template <
class Scalar>
228 :
public virtual Vector<Scalar,int,int,EpetraNode>,
235 #undef XPETRA_TPETRAMULTIVECTOR_SHORT 261 :
TpetraMultiVector<Scalar,LocalOrdinal,GlobalOrdinal,Node> (map,A,map->getNodeNumElements(),1) {
331 #ifdef HAVE_XPETRA_KOKKOS_REFACTOR 335 typename dual_view_type::t_host_um getHostLocalView ()
const {
336 typename dual_view_type::t_host_um ret;
340 typename dual_view_type::t_dev_um getDeviceLocalView()
const {
341 typename dual_view_type::t_dev_um ret;
355 template<
class TargetDeviceType>
356 typename Kokkos::Impl::if_c<
357 Kokkos::Impl::is_same<
358 typename dual_view_type::t_dev_um::execution_space::memory_space,
359 typename TargetDeviceType::memory_space>::value,
360 typename dual_view_type::t_dev_um,
361 typename dual_view_type::t_host_um>::type
362 getLocalView ()
const {
363 typename Kokkos::Impl::if_c<
364 Kokkos::Impl::is_same<
365 typename dual_view_type::t_dev_um::execution_space::memory_space,
366 typename TargetDeviceType::memory_space>::value,
367 typename dual_view_type::t_dev_um,
368 typename dual_view_type::t_host_um>::type ret;
378 #if ((defined(EPETRA_HAVE_OMP) && (!defined(HAVE_TPETRA_INST_OPENMP) || !defined(HAVE_TPETRA_INST_INT_LONG_LONG))) || \ 379 (!defined(EPETRA_HAVE_OMP) && (!defined(HAVE_TPETRA_INST_SERIAL) || !defined(HAVE_TPETRA_INST_INT_LONG_LONG)))) 382 template <
class Scalar>
384 :
public virtual Vector<Scalar,int,long long,EpetraNode>,
391 #undef XPETRA_TPETRAMULTIVECTOR_SHORT 417 :
TpetraMultiVector<Scalar,LocalOrdinal,GlobalOrdinal,Node> (map,A,map->getNodeNumElements(),1) {
487 #ifdef HAVE_XPETRA_KOKKOS_REFACTOR 491 typename dual_view_type::t_host_um getHostLocalView ()
const {
492 typename dual_view_type::t_host_um ret;
496 typename dual_view_type::t_dev_um getDeviceLocalView()
const {
497 typename dual_view_type::t_dev_um ret;
511 template<
class TargetDeviceType>
512 typename Kokkos::Impl::if_c<
513 Kokkos::Impl::is_same<
514 typename dual_view_type::t_dev_um::execution_space::memory_space,
515 typename TargetDeviceType::memory_space>::value,
516 typename dual_view_type::t_dev_um,
517 typename dual_view_type::t_host_um>::type
518 getLocalView ()
const {
519 typename Kokkos::Impl::if_c<
520 Kokkos::Impl::is_same<
521 typename dual_view_type::t_dev_um::execution_space::memory_space,
522 typename TargetDeviceType::memory_space>::value,
523 typename dual_view_type::t_dev_um,
524 typename dual_view_type::t_host_um>::type ret;
533 #endif // HAVE_XPETRA_EPETRA 536 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
540 return tX.getTpetra_Vector();
543 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
547 return tX.getTpetra_Vector();
550 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
555 return Teuchos::null;
558 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
561 return toXpetra(Teuchos::rcp_const_cast<Tpetra::Vector<Scalar, LocalOrdinal, GlobalOrdinal, Node > > (vec));
568 #define XPETRA_TPETRAVECTOR_SHORT 569 #endif // XPETRA_TPETRAVECTOR_HPP Teuchos::ScalarTraits< Scalar >::magnitudeType norm1() const
Return 1-norm of this Vector.
std::string description() const
Return a simple one-line description of this object.
void sumIntoLocalValue(LocalOrdinal myRow, const Scalar &value)
Adds specified value to existing value at the specified location.
void norm1(const Teuchos::ArrayView< typename Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
Compute 1-norm of each vector in multi-vector.
TpetraVector(const Teuchos::RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &vec)
TpetraMultiVector constructor to wrap a Tpetra::MultiVector object.
virtual ~TpetraVector()
Destructor.
void dot(const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Teuchos::ArrayView< Scalar > &dots) const
Compute dot product of each corresponding pair of vectors, dots[i] = this[i].dot(A[i]).
TpetraVector(const Teuchos::RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &vec)
TpetraMultiVector constructor to wrap a Tpetra::MultiVector object.
LocalOrdinal local_ordinal_type
void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
Print the object with some verbosity level to an FancyOStream object.
void sumIntoGlobalValue(GlobalOrdinal globalRow, const Scalar &value)
Adds specified value to existing value at the specified location.
Scalar meanValue() const
Compute mean (average) value of this Vector.
RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > getTpetra_MultiVector() const
Get the underlying Tpetra multivector.
void normInf(const Teuchos::ArrayView< typename Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
Compute Inf-norm of each vector in multi-vector.
GlobalOrdinal global_ordinal_type
Teuchos::ScalarTraits< Scalar >::magnitudeType normInf() const
Compute Inf-norm of this Vector.
Teuchos::ScalarTraits< Scalar >::magnitudeType norm2() const
Compute 2-norm of this Vector.
void replaceGlobalValue(GlobalOrdinal globalRow, size_t vectorIndex, const Scalar &value)
Replace value, using global (row) index.
void meanValue(const Teuchos::ArrayView< Scalar > &means) const
Compute mean (average) value of each vector in multi-vector. The outcome of this routine is undefined...
void replaceGlobalValue(GlobalOrdinal globalRow, const Scalar &value)
Replace current value at the specified location with specified value.
TpetraVector(const Teuchos::RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &vec)
TpetraMultiVector constructor to wrap a Tpetra::MultiVector object.
void sumIntoGlobalValue(GlobalOrdinal globalRow, const Scalar &value)
Adds specified value to existing value at the specified location.
TpetraVector(const Teuchos::RCP< const Map > &map, const Teuchos::ArrayView< const Scalar > &A)
Set multi-vector values from an array using Teuchos memory management classes. (copy) ...
void replaceLocalValue(LocalOrdinal myRow, const Scalar &value)
Replace current value at the specified location with specified values.
Teuchos::ScalarTraits< Scalar >::magnitudeType normWeighted(const Vector &weights) const
Compute Weighted 2-norm (RMS Norm) of this Vector.
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
Scalar dot(const Vector &a) const
Computes dot product of this Vector against input Vector x.
void replaceGlobalValue(GlobalOrdinal globalRow, const Scalar &value)
Replace current value at the specified location with specified value.
Teuchos::ScalarTraits< Scalar >::magnitudeType norm1() const
Return 1-norm of this Vector.
void sumIntoLocalValue(LocalOrdinal myRow, const Scalar &value)
Adds specified value to existing value at the specified location.
Teuchos::ScalarTraits< Scalar >::magnitudeType norm2() const
Compute 2-norm of this Vector.
void replaceLocalValue(LocalOrdinal myRow, size_t vectorIndex, const Scalar &value)
Replace value, using local (row) index.
#define XPETRA_TPETRA_ETI_EXCEPTION(cl, obj, go)
void sumIntoLocalValue(LocalOrdinal myRow, size_t vectorIndex, const Scalar &value)
Add value to existing value, using local (row) index.
Teuchos::ScalarTraits< Scalar >::magnitudeType norm2() const
Compute 2-norm of this Vector.
std::string description() const
Return a simple one-line description of this object.
void sumIntoGlobalValue(GlobalOrdinal globalRow, size_t vectorIndex, const Scalar &value)
Add value to existing value, using global (row) index.
Teuchos::ScalarTraits< Scalar >::magnitudeType norm1() const
Return 1-norm of this Vector.
Scalar meanValue() const
Compute mean (average) value of this Vector.
virtual ~TpetraVector()
Destructor.
#define XPETRA_DYNAMIC_CAST(type, obj, newObj, exceptionMsg)
static const EVerbosityLevel verbLevel_default
void sumIntoGlobalValue(GlobalOrdinal globalRow, const Scalar &value)
Adds specified value to existing value at the specified location.
void replaceLocalValue(LocalOrdinal myRow, const Scalar &value)
Replace current value at the specified location with specified values.
static magnitudeType magnitude(T a)
RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > getTpetra_Vector() const
Get the underlying Tpetra multivector.
RCP< const Tpetra::CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > toTpetra(const RCP< const CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > &graph)
RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > getTpetra_Vector() const
Get the underlying Tpetra multivector.
void norm2(const Teuchos::ArrayView< typename Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
RCP< const CrsGraph< int, GlobalOrdinal, Node > > toXpetra(const Epetra_CrsGraph &g)
RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > getTpetra_Vector() const
Get the underlying Tpetra multivector.
Teuchos::ScalarTraits< Scalar >::magnitudeType normWeighted(const Vector &weights) const
Compute Weighted 2-norm (RMS Norm) of this Vector.
Teuchos::ScalarTraits< Scalar >::magnitudeType normInf() const
Compute Inf-norm of this Vector.
void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
Print the object with some verbosity level to an FancyOStream object.
Teuchos::ScalarTraits< Scalar >::magnitudeType normInf() const
Compute Inf-norm of this Vector.
void sumIntoLocalValue(LocalOrdinal myRow, const Scalar &value)
Adds specified value to existing value at the specified location.
void replaceLocalValue(LocalOrdinal myRow, const Scalar &value)
Replace current value at the specified location with specified values.
TpetraVector(const Teuchos::RCP< const Map > &map, const Teuchos::ArrayView< const Scalar > &A)
Set multi-vector values from an array using Teuchos memory management classes. (copy) ...
std::string description() const
Return a simple one-line description of this object.
#define XPETRA_MONITOR(funcName)
TpetraVector(const Teuchos::RCP< const Map > &map, const Teuchos::ArrayView< const Scalar > &A)
Set multi-vector values from an array using Teuchos memory management classes. (copy) ...
TpetraVector(const Teuchos::RCP< const Map > &map, bool zeroOut=true)
Sets all vector entries to zero.
Scalar dot(const Vector &a) const
Computes dot product of this Vector against input Vector x.
void replaceGlobalValue(GlobalOrdinal globalRow, const Scalar &value)
Replace current value at the specified location with specified value.
Scalar dot(const Vector &a) const
Computes dot product of this Vector against input Vector x.
Scalar meanValue() const
Compute mean (average) value of this Vector.
TpetraVector(const Teuchos::RCP< const Map > &map, bool zeroOut=true)
Sets all vector entries to zero.
virtual ~TpetraVector()
Destructor.
Teuchos::ScalarTraits< Scalar >::magnitudeType normWeighted(const Vector &weights) const
Compute Weighted 2-norm (RMS Norm) of this Vector.
void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
Print the object with some verbosity level to an FancyOStream object.
TpetraVector(const Teuchos::RCP< const Map > &map, bool zeroOut=true)
Sets all vector entries to zero.