Sacado Package Browser (Single Doxygen Collection) Version of the Day
Loading...
Searching...
No Matches
Macros | Typedefs | Functions
mat_vec_hierarchical_dfad.cpp File Reference
#include "Sacado.hpp"
#include "mat_vec_hierarchical_dfad.hpp"
#include "Kokkos_Timer.hpp"
Include dependency graph for mat_vec_hierarchical_dfad.cpp:

Go to the source code of this file.

Macros

#define SACADO_VIEW_CUDA_HIERARCHICAL_DFAD   1
 
#define SACADO_KOKKOS_USE_MEMORY_POOL   1
 
#define INST_FUNC_FAD_DEV(FAD, DEV)
 
#define INST_FUNC_DEV(DEV)    INST_FUNC_FAD_DEV( DFad_type, DEV )
 

Typedefs

typedef Sacado::Fad::DFad< double > DFad_type
 

Functions

template<typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void run_mat_vec_hierarchical_dfad (const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
 
template<typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void run_mat_vec_hierarchical_dfad_scratch (const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
 
template<typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void check_deriv_hierarchical_dfad (const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
 
template<typename FadType , typename ... ViewArgs>
Perf do_time_fad_hierarchical_dfad (const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check)
 
template<typename FadType , typename ... ViewArgs>
Perf do_time_fad_hierarchical_dfad_scratch (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_DFAD

#define SACADO_VIEW_CUDA_HIERARCHICAL_DFAD   1

Definition at line 30 of file mat_vec_hierarchical_dfad.cpp.

◆ SACADO_KOKKOS_USE_MEMORY_POOL

#define SACADO_KOKKOS_USE_MEMORY_POOL   1

Definition at line 31 of file mat_vec_hierarchical_dfad.cpp.

◆ INST_FUNC_FAD_DEV

#define INST_FUNC_FAD_DEV ( FAD,
DEV )
Value:
template Perf do_time_fad_hierarchical_dfad< 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_dfad< 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_dfad< FAD, 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_dfad_scratch< 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_dfad_scratch< 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_dfad_scratch< FAD, DEV > ( const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check );
const char * p

Definition at line 260 of file mat_vec_hierarchical_dfad.cpp.

◆ INST_FUNC_DEV

#define INST_FUNC_DEV ( DEV)     INST_FUNC_FAD_DEV( DFad_type, DEV )

Definition at line 268 of file mat_vec_hierarchical_dfad.cpp.

Typedef Documentation

◆ DFad_type

typedef Sacado::Fad::DFad<double> DFad_type

Definition at line 258 of file mat_vec_hierarchical_dfad.cpp.

Function Documentation

◆ run_mat_vec_hierarchical_dfad()

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

Definition at line 40 of file mat_vec_hierarchical_dfad.cpp.

◆ run_mat_vec_hierarchical_dfad_scratch()

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

Definition at line 74 of file mat_vec_hierarchical_dfad.cpp.

◆ check_deriv_hierarchical_dfad()

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

Definition at line 116 of file mat_vec_hierarchical_dfad.cpp.

◆ do_time_fad_hierarchical_dfad()

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

Definition at line 138 of file mat_vec_hierarchical_dfad.cpp.

◆ do_time_fad_hierarchical_dfad_scratch()

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

Definition at line 209 of file mat_vec_hierarchical_dfad.cpp.