Stokhos Package Browser (Single Doxygen Collection) Version of the Day
Loading...
Searching...
No Matches
Namespaces | Classes | Functions | Variables
Kokkos Namespace Reference

Namespaces

namespace  Compat
 
namespace  Details
 
namespace  Example
 
namespace  Experimental
 
namespace  Impl
 

Classes

struct  CijkType
 
struct  CijkType< ViewType, typename std::enable_if< is_view_uq_pce< ViewType >::value >::type >
 
struct  FlatArrayType
 
struct  FlatArrayType< View< D, P... >, typename std::enable_if< is_view_mp_vector< View< D, P... > >::value >::type >
 
struct  FlatArrayType< View< D, P... >, typename std::enable_if< is_view_uq_pce< View< D, P... > >::value >::type >
 
struct  IntrinsicScalarType
 
struct  is_view_mp_vector
 
struct  is_view_mp_vector< View< T, P... > >
 
struct  is_view_uq_pce
 
struct  is_view_uq_pce< View< T, P... > >
 
struct  LocalMPVectorView
 
struct  LocalMPVectorView< View< D, P... >, LocalSize, true >
 
struct  LocalMPVectorView< ViewType, LocalSize, false >
 
struct  LocalUQPCEView
 
struct  LocalUQPCEView< ViewType, LocalSize, 1, false >
 
struct  LocalUQPCEView< ViewType, LocalSize, 1, true >
 
struct  MPVectorWorkConfig
 Team-based parallel work configuration for Sacado::MP::Vector. More...
 
class  View< DataType, Arg1Type, Arg2Type, Arg3Type, Impl::ViewMPVectorInterlaced >
 View::value_type == Sacado::MP::Vector< Stokhos::StorageType<...> > More...
 

Functions

template<typename ValueType , typename Layout , typename Device >
Stokhos::CrsMatrix< ValueType, Device, Layout >::HostMirror create_mirror (const Stokhos::CrsMatrix< ValueType, Device, Layout > &A)
 
template<typename ValueType , typename Layout , typename Device >
Stokhos::CrsMatrix< ValueType, Device, Layout >::HostMirror create_mirror_view (const Stokhos::CrsMatrix< ValueType, Device, Layout > &A)
 
template<typename ValueType , typename Layout , typename DstDevice , typename SrcDevice >
void deep_copy (const Stokhos::CrsMatrix< ValueType, DstDevice, Layout > &dst, const Stokhos::CrsMatrix< ValueType, SrcDevice, Layout > &src)
 
template<typename ViewType >
ViewType make_view (const std::string &label, size_t N0=0, size_t N1=0, size_t N2=0, size_t N3=0, size_t N4=0, size_t N5=0, size_t N6=0, size_t N7=0)
 
template<typename ViewType >
ViewType make_view (const ViewAllocateWithoutInitializing &init, size_t N0=0, size_t N1=0, size_t N2=0, size_t N3=0, size_t N4=0, size_t N5=0, size_t N6=0, size_t N7=0)
 
template<typename ViewType >
ViewType make_view (typename ViewType::pointer_type ptr, size_t N0=0, size_t N1=0, size_t N2=0, size_t N3=0, size_t N4=0, size_t N5=0, size_t N6=0, size_t N7=0)
 
template<typename ViewType >
ViewType make_view (const std::string &label, const Impl::WithoutInitializing_t &init, size_t N0=0, size_t N1=0, size_t N2=0, size_t N3=0, size_t N4=0, size_t N5=0, size_t N6=0, size_t N7=0)
 
template<typename Storage >
KOKKOS_INLINE_FUNCTION void atomic_assign (volatile Sacado::UQ::PCE< Storage > *const dest, const Sacado::UQ::PCE< Storage > &src)
 
template<typename Storage >
KOKKOS_INLINE_FUNCTION void atomic_add (volatile Sacado::UQ::PCE< Storage > *const dest, const Sacado::UQ::PCE< Storage > &src)
 
template<typename cijk_type >
cijk_type & getGlobalCijkTensor ()
 
template<typename cijk_type >
void setGlobalCijkTensor (const cijk_type &cijk)
 
template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&!std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type create_mirror (const Kokkos::View< T, P... > &src)
 
template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type create_mirror (const Kokkos::View< T, P... > &src)
 
template<class Space , class T , class ... P, typename Enable = std::enable_if_t<Kokkos::is_space<Space>::value>>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value, typenameImpl::MirrorType< Space, T, P... >::view_type >::type create_mirror (const Space &, const Kokkos::View< T, P... > &src)
 
