Sacado Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Classes | Macros | Typedefs | Functions | Variables
Fad_KokkosTests.hpp File Reference
#include "Teuchos_TestingHelpers.hpp"
#include "Sacado.hpp"
#include "Kokkos_DynRankView_Fad.hpp"
Include dependency graph for Fad_KokkosTests.hpp:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Classes

struct  is_sfad< T >
 
struct  is_sfad< Sacado::Fad::SFad< T, N > >
 
struct  is_dfad< T >
 
struct  is_dfad< Sacado::Fad::DFad< T > >
 
struct  MultiplyKernel< InputViewType1, InputViewType2, OutputViewType >
 
struct  ScalarAssignKernel< ViewType >
 
struct  ValueAssignKernel< ViewType, ScalarViewType >
 
struct  AssignRank2Rank1Kernel< InputViewType, OutputViewType, Enabled >
 
struct  AtomicAddKernel< ViewType, ScalarViewType >
 

Macros

#define GLOBAL_FAD_SIZE   5
 
#define VIEW_FAD_TESTS_FLD(F, L, D)
 
#define VIEW_FAD_TESTS_SFLD(F, L, D)   TEUCHOS_UNIT_TEST_TEMPLATE_3_INSTANT( Kokkos_View_Fad, SFadNoSizeArg, F, L, D )
 
#define VIEW_FAD_TESTS_FDI(F, D)
 
#define VIEW_FAD_TESTS_SFDI(F, D)
 
#define VIEW_FAD_TESTS_FDC(F, D)   /* */
 
#define VIEW_FAD_TESTS_SFDC(F, D)   /* */
 
#define VIEW_FAD_TESTS_FD(F, D)
 
#define VIEW_FAD_TESTS_SFD(F, D)
 
#define VIEW_FAD_TESTS_D(D)
 

Typedefs

typedef Sacado::Fad::DFad< double > DFadType
 
typedef Sacado::Fad::SLFad
< double, 2 *global_fad_size
SLFadType
 
typedef Sacado::Fad::SFad
< double, global_fad_size
SFadType
 

Functions

template<typename FadType1 , typename FadType2 >
bool checkFads (const FadType1 &x, const FadType2 &x2, Teuchos::FancyOStream &out, double tol=1.0e-15)
 
template<typename fadtype , typename ordinal >
fadtype generate_fad (const ordinal num_rows, const ordinal num_cols, const ordinal fad_size, const ordinal row, const ordinal col)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, Size, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, DeepCopy, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, DeepCopy_ConstantScalar, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, DeepCopy_ConstantZero, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, DeepCopy_ConstantFad, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, DeepCopy_ConstantFadFull, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, LocalDeepCopy, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, LocalDeepCopyTeam, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, ScalarAssign, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, ValueAssign, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, Resize, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, Multiply, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, MultiplyUpdate, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, MultiplyConst, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, MultiplyMixed, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, AtomicAdd, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, Rank8, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, Roger, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, AssignDifferentStrides, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, ScalarValue, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, DynRankDimensionScalar, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, DynRankAssignStatic0, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, DynRankAssignStatic1, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, DynRankAssignStatic2, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, DynRankMultiply, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, SubdynrankviewCol, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, SubdynrankviewRow, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, SubdynrankviewScalar, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, Subview, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, Subview2, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, ConstViewAssign, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, ShmemSize, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, Unmanaged, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, Unmanaged2, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, UnmanagedConst, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, UnmanagedConst2, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, SFadNoSizeArg, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, Partition, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, AssignLayoutContiguousToLayoutStride, FadType, Layout, Device)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL (Kokkos_View_Fad, CommonViewAllocMixedSpec, FadType, Layout, Device)
 

Variables

const int global_num_rows = 11
 
const int global_num_cols = 7
 
const int global_fad_size = GLOBAL_FAD_SIZE
 

Macro Definition Documentation

#define GLOBAL_FAD_SIZE   5

Definition at line 95 of file Fad_KokkosTests.hpp.

#define VIEW_FAD_TESTS_FLD (   F,
  L,
  D 
)

Definition at line 2585 of file Fad_KokkosTests.hpp.

#define VIEW_FAD_TESTS_SFLD (   F,
  L,
  D 
)    TEUCHOS_UNIT_TEST_TEMPLATE_3_INSTANT( Kokkos_View_Fad, SFadNoSizeArg, F, L, D )

Definition at line 2623 of file Fad_KokkosTests.hpp.

