Sacado Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Classes | Public Types | Public Member Functions | Public Attributes | Static Public Attributes | List of all members
DrekarTest< ExecSpace, DIM, N > Struct Template Reference

Classes

struct  MomFluxTag
 
struct  MomFluxTagConst
 
struct  MomFluxTagConstTeam
 

Public Types

typedef Kokkos::View< double
****[N+1], ExecSpace > 
t_4DView
 
typedef Kokkos::View< double
***[N+1], ExecSpace > 
t_3DView
 
typedef Kokkos::View< double
**[N+1], ExecSpace > 
t_2DView
 
typedef Kokkos::View< const
double ***[N+1], ExecSpace,
Kokkos::MemoryTraits
< Kokkos::RandomAccess > > 
t_3DView_const
 
typedef Sacado::Fad::DFad< double > FadType
 
typedef Kokkos::View< FadType
****, ExecSpace > 
t_4DViewFad
 
typedef Kokkos::View< FadType
***, ExecSpace > 
t_3DViewFad
 
typedef Kokkos::View< FadType
**, ExecSpace > 
t_2DViewFad
 
typedef ExecSpace::array_layout DefaultLayout
 
typedef FadType AlignedFadType
 
typedef
Kokkos::LayoutContiguous
< DefaultLayout, FadStride
ContLayout
 
typedef Kokkos::View
< AlignedFadType
****, ContLayout, ExecSpace > 
t_4DViewFadCont
 
typedef Kokkos::View
< AlignedFadType
***, ContLayout, ExecSpace > 
t_3DViewFadCont
 
typedef Kokkos::View
< AlignedFadType
**, ContLayout, ExecSpace > 
t_2DViewFadCont
 
typedef Kokkos::TeamPolicy
< ExecSpace >::member_type 
team_handle
 
typedef Kokkos::View< double
****[N+1], Kokkos::LayoutRight,
ExecSpace > 
t_4DView_team
 
typedef Kokkos::View< double
***[N+1], Kokkos::LayoutRight,
ExecSpace > 
t_3DView_team
 
typedef Kokkos::View< double
**[N+1], Kokkos::LayoutRight,
ExecSpace > 
t_2DView_team
 
typedef Kokkos::View< const
double ***[N+1],
Kokkos::LayoutRight, ExecSpace,
Kokkos::MemoryTraits
< Kokkos::RandomAccess > > 
t_3DView_const_team
 
typedef Kokkos::View< double[N+1],
typename
ExecSpace::scratch_memory_space,
Kokkos::MemoryTraits
< Kokkos::Unmanaged > > 
t_shared_scalar
 

Public Member Functions

 DrekarTest (int ncells_, int num_basis_, int num_points_)
 
FadType::value_type generate_fad (const size_t n0, const size_t n1, const size_t n2, const size_t n3, const int fad_size, const size_t i0, const size_t i1, const size_t i2, const size_t i3, const int i_fad)
 
template<typename V1 , typename V2 , typename V3 , typename V4 , typename V5 >
void init_fad (const V1 &v1, const V2 &v2, const V3 &v3, const V4 &v4, const V5 &v5)
 
template<typename V1 , typename V2 , typename V3 , typename V4 , typename V5 >
void init_array (const V1 &v1, const V2 &v2, const V3 &v3, const V4 &v4, const V5 &v5)
 
template<typename View1 , typename View2 >
std::enable_if
< !Kokkos::is_view_fad< View2 >
::value, bool >::type 
check (const View1 &v_gold, const View2 &v, const double tol)
 
template<typename View1 , typename View2 >
std::enable_if
< Kokkos::is_view_fad< View2 >
::value, bool >::type 
check (const View1 &v_gold, const View2 &v, const double tol)
 
KOKKOS_INLINE_FUNCTION void operator() (const MomFluxTag, const std::size_t &cell) const
 
KOKKOS_INLINE_FUNCTION void operator() (const MomFluxTagConst, const std::size_t &cell) const
 
KOKKOS_INLINE_FUNCTION void compute_one (const MomFluxTagConstTeam, const team_handle &team, const int &cell, const int &basis, const t_shared_scalar &value, const t_shared_scalar &value2) const
 
KOKKOS_INLINE_FUNCTION void operator() (const MomFluxTagConstTeam, const team_handle &team) const
 
void compute (const int ntrial, const bool do_check)
 

Public Attributes

int ncells
 
int num_basis
 
int num_points
 
int ndim
 
t_4DViewFad wgb_fad
 
t_3DViewFad flux_m_i_fad
 
t_3DViewFad wbs_fad
 
t_2DViewFad src_m_i_fad
 
t_2DViewFad residual_m_i_fad
 
t_4DViewFadCont wgb_fad_cont
 
t_3DViewFadCont flux_m_i_fad_cont
 
t_3DViewFadCont wbs_fad_cont
 