template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&!std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type create_mirror (Kokkos::Impl::WithoutInitializing_t wi, const Kokkos::View< T, P... > &src)
 
template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type create_mirror (Kokkos::Impl::WithoutInitializing_t wi, const Kokkos::View< T, P... > &src)
 
template<class Space , class T , class ... P, typename Enable = std::enable_if_t<Kokkos::is_space<Space>::value>>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value, typenameImpl::MirrorType< Space, T, P... >::view_type >::type create_mirror (Kokkos::Impl::WithoutInitializing_t wi, const Space &, const Kokkos::View< T, P... > &src)
 
template<class Space , class T , class... P>
Impl::MirrorViewType< Space, T, P... >::view_type create_mirror_view_and_copy (const Space &, const Kokkos::View< T, P... > &src, std::string const &name="", typename std::enable_if< std::is_same< typename ViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&Impl::MirrorViewType< Space, T, P... >::is_same_memspace >::type *=nullptr)
 
template<class Space , class T , class... P>
Impl::MirrorViewType< Space, T, P... >::view_type create_mirror_view_and_copy (const Space &, const Kokkos::View< T, P... > &src, std::string const &name="", typename std::enable_if< std::is_same< typename ViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&!Impl::MirrorViewType< Space, T, P... >::is_same_memspace >::type *=nullptr)
 
template<class DT , class ... DP>
void deep_copy (const View< DT, DP... > &view, const typename View< DT, DP... >::array_type::value_type &value, typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value)>::type *=0)
 
template<class DT , class ... DP>
void deep_copy (const View< DT, DP... > &view, const typename View< DT, DP... >::value_type &value, typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value)>::type *=0)
 
template<class ExecSpace , class DT , class ... DP>
void deep_copy (const ExecSpace &, const View< DT, DP... > &view, const typename View< DT, DP... >::array_type::value_type &value, typename std::enable_if<(Kokkos::is_execution_space< ExecSpace >::value &&std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value)>::type *=0)
 
template<class ExecSpace , class DT , class ... DP>
void deep_copy (const ExecSpace &, const View< DT, DP... > &view, const typename View< DT, DP... >::value_type &value, typename std::enable_if<(Kokkos::is_execution_space< ExecSpace >::value &&std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value)>::type *=0)
 
template<class DT , class ... DP, class ST , class ... SP>
void deep_copy (const View< DT, DP... > &dst, const View< ST, SP... > &src, typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&std::is_same< typename ViewTraits< ST, SP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value)>::type *=0)
 
template<class ExecSpace , class DT , class ... DP, class ST , class ... SP>
void deep_copy (const ExecSpace &, const View< DT, DP... > &dst, const View< ST, SP... > &src, typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&std::is_same< typename ViewTraits< ST, SP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value)>::type *=0)
 
template<typename T , typename ... P>
KOKKOS_INLINE_FUNCTION constexpr std::enable_if< is_view_uq_pce< View< T, P... > >::value, unsigned >::type dimension_scalar (const View< T, P... > &view)
 
template<typename view_type >
KOKKOS_INLINE_FUNCTION constexpr std::enable_if< is_view_uq_pce< view_type >::value, typenameCijkType< view_type >::type >::type cijk (const view_type &view)
 
template<typename view_type >
KOKKOS_INLINE_FUNCTION constexpr std::enable_if< is_view_uq_pce< view_type >::value, bool >::type is_allocation_contiguous (const view_type &view)
 
template<typename ViewType >
ViewType make_view (const std::string &label, const typename CijkType< ViewType >::type &cijk, size_t N0=0, size_t N1=0, size_t N2=0, size_t N3=0, size_t N4=0, size_t N5=0, size_t N6=0, size_t N7=0)
 
template<typename ViewType >
ViewType make_view (const std::string &label, const Impl::WithoutInitializing_t &init, const typename CijkType< ViewType >::type &cijk, size_t N0=0, size_t N1=0, size_t N2=0, size_t N3=0, size_t N4=0, size_t N5=0, size_t N6=0, size_t N7=0)
 
template<typename ViewType >
ViewType make_view (const ViewAllocateWithoutInitializing &init, const typename CijkType< ViewType >::type &cijk, size_t N0=0, size_t N1=0, size_t N2=0, size_t N3=0, size_t N4=0, size_t N5=0, size_t N6=0, size_t N7=0)
 
