Sacado Package Browser (Single Doxygen Collection) Version of the Day
Loading...
Searching...
No Matches
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_sizeSLFadType
 
typedef Sacado::Fad::SFad< double, global_fad_sizeSFadType
 

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, 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, 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

◆ GLOBAL_FAD_SIZE

#define GLOBAL_FAD_SIZE   5

Definition at line 95 of file Fad_KokkosTests.hpp.

◆ VIEW_FAD_TESTS_FLD

#define VIEW_FAD_TESTS_FLD ( F,
L,
D )

Definition at line 2347 of file Fad_KokkosTests.hpp.

◆ VIEW_FAD_TESTS_SFLD

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

Definition at line 2382 of file Fad_KokkosTests.hpp.

◆ VIEW_FAD_TESTS_FDI

#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 D

Definition at line 2385 of file Fad_KokkosTests.hpp.

◆ VIEW_FAD_TESTS_SFDI

#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 )

Definition at line 2395 of file Fad_KokkosTests.hpp.

◆ VIEW_FAD_TESTS_FDC

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

Definition at line 2414 of file Fad_KokkosTests.hpp.

◆ VIEW_FAD_TESTS_SFDC

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

Definition at line 2415 of file Fad_KokkosTests.hpp.

◆ VIEW_FAD_TESTS_FD

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

Definition at line 2418 of file Fad_KokkosTests.hpp.

◆ VIEW_FAD_TESTS_SFD

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

Definition at line 2422 of file Fad_KokkosTests.hpp.

◆ VIEW_FAD_TESTS_D

#define VIEW_FAD_TESTS_D ( D)
Value:
VIEW_FAD_TESTS_FD( SLFadType, D ) \
VIEW_FAD_TESTS_SFD( SFadType, D )
#define VIEW_FAD_TESTS_FD(F, D)
Fad specializations for Teuchos::BLAS wrappers.

Definition at line 2472 of file Fad_KokkosTests.hpp.

Typedef Documentation

◆ DFadType

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

Definition at line 2428 of file Fad_KokkosTests.hpp.

◆ SLFadType

Definition at line 2429 of file Fad_KokkosTests.hpp.

◆ SFadType

Definition at line 2430 of file Fad_KokkosTests.hpp.

Function Documentation

◆ checkFads()

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.

◆ generate_fad()

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() [1/37]

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() [2/37]

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() [3/37]

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() [4/37]

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() [5/37]

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() [6/37]

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() [7/37]

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

Definition at line 733 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [8/37]

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

Definition at line 774 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [9/37]

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

Definition at line 824 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [10/37]

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

Definition at line 875 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [11/37]

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

Definition at line 930 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [12/37]

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

Definition at line 986 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [13/37]

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

Definition at line 1044 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [14/37]

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

Definition at line 1075 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [15/37]

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

Definition at line 1123 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [16/37]

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

Definition at line 1151 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [17/37]

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

Definition at line 1195 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [18/37]

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

Definition at line 1246 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [19/37]

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

Definition at line 1624 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [20/37]

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

Definition at line 1626 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [21/37]

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

Definition at line 1628 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [22/37]

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

Definition at line 1630 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [23/37]

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

Definition at line 1632 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [24/37]

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

Definition at line 1634 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [25/37]

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

Definition at line 1636 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [26/37]

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

Definition at line 1638 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [27/37]

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

Definition at line 1643 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [28/37]

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

Definition at line 1790 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [29/37]

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

Definition at line 2300 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [30/37]

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

Definition at line 2321 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [31/37]

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

Definition at line 2324 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [32/37]

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

Definition at line 2327 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [33/37]

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

Definition at line 2330 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [34/37]

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

Definition at line 2333 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [35/37]

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

Definition at line 2336 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [36/37]

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

Definition at line 2339 of file Fad_KokkosTests.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL() [37/37]

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

Definition at line 2342 of file Fad_KokkosTests.hpp.

Variable Documentation

◆ global_num_rows

const int global_num_rows = 11

Definition at line 97 of file Fad_KokkosTests.hpp.

◆ global_num_cols

const int global_num_cols = 7

Definition at line 98 of file Fad_KokkosTests.hpp.

◆ global_fad_size

const int global_fad_size = GLOBAL_FAD_SIZE

Definition at line 99 of file Fad_KokkosTests.hpp.