Sacado Package Browser (Single Doxygen Collection)
Version of the Day
|
#include "Sacado.hpp"
#include "Teuchos_CommandLineProcessor.hpp"
#include "Teuchos_StandardCatchMacros.hpp"
#include "Kokkos_Core.hpp"
#include "Kokkos_MemoryPool.hpp"
#include "impl/Kokkos_Timer.hpp"
#include <cstdio>
#include <algorithm>
Go to the source code of this file.
Macros | |
#define | SACADO_VIEW_CUDA_HIERARCHICAL_DFAD 1 |
#define | SACADO_KOKKOS_USE_MEMORY_POOL 1 |
#define | SACADO_ALIGN_SFAD 1 |
Functions | |
template<typename FluxView , typename WgbView , typename SrcView , typename WbsView , typename ResidualView > | |
KOKKOS_INLINE_FUNCTION AdvectionKernel< FluxView, WgbView, SrcView, WbsView, ResidualView > | create_advection_kernel (const FluxView &flux, const WgbView &bg, const SrcView &src, const WbsView &bs, const ResidualView &residual, const typename FluxView::non_const_value_type &coeff) |
template<typename KernelType > | |
void | run_flat (const KernelType &kernel) |
template<typename KernelType > | |
void | run_hierarchical_flat (const KernelType &kernel) |
template<typename KernelType > | |
void | run_hierarchical_team (const KernelType &kernel) |
template<typename ExecSpace > | |
void | run (const int cell_begin, const int cell_end, const int cell_step, const int nbasis, const int npoint, const int ntrial, const bool check) |
int | main (int argc, char *argv[]) |
#define SACADO_VIEW_CUDA_HIERARCHICAL_DFAD 1 |
Definition at line 3 of file fad_kokkos_hierarchical.cpp.
#define SACADO_KOKKOS_USE_MEMORY_POOL 1 |
Definition at line 4 of file fad_kokkos_hierarchical.cpp.
#define SACADO_ALIGN_SFAD 1 |
Definition at line 5 of file fad_kokkos_hierarchical.cpp.
KOKKOS_INLINE_FUNCTION AdvectionKernel< FluxView, WgbView, SrcView, WbsView, ResidualView > create_advection_kernel | ( | const FluxView & | flux, |
const WgbView & | bg, | ||
const SrcView & | src, | ||
const WbsView & | bs, | ||
const ResidualView & | residual, | ||
const typename FluxView::non_const_value_type & | coeff | ||
) |
Definition at line 314 of file fad_kokkos_hierarchical.cpp.
void run_flat | ( | const KernelType & | kernel | ) |
Definition at line 324 of file fad_kokkos_hierarchical.cpp.
void run_hierarchical_flat | ( | const KernelType & | kernel | ) |
Definition at line 331 of file fad_kokkos_hierarchical.cpp.
void run_hierarchical_team | ( | const KernelType & | kernel | ) |
Definition at line 353 of file fad_kokkos_hierarchical.cpp.
void run | ( | const int | cell_begin, |
const int | cell_end, | ||
const int | cell_step, | ||
const int | nbasis, | ||
const int | npoint, | ||
const int | ntrial, | ||
const bool | check | ||
) |
Definition at line 874 of file fad_kokkos_hierarchical.cpp.
int main | ( | int | argc, |
char * | argv[] | ||
) |
Definition at line 920 of file fad_kokkos_hierarchical.cpp.