template<typename ViewType >
std::enable_if< is_view_uq_pce< ViewType >::value, ViewType >::type make_view (typename ViewType::pointer_type ptr, const typename CijkType< ViewType >::type &cijk, size_t N0=0, size_t N1=0, size_t N2=0, size_t N3=0, size_t N4=0, size_t N5=0, size_t N6=0, size_t N7=0)
 
template<typename CijkType , typename AllocProp >
KOKKOS_INLINE_FUNCTION std::enable_if<!Impl::ctor_prop_has_cijk< AllocProp >::value, CijkType >::type extract_cijk (const AllocProp &prop)
 
template<typename CijkType , typename AllocProp >
KOKKOS_INLINE_FUNCTION std::enable_if< Impl::ctor_prop_has_cijk< AllocProp >::value, CijkType >::type extract_cijk (const AllocProp &prop)
 
template<class S , class L , class G , class N >
size_t dimension_scalar (const Tpetra::MultiVector< S, L, G, N > &mv)
 
template<class S , class L , class G , class N >
size_t dimension_scalar (const Tpetra::Vector< S, L, G, N > &v)
 
template<typename Storage >
KOKKOS_INLINE_FUNCTION void atomic_assign (volatile Sacado::MP::Vector< Storage > *const dest, const Sacado::MP::Vector< Storage > &src)
 
template<typename Storage >
KOKKOS_INLINE_FUNCTION void atomic_add (volatile Sacado::MP::Vector< Storage > *const dest, const Sacado::MP::Vector< Storage > &src)
 
template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&!std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type create_mirror (const Kokkos::View< T, P... > &src)
 
template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type create_mirror (const Kokkos::View< T, P... > &src)
 
template<class Space , class T , class ... P, typename Enable = std::enable_if_t<Kokkos::is_space<Space>::value>>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value, typenameImpl::MirrorType< Space, T, P... >::view_type >::type create_mirror (const Space &, const Kokkos::View< T, P... > &src)
 
template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&!std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type create_mirror (Kokkos::Impl::WithoutInitializing_t wi, const Kokkos::View< T, P... > &src)
 
template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type create_mirror (Kokkos::Impl::WithoutInitializing_t wi, const Kokkos::View< T, P... > &src)
 
template<class Space , class T , class ... P, typename Enable = std::enable_if_t<Kokkos::is_space<Space>::value>>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value, typenameImpl::MirrorType< Space, T, P... >::view_type >::type create_mirror (Kokkos::Impl::WithoutInitializing_t wi, const Space &, const Kokkos::View< T, P... > &src)
 
template<class Space , class T , class... P>
Impl::MirrorViewType< Space, T, P... >::view_type create_mirror_view_and_copy (const Space &, const Kokkos::View< T, P... > &src, std::string const &name="", typename std::enable_if< std::is_same< typename ViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&Impl::MirrorViewType< Space, T, P... >::is_same_memspace >::type *=nullptr)
 
template<class Space , class T , class... P>
Impl::MirrorViewType< Space, T, P... >::view_type create_mirror_view_and_copy (const Space &, const Kokkos::View< T, P... > &src, std::string const &name="", typename std::enable_if< std::is_same< typename ViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&!Impl::MirrorViewType< Space, T, P... >::is_same_memspace >::type *=nullptr)
 
template<class DT , class ... DP>
void deep_copy (const View< DT, DP... > &view, const typename View< DT, DP... >::array_type::value_type &value, typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value)>::type *=0)
 
template<class DT , class ... DP>
void deep_copy (const View< DT, DP... > &view, const typename View< DT, DP... >::value_type &value, typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value)>::type *=0)
 
template<class ExecSpace , class DT , class ... DP>
void deep_copy (const ExecSpace &, const View< DT, DP... > &view, const typename View< DT, DP... >::array_type::value_type &value, typename std::enable_if<(Kokkos::is_execution_space< ExecSpace >::value &&std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value)>::type *=0)
 
template<class ExecSpace , class DT , class ... DP>
void deep_copy (const ExecSpace &, const View< DT, DP... > &view, const typename View< DT, DP... >::value_type &value, typename std::enable_if<(Kokkos::is_execution_space< ExecSpace >::value &&std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value)>::type *=0)
 
template<class DT , class ... DP, class ST , class ... SP>
void deep_copy (const View< DT, DP... > &dst, const View< ST, SP... > &src, typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&std::is_same< typename ViewTraits< ST, SP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value)>::type *=0)
 