t_2DViewFadCont src_m_i_fad_cont
 
t_2DViewFadCont residual_m_i_fad_cont
 
t_4DView wgb
 
t_3DView flux_m_i
 
t_3DView wbs
 
t_3DView_const flux_m_i_const
 
t_2DView src_m_i
 
t_2DView residual_m_i
 
t_2DView residual_m_i_const
 
t_4DView_team twgb
 
t_3DView_team tflux_m_i
 
t_3DView_team twbs
 
t_3DView_const_team tflux_m_i_const
 
t_2DView_team tsrc_m_i
 
t_2DView_team tresidual_m_i
 
AlignedFadType coeff
 

Static Public Attributes

static const int FadStride = 1
 

Detailed Description

template<typename ExecSpace, int DIM, int N>
struct DrekarTest< ExecSpace, DIM, N >

Definition at line 400 of file fad_kokkos_hierarchical.cpp.

Member Typedef Documentation

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<double****[N+1],ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_4DView

Definition at line 411 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<double***[N+1],ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_3DView

Definition at line 412 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<double**[N+1],ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_2DView

Definition at line 413 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<const double***[N+1],ExecSpace,Kokkos::MemoryTraits<Kokkos::RandomAccess> > DrekarTest< ExecSpace, DIM, N >::t_3DView_const

Definition at line 415 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Sacado::Fad::DFad<double> DrekarTest< ExecSpace, DIM, N >::FadType

Definition at line 418 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<FadType****,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_4DViewFad

Definition at line 422 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<FadType***,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_3DViewFad

Definition at line 423 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<FadType**,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_2DViewFad

Definition at line 424 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef ExecSpace::array_layout DrekarTest< ExecSpace, DIM, N >::DefaultLayout

Definition at line 426 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef FadType DrekarTest< ExecSpace, DIM, N >::AlignedFadType

Definition at line 438 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::LayoutContiguous<DefaultLayout,FadStride> DrekarTest< ExecSpace, DIM, N >::ContLayout

Definition at line 440 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<AlignedFadType****,ContLayout,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_4DViewFadCont

Definition at line 441 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<AlignedFadType***,ContLayout,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_3DViewFadCont

Definition at line 442 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<AlignedFadType**,ContLayout,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_2DViewFadCont

Definition at line 443 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::TeamPolicy<ExecSpace>::member_type DrekarTest< ExecSpace, DIM, N >::team_handle

Definition at line 445 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<double****[N+1],Kokkos::LayoutRight,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_4DView_team

Definition at line 447 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<double***[N+1],Kokkos::LayoutRight,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_3DView_team

Definition at line 448 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<double**[N+1],Kokkos::LayoutRight,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_2DView_team

Definition at line 449 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<const double***[N+1],Kokkos::LayoutRight,ExecSpace,Kokkos::MemoryTraits<Kokkos::RandomAccess> > DrekarTest< ExecSpace, DIM, N >::t_3DView_const_team

Definition at line 450 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
typedef Kokkos::View<double[N+1],typename ExecSpace::scratch_memory_space,Kokkos::MemoryTraits<Kokkos::Unmanaged> > DrekarTest< ExecSpace, DIM, N >::t_shared_scalar

Definition at line 453 of file fad_kokkos_hierarchical.cpp.

Constructor & Destructor Documentation

template<typename ExecSpace , int DIM, int N>
DrekarTest< ExecSpace, DIM, N >::DrekarTest ( int  ncells_,
int  num_basis_,
int  num_points_ 
)
inline

Definition at line 475 of file fad_kokkos_hierarchical.cpp.

Member Function Documentation

template<typename ExecSpace , int DIM, int N>
FadType::value_type DrekarTest< ExecSpace, DIM, N >::generate_fad ( const size_t  n0,
const size_t  n1,
const size_t  n2,
const size_t  n3,
const int  fad_size,
const size_t  i0,
const size_t  i1,
const size_t  i2,
const size_t  i3,
const int  i_fad 
)
inline

Definition at line 519 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
template<typename V1 , typename V2 , typename V3 , typename V4 , typename V5 >
void DrekarTest< ExecSpace, DIM, N >::init_fad ( const V1 &  v1,
const V2 &  v2,
const V3 &  v3,
const V4 &  v4,
const V5 &  v5 
)
inline

Definition at line 538 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
template<typename V1 , typename V2 , typename V3 , typename V4 , typename V5 >
void DrekarTest< ExecSpace, DIM, N >::init_array ( const V1 &  v1,
const V2 &  v2,
const V3 &  v3,
const V4 &  v4,
const V5 &  v5 
)
inline

Definition at line 591 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
template<typename View1 , typename View2 >
std::enable_if< !Kokkos::is_view_fad<View2>::value, bool>::type DrekarTest< ExecSpace, DIM, N >::check ( const View1 &  v_gold,
const View2 &  v,
const double  tol 
)
inline