#define VIEW_FAD_TESTS_FDI (   F,
  D 
)
Value:
using Kokkos::LayoutLeft; \
using Kokkos::LayoutRight; \
VIEW_FAD_TESTS_FLD( F, LayoutLeft, D ) \
VIEW_FAD_TESTS_FLD( F, LayoutRight, D ) \
TEUCHOS_UNIT_TEST_TEMPLATE_3_INSTANT( Kokkos_View_Fad, AssignLayoutContiguousToLayoutStride, F, LayoutLeft, D ) \
TEUCHOS_UNIT_TEST_TEMPLATE_3_INSTANT( Kokkos_View_Fad, AssignLayoutContiguousToLayoutStride, F, LayoutRight, D ) \
TEUCHOS_UNIT_TEST_TEMPLATE_3_INSTANT( Kokkos_View_Fad, CommonViewAllocMixedSpec, F, LayoutLeft, D ) \
TEUCHOS_UNIT_TEST_TEMPLATE_3_INSTANT( Kokkos_View_Fad, CommonViewAllocMixedSpec, F, LayoutRight, D )
#define VIEW_FAD_TESTS_FLD(F, L, D)

Definition at line 2626 of file Fad_KokkosTests.hpp.

#define VIEW_FAD_TESTS_SFDI (   F,
  D 
)
Value:
using Kokkos::LayoutLeft; \
using Kokkos::LayoutRight; \
VIEW_FAD_TESTS_SFLD( F, LayoutLeft, D ) \
VIEW_FAD_TESTS_SFLD( F, LayoutRight, D )
#define VIEW_FAD_TESTS_SFLD(F, L, D)

Definition at line 2636 of file Fad_KokkosTests.hpp.

#define VIEW_FAD_TESTS_FDC (   F,
  D 
)    /* */

Definition at line 2655 of file Fad_KokkosTests.hpp.

#define VIEW_FAD_TESTS_SFDC (   F,
  D 
)    /* */

Definition at line 2656 of file Fad_KokkosTests.hpp.

#define VIEW_FAD_TESTS_FD (   F,
  D 
)
Value:
#define VIEW_FAD_TESTS_FDI(F, D)
#define VIEW_FAD_TESTS_FDC(F, D)

Definition at line 2659 of file Fad_KokkosTests.hpp.

#define VIEW_FAD_TESTS_SFD (   F,
  D 
)
Value:
#define VIEW_FAD_TESTS_SFDI(F, D)
#define VIEW_FAD_TESTS_SFDC(F, D)

Definition at line 2663 of file Fad_KokkosTests.hpp.

#define VIEW_FAD_TESTS_D (   D)

Typedef Documentation

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

Definition at line 2669 of file Fad_KokkosTests.hpp.

Definition at line 2670 of file Fad_KokkosTests.hpp.

Definition at line 2671 of file Fad_KokkosTests.hpp.

Function Documentation

template<typename FadType1 , typename FadType2 >
bool checkFads ( const FadType1 &  x,
const FadType2 &  x2,
Teuchos::FancyOStream out,
double  tol = 1.0e-15 
)

Definition at line 55 of file Fad_KokkosTests.hpp.

template<typename fadtype , typename ordinal >
fadtype generate_fad ( const ordinal  num_rows,
const ordinal  num_cols,
const ordinal  fad_size,
const ordinal  row,
const ordinal  col 
)
inline

Definition at line 75 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
Size  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 506 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
DeepCopy  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 525 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
DeepCopy_ConstantScalar  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 563 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
DeepCopy_ConstantZero  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 607 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
DeepCopy_ConstantFad  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 651 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
DeepCopy_ConstantFadFull  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 694 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
LocalDeepCopy  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 733 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
LocalDeepCopyTeam  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 794 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
ScalarAssign  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 858 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
ValueAssign  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 899 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
Resize  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 949 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
Multiply  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1000 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
MultiplyUpdate  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1055 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
MultiplyConst  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1111 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
MultiplyMixed  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1169 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
AtomicAdd  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1200 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
Rank8  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1248 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
Roger  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1276 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
AssignDifferentStrides  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1320 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
ScalarValue  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1371 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
DynRankDimensionScalar  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1749 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
DynRankAssignStatic0  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1751 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
DynRankAssignStatic1  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1753 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
DynRankAssignStatic2  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1755 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
DynRankMultiply  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1757 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
SubdynrankviewCol  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1759 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
SubdynrankviewRow  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1761 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
SubdynrankviewScalar  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1763 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
Subview  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1768 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
Subview2  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 1821 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
ConstViewAssign  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 2028 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
ShmemSize  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 2538 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
Unmanaged  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 2559 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
Unmanaged2  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 2562 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
UnmanagedConst  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 2565 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
UnmanagedConst2  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 2568 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
SFadNoSizeArg  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 2571 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
Partition  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 2574 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
AssignLayoutContiguousToLayoutStride  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 2577 of file Fad_KokkosTests.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL ( Kokkos_View_Fad  ,
CommonViewAllocMixedSpec  ,
FadType  ,
Layout  ,
Device   
)

Definition at line 2580 of file Fad_KokkosTests.hpp.

Variable Documentation

const int global_num_rows = 11

Definition at line 97 of file Fad_KokkosTests.hpp.

const int global_num_cols = 7

Definition at line 98 of file Fad_KokkosTests.hpp.

const int global_fad_size = GLOBAL_FAD_SIZE

Definition at line 99 of file Fad_KokkosTests.hpp.