template<class ExecSpace , class DT , class ... DP, class ST , class ... SP>
void deep_copy (const ExecSpace &, const View< DT, DP... > &dst, const View< ST, SP... > &src, typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&std::is_same< typename ViewTraits< ST, SP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value)>::type *=0)
 
template<class DT , class DL , class DD , class DM , class ST , class SL , class SD , class SM >
void deep_copy (const View< DT, DL, DD, DM, Impl::ViewMPVectorInterlaced > &dst, const View< ST, SL, SD, SM, Impl::ViewMPVectorInterlaced > &src, typename Impl::enable_if<(Impl::is_same< typename View< DT, DL, DD, DM, Impl::ViewMPVectorInterlaced >::intinsic_scalar_type, typename View< ST, SL, SD, SM, Impl::ViewMPVectorInterlaced >::intinsic_scalar_type >::value &&Impl::is_same< typename View< DT, DL, DD, DM, Impl::ViewMPVectorInterlaced >::array_layout, typename View< ST, SL, SD, SM, Impl::ViewMPVectorInterlaced >::array_layout >::value &&(unsigned(View< DT, DL, DD, DM, Impl::ViewMPVectorInterlaced >::rank)==unsigned(View< ST, SL, SD, SM, Impl::ViewMPVectorInterlaced >::rank)))>::type *=0)
 A deep copy between views of the same specialization, compatible type, same rank, same layout are handled by that specialization.
 
template<typename T , typename ... P>
KOKKOS_INLINE_FUNCTION constexpr std::enable_if< is_view_mp_vector< View< T, P... > >::value, unsigned >::type dimension_scalar (const View< T, P... > &view)
 
template<unsigned Size, typename D , typename ... P>
KOKKOS_INLINE_FUNCTION Kokkos::Impl::ViewMapping< void, typenameKokkos::ViewTraits< D, P... >, Sacado::MP::VectorPartition< Size > >::type partition (const Kokkos::View< D, P... > &src, const unsigned beg)
 

Variables

unsigned global_sacado_mp_vector_size = 0
 

Function Documentation

◆ create_mirror() [1/13]

template<typename ValueType , typename Layout , typename Device >
Stokhos::CrsMatrix< ValueType, Device, Layout >::HostMirror Kokkos::create_mirror ( const Stokhos::CrsMatrix< ValueType, Device, Layout > & A)

Definition at line 667 of file Stokhos_CrsMatrix.hpp.

◆ create_mirror_view()

template<typename ValueType , typename Layout , typename Device >
Stokhos::CrsMatrix< ValueType, Device, Layout >::HostMirror Kokkos::create_mirror_view ( const Stokhos::CrsMatrix< ValueType, Device, Layout > & A)

Definition at line 677 of file Stokhos_CrsMatrix.hpp.

◆ deep_copy() [1/14]

template<typename ValueType , typename Layout , typename DstDevice , typename SrcDevice >
void Kokkos::deep_copy ( const Stokhos::CrsMatrix< ValueType, DstDevice, Layout > & dst,
const Stokhos::CrsMatrix< ValueType, SrcDevice, Layout > & src )

Definition at line 688 of file Stokhos_CrsMatrix.hpp.

◆ make_view() [1/8]

template<typename ViewType >
ViewType Kokkos::make_view ( const std::string & label,
size_t N0 = 0,
size_t N1 = 0,
size_t N2 = 0,
size_t N3 = 0,
size_t N4 = 0,
size_t N5 = 0,
size_t N6 = 0,
size_t N7 = 0 )

Definition at line 262 of file Kokkos_View_Utils.hpp.

◆ make_view() [2/8]

template<typename ViewType >
ViewType Kokkos::make_view ( const ViewAllocateWithoutInitializing & init,
size_t N0 = 0,
size_t N1 = 0,
size_t N2 = 0,
size_t N3 = 0,
size_t N4 = 0,
size_t N5 = 0,
size_t N6 = 0,
size_t N7 = 0 )

Definition at line 271 of file Kokkos_View_Utils.hpp.

◆ make_view() [3/8]

template<typename ViewType >
ViewType Kokkos::make_view ( typename ViewType::pointer_type ptr,
size_t N0 = 0,
size_t N1 = 0,
size_t N2 = 0,
size_t N3 = 0,
size_t N4 = 0,
size_t N5 = 0,
size_t N6 = 0,
size_t N7 = 0 )