Definition at line 645 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
template<typename View1 , typename View2 >
std::enable_if< Kokkos::is_view_fad<View2>::value, bool>::type DrekarTest< ExecSpace, DIM, N >::check ( const View1 &  v_gold,
const View2 &  v,
const double  tol 
)
inline

Definition at line 681 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
KOKKOS_INLINE_FUNCTION void DrekarTest< ExecSpace, DIM, N >::operator() ( const MomFluxTag  ,
const std::size_t &  cell 
) const
inline

Definition at line 716 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
KOKKOS_INLINE_FUNCTION void DrekarTest< ExecSpace, DIM, N >::operator() ( const MomFluxTagConst  ,
const std::size_t &  cell 
) const
inline

Definition at line 746 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
KOKKOS_INLINE_FUNCTION void DrekarTest< ExecSpace, DIM, N >::compute_one ( const MomFluxTagConstTeam  ,
const team_handle team,
const int &  cell,
const int &  basis,
const t_shared_scalar value,
const t_shared_scalar value2 
) const
inline

Definition at line 777 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
KOKKOS_INLINE_FUNCTION void DrekarTest< ExecSpace, DIM, N >::operator() ( const MomFluxTagConstTeam  ,
const team_handle team 
) const
inline

Definition at line 810 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
void DrekarTest< ExecSpace, DIM, N >::compute ( const int  ntrial,
const bool  do_check 
)
inline

Definition at line 824 of file fad_kokkos_hierarchical.cpp.

Member Data Documentation

template<typename ExecSpace , int DIM, int N>
int DrekarTest< ExecSpace, DIM, N >::ncells

Definition at line 402 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
int DrekarTest< ExecSpace, DIM, N >::num_basis

Definition at line 403 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
int DrekarTest< ExecSpace, DIM, N >::num_points

Definition at line 404 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
int DrekarTest< ExecSpace, DIM, N >::ndim

Definition at line 405 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
const int DrekarTest< ExecSpace, DIM, N >::FadStride = 1
static

Definition at line 437 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_4DViewFad DrekarTest< ExecSpace, DIM, N >::wgb_fad

Definition at line 455 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_3DViewFad DrekarTest< ExecSpace, DIM, N >::flux_m_i_fad

Definition at line 456 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_3DViewFad DrekarTest< ExecSpace, DIM, N >::wbs_fad

Definition at line 456 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_2DViewFad DrekarTest< ExecSpace, DIM, N >::src_m_i_fad

Definition at line 457 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_2DViewFad DrekarTest< ExecSpace, DIM, N >::residual_m_i_fad

Definition at line 457 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_4DViewFadCont DrekarTest< ExecSpace, DIM, N >::wgb_fad_cont

Definition at line 459 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_3DViewFadCont DrekarTest< ExecSpace, DIM, N >::flux_m_i_fad_cont

Definition at line 460 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_3DViewFadCont DrekarTest< ExecSpace, DIM, N >::wbs_fad_cont

Definition at line 460 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_2DViewFadCont DrekarTest< ExecSpace, DIM, N >::src_m_i_fad_cont

Definition at line 461 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_2DViewFadCont DrekarTest< ExecSpace, DIM, N >::residual_m_i_fad_cont

Definition at line 461 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_4DView DrekarTest< ExecSpace, DIM, N >::wgb

Definition at line 463 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_3DView DrekarTest< ExecSpace, DIM, N >::flux_m_i

Definition at line 464 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_3DView DrekarTest< ExecSpace, DIM, N >::wbs

Definition at line 464 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_3DView_const DrekarTest< ExecSpace, DIM, N >::flux_m_i_const

Definition at line 465 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_2DView DrekarTest< ExecSpace, DIM, N >::src_m_i

Definition at line 466 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_2DView DrekarTest< ExecSpace, DIM, N >::residual_m_i

Definition at line 466 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_2DView DrekarTest< ExecSpace, DIM, N >::residual_m_i_const

Definition at line 466 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_4DView_team DrekarTest< ExecSpace, DIM, N >::twgb

Definition at line 468 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_3DView_team DrekarTest< ExecSpace, DIM, N >::tflux_m_i

Definition at line 469 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_3DView_team DrekarTest< ExecSpace, DIM, N >::twbs

Definition at line 469 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_3DView_const_team DrekarTest< ExecSpace, DIM, N >::tflux_m_i_const

Definition at line 470 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_2DView_team DrekarTest< ExecSpace, DIM, N >::tsrc_m_i

Definition at line 471 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
t_2DView_team DrekarTest< ExecSpace, DIM, N >::tresidual_m_i

Definition at line 471 of file fad_kokkos_hierarchical.cpp.

template<typename ExecSpace , int DIM, int N>
AlignedFadType DrekarTest< ExecSpace, DIM, N >::coeff

Definition at line 473 of file fad_kokkos_hierarchical.cpp.


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