Sacado Package Browser (Single Doxygen Collection)
Version of the Day
|
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) |
Static Public Attributes | |
static const int | FadStride = 1 |
Definition at line 400 of file fad_kokkos_hierarchical.cpp.
typedef Kokkos::View<double****[N+1],ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_4DView |
Definition at line 411 of file fad_kokkos_hierarchical.cpp.
typedef Kokkos::View<double***[N+1],ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_3DView |
Definition at line 412 of file fad_kokkos_hierarchical.cpp.
typedef Kokkos::View<double**[N+1],ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_2DView |
Definition at line 413 of file fad_kokkos_hierarchical.cpp.
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.
typedef Sacado::Fad::DFad<double> DrekarTest< ExecSpace, DIM, N >::FadType |
Definition at line 418 of file fad_kokkos_hierarchical.cpp.
typedef Kokkos::View<FadType****,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_4DViewFad |
Definition at line 422 of file fad_kokkos_hierarchical.cpp.
typedef Kokkos::View<FadType***,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_3DViewFad |
Definition at line 423 of file fad_kokkos_hierarchical.cpp.
typedef Kokkos::View<FadType**,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_2DViewFad |
Definition at line 424 of file fad_kokkos_hierarchical.cpp.
typedef ExecSpace::array_layout DrekarTest< ExecSpace, DIM, N >::DefaultLayout |
Definition at line 426 of file fad_kokkos_hierarchical.cpp.
typedef FadType DrekarTest< ExecSpace, DIM, N >::AlignedFadType |
Definition at line 438 of file fad_kokkos_hierarchical.cpp.
typedef Kokkos::LayoutContiguous<DefaultLayout,FadStride> DrekarTest< ExecSpace, DIM, N >::ContLayout |
Definition at line 440 of file fad_kokkos_hierarchical.cpp.
typedef Kokkos::View<AlignedFadType****,ContLayout,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_4DViewFadCont |
Definition at line 441 of file fad_kokkos_hierarchical.cpp.
typedef Kokkos::View<AlignedFadType***,ContLayout,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_3DViewFadCont |
Definition at line 442 of file fad_kokkos_hierarchical.cpp.
typedef Kokkos::View<AlignedFadType**,ContLayout,ExecSpace> DrekarTest< ExecSpace, DIM, N >::t_2DViewFadCont |
Definition at line 443 of file fad_kokkos_hierarchical.cpp.
typedef Kokkos::TeamPolicy<ExecSpace>::member_type DrekarTest< ExecSpace, DIM, N >::team_handle |
Definition at line 445 of file fad_kokkos_hierarchical.cpp.
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.
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.
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.
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.
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.
|
inline |
Definition at line 475 of file fad_kokkos_hierarchical.cpp.
|
inline |
Definition at line 519 of file fad_kokkos_hierarchical.cpp.
|
inline |
Definition at line 538 of file fad_kokkos_hierarchical.cpp.
|
inline |
Definition at line 591 of file fad_kokkos_hierarchical.cpp.
|
inline |
Definition at line 645 of file fad_kokkos_hierarchical.cpp.
|
inline |
Definition at line 681 of file fad_kokkos_hierarchical.cpp.
|
inline |
Definition at line 716 of file fad_kokkos_hierarchical.cpp.
|
inline |
Definition at line 746 of file fad_kokkos_hierarchical.cpp.
|
inline |
Definition at line 777 of file fad_kokkos_hierarchical.cpp.
|
inline |
Definition at line 810 of file fad_kokkos_hierarchical.cpp.
|
inline |
Definition at line 824 of file fad_kokkos_hierarchical.cpp.
int DrekarTest< ExecSpace, DIM, N >::ncells |
Definition at line 402 of file fad_kokkos_hierarchical.cpp.
int DrekarTest< ExecSpace, DIM, N >::num_basis |
Definition at line 403 of file fad_kokkos_hierarchical.cpp.
int DrekarTest< ExecSpace, DIM, N >::num_points |
Definition at line 404 of file fad_kokkos_hierarchical.cpp.
int DrekarTest< ExecSpace, DIM, N >::ndim |
Definition at line 405 of file fad_kokkos_hierarchical.cpp.
|
static |
Definition at line 437 of file fad_kokkos_hierarchical.cpp.
t_4DViewFad DrekarTest< ExecSpace, DIM, N >::wgb_fad |
Definition at line 455 of file fad_kokkos_hierarchical.cpp.
t_3DViewFad DrekarTest< ExecSpace, DIM, N >::flux_m_i_fad |
Definition at line 456 of file fad_kokkos_hierarchical.cpp.
t_3DViewFad DrekarTest< ExecSpace, DIM, N >::wbs_fad |
Definition at line 456 of file fad_kokkos_hierarchical.cpp.
t_2DViewFad DrekarTest< ExecSpace, DIM, N >::src_m_i_fad |
Definition at line 457 of file fad_kokkos_hierarchical.cpp.
t_2DViewFad DrekarTest< ExecSpace, DIM, N >::residual_m_i_fad |
Definition at line 457 of file fad_kokkos_hierarchical.cpp.
t_4DViewFadCont DrekarTest< ExecSpace, DIM, N >::wgb_fad_cont |
Definition at line 459 of file fad_kokkos_hierarchical.cpp.
t_3DViewFadCont DrekarTest< ExecSpace, DIM, N >::flux_m_i_fad_cont |
Definition at line 460 of file fad_kokkos_hierarchical.cpp.
t_3DViewFadCont DrekarTest< ExecSpace, DIM, N >::wbs_fad_cont |
Definition at line 460 of file fad_kokkos_hierarchical.cpp.
t_2DViewFadCont DrekarTest< ExecSpace, DIM, N >::src_m_i_fad_cont |
Definition at line 461 of file fad_kokkos_hierarchical.cpp.
t_2DViewFadCont DrekarTest< ExecSpace, DIM, N >::residual_m_i_fad_cont |
Definition at line 461 of file fad_kokkos_hierarchical.cpp.
t_4DView DrekarTest< ExecSpace, DIM, N >::wgb |
Definition at line 463 of file fad_kokkos_hierarchical.cpp.
t_3DView DrekarTest< ExecSpace, DIM, N >::flux_m_i |
Definition at line 464 of file fad_kokkos_hierarchical.cpp.
t_3DView DrekarTest< ExecSpace, DIM, N >::wbs |
Definition at line 464 of file fad_kokkos_hierarchical.cpp.
t_3DView_const DrekarTest< ExecSpace, DIM, N >::flux_m_i_const |
Definition at line 465 of file fad_kokkos_hierarchical.cpp.
t_2DView DrekarTest< ExecSpace, DIM, N >::src_m_i |
Definition at line 466 of file fad_kokkos_hierarchical.cpp.
t_2DView DrekarTest< ExecSpace, DIM, N >::residual_m_i |
Definition at line 466 of file fad_kokkos_hierarchical.cpp.
t_2DView DrekarTest< ExecSpace, DIM, N >::residual_m_i_const |
Definition at line 466 of file fad_kokkos_hierarchical.cpp.
t_4DView_team DrekarTest< ExecSpace, DIM, N >::twgb |
Definition at line 468 of file fad_kokkos_hierarchical.cpp.
t_3DView_team DrekarTest< ExecSpace, DIM, N >::tflux_m_i |
Definition at line 469 of file fad_kokkos_hierarchical.cpp.
t_3DView_team DrekarTest< ExecSpace, DIM, N >::twbs |
Definition at line 469 of file fad_kokkos_hierarchical.cpp.
t_3DView_const_team DrekarTest< ExecSpace, DIM, N >::tflux_m_i_const |
Definition at line 470 of file fad_kokkos_hierarchical.cpp.
t_2DView_team DrekarTest< ExecSpace, DIM, N >::tsrc_m_i |
Definition at line 471 of file fad_kokkos_hierarchical.cpp.
t_2DView_team DrekarTest< ExecSpace, DIM, N >::tresidual_m_i |
Definition at line 471 of file fad_kokkos_hierarchical.cpp.
AlignedFadType DrekarTest< ExecSpace, DIM, N >::coeff |
Definition at line 473 of file fad_kokkos_hierarchical.cpp.