Definition at line 280 of file Kokkos_View_Utils.hpp.

◆ make_view() [4/8]

template<typename ViewType >
ViewType Kokkos::make_view ( const std::string & label,
const Impl::WithoutInitializing_t & init,
size_t N0 = 0,
size_t N1 = 0,
size_t N2 = 0,
size_t N3 = 0,
size_t N4 = 0,
size_t N5 = 0,
size_t N6 = 0,
size_t N7 = 0 )

Definition at line 289 of file Kokkos_View_Utils.hpp.

◆ atomic_assign() [1/2]

template<typename Storage >
KOKKOS_INLINE_FUNCTION void Kokkos::atomic_assign ( volatile Sacado::UQ::PCE< Storage > *const dest,
const Sacado::UQ::PCE< Storage > & src )

Definition at line 57 of file Kokkos_Atomic_UQ_PCE.hpp.

◆ atomic_add() [1/2]

template<typename Storage >
KOKKOS_INLINE_FUNCTION void Kokkos::atomic_add ( volatile Sacado::UQ::PCE< Storage > *const dest,
const Sacado::UQ::PCE< Storage > & src )

Definition at line 75 of file Kokkos_Atomic_UQ_PCE.hpp.

◆ getGlobalCijkTensor()

template<typename cijk_type >
cijk_type & Kokkos::getGlobalCijkTensor ( )

Definition at line 49 of file Kokkos_View_UQ_PCE.hpp.

◆ setGlobalCijkTensor()

template<typename cijk_type >
void Kokkos::setGlobalCijkTensor ( const cijk_type & cijk)

Definition at line 56 of file Kokkos_View_UQ_PCE.hpp.

◆ create_mirror() [2/13]

template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&!std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type Kokkos::create_mirror ( const Kokkos::View< T, P... > & src)
inline

Definition at line 209 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ create_mirror() [3/13]

template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type Kokkos::create_mirror ( const Kokkos::View< T, P... > & src)
inline

Definition at line 229 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ create_mirror() [4/13]

template<class Space , class T , class ... P, typename Enable = std::enable_if_t<Kokkos::is_space<Space>::value>>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value, typenameImpl::MirrorType< Space, T, P... >::view_type >::type Kokkos::create_mirror ( const Space & ,
const Kokkos::View< T, P... > & src )

Definition at line 265 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ create_mirror() [5/13]

template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&!std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type Kokkos::create_mirror ( Kokkos::Impl::WithoutInitializing_t wi,
const Kokkos::View< T, P... > & src )
inline

Definition at line 282 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ create_mirror() [6/13]

template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type Kokkos::create_mirror ( Kokkos::Impl::WithoutInitializing_t wi,
const Kokkos::View< T, P... > & src )
inline

Definition at line 303 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ create_mirror() [7/13]

template<class Space , class T , class ... P, typename Enable = std::enable_if_t<Kokkos::is_space<Space>::value>>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value, typenameImpl::MirrorType< Space, T, P... >::view_type >::type Kokkos::create_mirror ( Kokkos::Impl::WithoutInitializing_t wi,
const Space & ,
const Kokkos::View< T, P... > & src )

Definition at line 340 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ create_mirror_view_and_copy() [1/4]

template<class Space , class T , class... P>
Impl::MirrorViewType< Space, T, P... >::view_type Kokkos::create_mirror_view_and_copy ( const Space & ,
const Kokkos::View< T, P... > & src,
std::string const & name = "",
typename std::enable_if< std::is_same< typename ViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&Impl::MirrorViewType< Space, T, P... >::is_same_memspace >::type * = nullptr )

Definition at line 352 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ create_mirror_view_and_copy() [2/4]

template<class Space , class T , class... P>
Impl::MirrorViewType< Space, T, P... >::view_type Kokkos::create_mirror_view_and_copy ( const Space & ,
const Kokkos::View< T, P... > & src,
std::string const & name = "",
typename std::enable_if< std::is_same< typename ViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&!Impl::MirrorViewType< Space, T, P... >::is_same_memspace >::type * = nullptr )

Definition at line 368 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ deep_copy() [2/14]

template<class DT , class ... DP>
void Kokkos::deep_copy ( const View< DT, DP... > & view,
const typename View< DT, DP... >::array_type::value_type & value,
typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value)>::type * = 0 )

Definition at line 389 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ deep_copy() [3/14]

template<class DT , class ... DP>
void Kokkos::deep_copy ( const View< DT, DP... > & view,
const typename View< DT, DP... >::value_type & value,
typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value)>::type * = 0 )

