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

Go to the source code of this file.

Macros

#define INST_FUNC_VAL_DEV(DEV)
 
#define INST_FUNC_FAD_DEV(FAD, DEV)
 
#define INST_FUNC_DEV(DEV)
 

Typedefs

typedef Sacado::Fad::SFad< double, SFadSizeSFad_type
 
typedef Sacado::Fad::SLFad< double, SLFadSizeSLFad_type
 
typedef Sacado::Fad::DFad< double > DFad_type
 

Functions

template<typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void run_mat_vec (const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
 
template<typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void run_mat_vec_scratch (const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
 
template<typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void run_mat_vec_deriv (const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
 
template<int MaxP, typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void run_mat_vec_deriv_sl (const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
 
template<int p, typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void run_mat_vec_deriv_s (const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
 
template<typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void check_val (const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
 
template<typename ViewTypeA , typename ViewTypeB , typename ViewTypeC >
void check_deriv (const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
 
template<typename ... ViewArgs>
Perf do_time_val (const size_t m, const size_t n, const size_t nloop, const bool check)
 
template<typename FadType , typename ... ViewArgs>
Perf do_time_fad (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_scratch (const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check)
 
template<typename ... ViewArgs>
Perf do_time_analytic (const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check)
 
template<int MaxP, typename ... ViewArgs>
Perf do_time_analytic_sl (const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check)
 
template<int p, typename ... ViewArgs>
Perf do_time_analytic_s (const size_t m, const size_t n, const size_t nloop, const bool check)
 

Macro Definition Documentation

◆ INST_FUNC_VAL_DEV

#define INST_FUNC_VAL_DEV ( DEV)
Value:
template Perf do_time_val< Kokkos::LayoutLeft, DEV > ( const size_t m, const size_t n, const size_t nloop, const bool check ); \
template Perf do_time_val< Kokkos::LayoutRight, DEV > ( const size_t m, const size_t n, const size_t nloop, const bool check ); \
template Perf do_time_val< DEV > ( const size_t m, const size_t n, const size_t nloop, const bool check ); \
template Perf do_time_analytic< 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_analytic< 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_analytic< DEV > ( const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check); \
template Perf do_time_analytic_sl< SLFadSize, 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_analytic_sl< SLFadSize, 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_analytic_sl< SLFadSize, DEV > ( const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check); \
template Perf do_time_analytic_s< SFadSize, Kokkos::LayoutLeft, DEV > ( const size_t m, const size_t n, const size_t nloop, const bool check); \
template Perf do_time_analytic_s< SFadSize, Kokkos::LayoutRight, DEV > ( const size_t m, const size_t n, const size_t nloop, const bool check); \
template Perf do_time_analytic_s< SFadSize, DEV > ( const size_t m, const size_t n, const size_t nloop, const bool check);
const char * p

Definition at line 518 of file mat_vec.cpp.

◆ INST_FUNC_FAD_DEV

#define INST_FUNC_FAD_DEV ( FAD,
DEV )
Value:
template Perf do_time_fad< 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< 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< 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_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_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_scratch< FAD, DEV > ( const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check );

Definition at line 532 of file mat_vec.cpp.

◆ INST_FUNC_DEV

#define INST_FUNC_DEV ( DEV)
Value:
INST_FUNC_FAD_DEV( SFad_type, DEV ) \
INST_FUNC_FAD_DEV( SLFad_type, DEV ) \
INST_FUNC_FAD_DEV( DFad_type, DEV )
Fad specializations for Teuchos::BLAS wrappers.
#define INST_FUNC_VAL_DEV(DEV)
Definition mat_vec.cpp:518

Definition at line 540 of file mat_vec.cpp.

Typedef Documentation

◆ SFad_type

Definition at line 514 of file mat_vec.cpp.

◆ SLFad_type

Definition at line 515 of file mat_vec.cpp.

◆ DFad_type

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

Definition at line 516 of file mat_vec.cpp.

Function Documentation

◆ run_mat_vec()

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

Definition at line 39 of file mat_vec.cpp.

◆ run_mat_vec_scratch()

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

Definition at line 58 of file mat_vec.cpp.

◆ run_mat_vec_deriv()

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

Definition at line 98 of file mat_vec.cpp.

◆ run_mat_vec_deriv_sl()

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

Definition at line 123 of file mat_vec.cpp.

◆ run_mat_vec_deriv_s()

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

Definition at line 157 of file mat_vec.cpp.

◆ check_val()

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

Definition at line 197 of file mat_vec.cpp.

◆ check_deriv()

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

Definition at line 216 of file mat_vec.cpp.

◆ do_time_val()

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

Definition at line 238 of file mat_vec.cpp.

◆ do_time_fad()

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

Definition at line 278 of file mat_vec.cpp.

◆ do_time_scratch()

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

Definition at line 344 of file mat_vec.cpp.

◆ do_time_analytic()

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

Definition at line 399 of file mat_vec.cpp.

◆ do_time_analytic_sl()

template<int MaxP, typename ... ViewArgs>
Perf do_time_analytic_sl ( const size_t m,
const size_t n,
const size_t p,
const size_t nloop,
const bool check )

Definition at line 438 of file mat_vec.cpp.

◆ do_time_analytic_s()

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

Definition at line 477 of file mat_vec.cpp.