Sacado Package Browser (Single Doxygen Collection)  Version of the Day
Macros | Typedefs | Functions
mat_vec_hierarchical.cpp File Reference
#include "Sacado.hpp"
#include "mat_vec_hierarchical.hpp"
#include "impl/Kokkos_Timer.hpp"
Include dependency graph for mat_vec_hierarchical.cpp:

Go to the source code of this file.

Macros

#define SACADO_VIEW_CUDA_HIERARCHICAL   1
 
#define SACADO_ALIGN_SFAD   1
 
#define INST_FUNC_FAD_DEV(FAD, DEV)
 
#define INST_FUNC_DEV(DEV)
 

Typedefs

typedef Sacado::Fad::SFad< double, HierSFadSizeSFad_type
 
typedef Sacado::Fad::SLFad< double, HierSLFadSizeSLFad_type
 

Functions

template<typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void run_mat_vec_hierarchical (const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
 
template<typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void check_deriv_hierarchical (const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
 
template<typename FadType , typename ... ViewArgs>
Perf do_time_fad_hierarchical (const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check)
 

Macro Definition Documentation

◆ SACADO_VIEW_CUDA_HIERARCHICAL

#define SACADO_VIEW_CUDA_HIERARCHICAL   1

Definition at line 30 of file mat_vec_hierarchical.cpp.

◆ SACADO_ALIGN_SFAD

#define SACADO_ALIGN_SFAD   1

Definition at line 31 of file mat_vec_hierarchical.cpp.

◆ INST_FUNC_FAD_DEV

#define INST_FUNC_FAD_DEV (   FAD,
  DEV 
)
Value:
template Perf do_time_fad_hierarchical< FAD, Kokkos::LayoutLeft, DEV > ( const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check ); \
template Perf do_time_fad_hierarchical< FAD, Kokkos::LayoutRight, DEV > ( const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check ); \
template Perf do_time_fad_hierarchical< FAD, DEV > ( const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check );
const char * p
std::enable_if< !Kokkos::is_view_fad< View2 >::value, bool >::type check(const View1 &v_gold, const View2 &v, const double tol)

Definition at line 167 of file mat_vec_hierarchical.cpp.

◆ INST_FUNC_DEV

#define INST_FUNC_DEV (   DEV)
Value:
INST_FUNC_FAD_DEV( SLFad_type, DEV )
#define INST_FUNC_FAD_DEV(FAD, DEV)

Definition at line 172 of file mat_vec_hierarchical.cpp.

Typedef Documentation

◆ SFad_type

Definition at line 164 of file mat_vec_hierarchical.cpp.

◆ SLFad_type

Definition at line 165 of file mat_vec_hierarchical.cpp.

Function Documentation

◆ run_mat_vec_hierarchical()

template<typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void run_mat_vec_hierarchical ( const ViewTypeA &  A,
const ViewTypeB &  b,
const ViewTypeC &  c 
)

Definition at line 40 of file mat_vec_hierarchical.cpp.

◆ check_deriv_hierarchical()

template<typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void check_deriv_hierarchical ( const ViewTypeA &  A,
const ViewTypeB &  b,
const ViewTypeC &  c 
)

Definition at line 75 of file mat_vec_hierarchical.cpp.

◆ do_time_fad_hierarchical()

template<typename FadType , typename ... ViewArgs>
Perf do_time_fad_hierarchical ( const size_t  m,
const size_t  n,
const size_t  p,
const size_t  nloop,
const bool  check 
)

Definition at line 97 of file mat_vec_hierarchical.cpp.