Definition at line 413 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ deep_copy() [4/14]

template<class ExecSpace , class DT , class ... DP>
void Kokkos::deep_copy ( const ExecSpace & ,
const View< DT, DP... > & view,
const typename View< DT, DP... >::array_type::value_type & value,
typename std::enable_if<(Kokkos::is_execution_space< ExecSpace >::value &&std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value)>::type * = 0 )

Definition at line 431 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ deep_copy() [5/14]

template<class ExecSpace , class DT , class ... DP>
void Kokkos::deep_copy ( const ExecSpace & ,
const View< DT, DP... > & view,
const typename View< DT, DP... >::value_type & value,
typename std::enable_if<(Kokkos::is_execution_space< ExecSpace >::value &&std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value)>::type * = 0 )

Definition at line 457 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ deep_copy() [6/14]

template<class DT , class ... DP, class ST , class ... SP>
void Kokkos::deep_copy ( const View< DT, DP... > & dst,
const View< ST, SP... > & src,
typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&std::is_same< typename ViewTraits< ST, SP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value)>::type * = 0 )
inline

Definition at line 672 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ deep_copy() [7/14]

template<class ExecSpace , class DT , class ... DP, class ST , class ... SP>
void Kokkos::deep_copy ( const ExecSpace & ,
const View< DT, DP... > & dst,
const View< ST, SP... > & src,
typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value &&std::is_same< typename ViewTraits< ST, SP... >::specialize, Kokkos::Experimental::Impl::ViewPCEContiguous >::value)>::type * = 0 )
inline

Definition at line 518 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ dimension_scalar() [1/4]

template<typename T , typename ... P>
KOKKOS_INLINE_FUNCTION constexpr std::enable_if< is_view_uq_pce< View< T, P... > >::value, unsigned >::type Kokkos::dimension_scalar ( const View< T, P... > & view)
constexpr

Definition at line 111 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ cijk()

template<typename view_type >
KOKKOS_INLINE_FUNCTION constexpr std::enable_if< is_view_uq_pce< view_type >::value, typenameCijkType< view_type >::type >::type Kokkos::cijk ( const view_type & view)
constexpr

Definition at line 120 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ is_allocation_contiguous()

template<typename view_type >
KOKKOS_INLINE_FUNCTION constexpr std::enable_if< is_view_uq_pce< view_type >::value, bool >::type Kokkos::is_allocation_contiguous ( const view_type & view)
constexpr

Definition at line 128 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ make_view() [5/8]

template<typename ViewType >
ViewType Kokkos::make_view ( const std::string & label,
const typename CijkType< ViewType >::type & cijk,
size_t N0 = 0,
size_t N1 = 0,
size_t N2 = 0,
size_t N3 = 0,
size_t N4 = 0,
size_t N5 = 0,
size_t N6 = 0,
size_t N7 = 0 )

Definition at line 134 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ make_view() [6/8]

template<typename ViewType >
ViewType Kokkos::make_view ( const std::string & label,
const Impl::WithoutInitializing_t & init,
const typename CijkType< ViewType >::type & cijk,
size_t N0 = 0,
size_t N1 = 0,
size_t N2 = 0,
size_t N3 = 0,
size_t N4 = 0,
size_t N5 = 0,
size_t N6 = 0,
size_t N7 = 0 )

Definition at line 145 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ make_view() [7/8]

template<typename ViewType >
ViewType Kokkos::make_view ( const ViewAllocateWithoutInitializing & init,
const typename CijkType< ViewType >::type & cijk,
size_t N0 = 0,
size_t N1 = 0,
size_t N2 = 0,
size_t N3 = 0,
size_t N4 = 0,
size_t N5 = 0,
size_t N6 = 0,
size_t N7 = 0 )

Definition at line 157 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ make_view() [8/8]

template<typename ViewType >
std::enable_if< is_view_uq_pce< ViewType >::value, ViewType >::type Kokkos::make_view ( typename ViewType::pointer_type ptr,
const typename CijkType< ViewType >::type & cijk,
size_t N0 = 0,
size_t N1 = 0,
size_t N2 = 0,
size_t N3 = 0,
size_t N4 = 0,
size_t N5 = 0,
size_t N6 = 0,
size_t N7 = 0 )

Definition at line 170 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ extract_cijk() [1/2]

template<typename CijkType , typename AllocProp >
KOKKOS_INLINE_FUNCTION std::enable_if<!Impl::ctor_prop_has_cijk< AllocProp >::value, CijkType >::type Kokkos::extract_cijk ( const AllocProp & prop)

Definition at line 778 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ extract_cijk() [2/2]

template<typename CijkType , typename AllocProp >
KOKKOS_INLINE_FUNCTION std::enable_if< Impl::ctor_prop_has_cijk< AllocProp >::value, CijkType >::type Kokkos::extract_cijk ( const AllocProp & prop)

Definition at line 787 of file KokkosExp_View_UQ_PCE_Contiguous.hpp.

◆ dimension_scalar() [2/4]

template<class S , class L , class G , class N >
size_t Kokkos::dimension_scalar ( const Tpetra::MultiVector< S, L, G, N > & mv)

Definition at line 325 of file Stokhos_Tpetra_UQ_PCE.hpp.

◆ dimension_scalar() [3/4]

template<class S , class L , class G , class N >
size_t Kokkos::dimension_scalar ( const Tpetra::Vector< S, L, G, N > & v)

Definition at line 338 of file Stokhos_Tpetra_UQ_PCE.hpp.

◆ atomic_assign() [2/2]

template<typename Storage >
KOKKOS_INLINE_FUNCTION void Kokkos::atomic_assign ( volatile Sacado::MP::Vector< Storage > *const dest,
const Sacado::MP::Vector< Storage > & src )

Definition at line 57 of file Kokkos_Atomic_MP_Vector.hpp.

◆ atomic_add() [2/2]

template<typename Storage >
KOKKOS_INLINE_FUNCTION void Kokkos::atomic_add ( volatile Sacado::MP::Vector< Storage > *const dest,
const Sacado::MP::Vector< Storage > & src )

Definition at line 75 of file Kokkos_Atomic_MP_Vector.hpp.

◆ create_mirror() [8/13]

template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&!std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type Kokkos::create_mirror ( const Kokkos::View< T, P... > & src)
inline

Definition at line 135 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ create_mirror() [9/13]

template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type Kokkos::create_mirror ( const Kokkos::View< T, P... > & src)
inline

Definition at line 154 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ create_mirror() [10/13]

template<class Space , class T , class ... P, typename Enable = std::enable_if_t<Kokkos::is_space<Space>::value>>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value, typenameImpl::MirrorType< Space, T, P... >::view_type >::type Kokkos::create_mirror ( const Space & ,
const Kokkos::View< T, P... > & src )

Definition at line 189 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ create_mirror() [11/13]

template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&!std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type Kokkos::create_mirror ( Kokkos::Impl::WithoutInitializing_t wi,
const Kokkos::View< T, P... > & src )
inline

Definition at line 205 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ create_mirror() [12/13]

template<class T , class ... P>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&std::is_same< typenameKokkos::ViewTraits< T, P... >::array_layout, Kokkos::LayoutStride >::value, typenameKokkos::View< T, P... >::HostMirror >::type Kokkos::create_mirror ( Kokkos::Impl::WithoutInitializing_t wi,
const Kokkos::View< T, P... > & src )
inline

Definition at line 226 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ create_mirror() [13/13]

template<class Space , class T , class ... P, typename Enable = std::enable_if_t<Kokkos::is_space<Space>::value>>
std::enable_if< std::is_same< typenameViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value, typenameImpl::MirrorType< Space, T, P... >::view_type >::type Kokkos::create_mirror ( Kokkos::Impl::WithoutInitializing_t wi,
const Space & ,
const Kokkos::View< T, P... > & src )

Definition at line 263 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ create_mirror_view_and_copy() [3/4]

template<class Space , class T , class... P>
Impl::MirrorViewType< Space, T, P... >::view_type Kokkos::create_mirror_view_and_copy ( const Space & ,
const Kokkos::View< T, P... > & src,
std::string const & name = "",
typename std::enable_if< std::is_same< typename ViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&Impl::MirrorViewType< Space, T, P... >::is_same_memspace >::type * = nullptr )

Definition at line 275 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ create_mirror_view_and_copy() [4/4]

template<class Space , class T , class... P>
Impl::MirrorViewType< Space, T, P... >::view_type Kokkos::create_mirror_view_and_copy ( const Space & ,
const Kokkos::View< T, P... > & src,
std::string const & name = "",
typename std::enable_if< std::is_same< typename ViewTraits< T, P... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&!Impl::MirrorViewType< Space, T, P... >::is_same_memspace >::type * = nullptr )

Definition at line 291 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ deep_copy() [8/14]

template<class DT , class ... DP>
void Kokkos::deep_copy ( const View< DT, DP... > & view,
const typename View< DT, DP... >::array_type::value_type & value,
typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value)>::type * = 0 )

Definition at line 312 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ deep_copy() [9/14]

template<class DT , class ... DP>
void Kokkos::deep_copy ( const View< DT, DP... > & view,
const typename View< DT, DP... >::value_type & value,
typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value)>::type * = 0 )

Definition at line 331 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ deep_copy() [10/14]

template<class ExecSpace , class DT , class ... DP>
void Kokkos::deep_copy ( const ExecSpace & ,
const View< DT, DP... > & view,
const typename View< DT, DP... >::array_type::value_type & value,
typename std::enable_if<(Kokkos::is_execution_space< ExecSpace >::value &&std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value)>::type * = 0 )

Definition at line 356 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ deep_copy() [11/14]

template<class ExecSpace , class DT , class ... DP>
void Kokkos::deep_copy ( const ExecSpace & ,
const View< DT, DP... > & view,
const typename View< DT, DP... >::value_type & value,
typename std::enable_if<(Kokkos::is_execution_space< ExecSpace >::value &&std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value)>::type * = 0 )

Definition at line 377 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ deep_copy() [12/14]

template<class DT , class ... DP, class ST , class ... SP>
void Kokkos::deep_copy ( const View< DT, DP... > & dst,
const View< ST, SP... > & src,
typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&std::is_same< typename ViewTraits< ST, SP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value)>::type * = 0 )
inline

Definition at line 446 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ deep_copy() [13/14]

template<class ExecSpace , class DT , class ... DP, class ST , class ... SP>
void Kokkos::deep_copy ( const ExecSpace & ,
const View< DT, DP... > & dst,
const View< ST, SP... > & src,
typename std::enable_if<(std::is_same< typename ViewTraits< DT, DP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value &&std::is_same< typename ViewTraits< ST, SP... >::specialize, Kokkos::Experimental::Impl::ViewMPVectorContiguous >::value)>::type * = 0 )
inline

Definition at line 405 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ deep_copy() [14/14]

template<class DT , class DL , class DD , class DM , class ST , class SL , class SD , class SM >
void Kokkos::deep_copy ( const View< DT, DL, DD, DM, Impl::ViewMPVectorInterlaced > & dst,
const View< ST, SL, SD, SM, Impl::ViewMPVectorInterlaced > & src,
typename Impl::enable_if<(Impl::is_same< typename View< DT, DL, DD, DM, Impl::ViewMPVectorInterlaced >::intinsic_scalar_type, typename View< ST, SL, SD, SM, Impl::ViewMPVectorInterlaced >::intinsic_scalar_type >::value &&Impl::is_same< typename View< DT, DL, DD, DM, Impl::ViewMPVectorInterlaced >::array_layout, typename View< ST, SL, SD, SM, Impl::ViewMPVectorInterlaced >::array_layout >::value &&(unsigned(View< DT, DL, DD, DM, Impl::ViewMPVectorInterlaced >::rank)==unsigned(View< ST, SL, SD, SM, Impl::ViewMPVectorInterlaced >::rank)))>::type * = 0 )
inline

A deep copy between views of the same specialization, compatible type, same rank, same layout are handled by that specialization.

Definition at line 840 of file Kokkos_View_MP_Vector_Interlaced.hpp.

◆ dimension_scalar() [4/4]

template<typename T , typename ... P>
KOKKOS_INLINE_FUNCTION constexpr std::enable_if< is_view_mp_vector< View< T, P... > >::value, unsigned >::type Kokkos::dimension_scalar ( const View< T, P... > & view)
constexpr

Definition at line 102 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

◆ partition()

template<unsigned Size, typename D , typename ... P>
KOKKOS_INLINE_FUNCTION Kokkos::Impl::ViewMapping< void, typenameKokkos::ViewTraits< D, P... >, Sacado::MP::VectorPartition< Size > >::type Kokkos::partition ( const Kokkos::View< D, P... > & src,
const unsigned beg )

Definition at line 1729 of file KokkosExp_View_MP_Vector_Contiguous.hpp.

Variable Documentation

◆ global_sacado_mp_vector_size

unsigned Kokkos::global_sacado_mp_vector_size = 0

Definition at line 46 of file Kokkos_View_MP_Vector.cpp.