Stokhos Package Browser (Single Doxygen Collection) Version of the Day
Loading...
Searching...
No Matches
Namespaces | Classes | Functions
Kokkos::Example Namespace Reference

Namespaces

namespace  FENL
 

Classes

class  BoxElemFixture
 Generate a distributed unstructured finite element mesh from a partitioned NX*NY*NZ box of elements. More...
 
class  BoxElemPart
 Partition a box of hexahedral elements among subdomains. More...
 
class  HexElement_Data
 
class  HexElement_TensorData
 
class  HexElement_TensorData< 27 >
 
class  HexElement_TensorData< 8 >
 Evaluate Hex element on interval [-1,1]^3. More...
 
class  HexElement_TensorEval
 
struct  MapGridUnitCube
 Map a grid onto a unit cube with smooth nonlinear grading of the map. More...
 
struct  VectorImport
 

Functions

void box_partition (const unsigned global_size, const unsigned global_rank, const unsigned global_box[][2], unsigned box[][2])
 
KOKKOS_INLINE_FUNCTION void box_intersect (unsigned box[][2], const unsigned boxA[][2], const unsigned boxB[][2])
 
KOKKOS_INLINE_FUNCTION size_t box_count (const unsigned box[][2])
 
KOKKOS_INLINE_FUNCTION void box_ghost_layer (const unsigned global_box[][2], const unsigned local_box[][2], const unsigned ghost_layer, unsigned ghost_box[][2])
 
void box_partition (const size_t global_size, const size_t global_rank, const size_t global_box[][2], size_t box[][2])
 
KOKKOS_INLINE_FUNCTION void box_intersect (size_t box[][2], const size_t boxA[][2], const size_t boxB[][2])
 
KOKKOS_INLINE_FUNCTION size_t box_count (const size_t box[][2])
 
KOKKOS_INLINE_FUNCTION void box_ghost_layer (const size_t global_box[][2], const size_t local_box[][2], const size_t ghost_layer, size_t ghost_box[][2])
 

Function Documentation

◆ box_partition() [1/2]

void Kokkos::Example::box_partition ( const unsigned global_size,
const unsigned global_rank,
const unsigned global_box[][2],
unsigned box[][2] )

Definition at line 56 of file FadMPAssembly/BoxElemPart.cpp.

◆ box_intersect() [1/2]

KOKKOS_INLINE_FUNCTION void Kokkos::Example::box_intersect ( unsigned box[][2],
const unsigned boxA[][2],
const unsigned boxB[][2] )

Definition at line 57 of file FadMPAssembly/BoxElemPart.hpp.

◆ box_count() [1/2]

KOKKOS_INLINE_FUNCTION size_t Kokkos::Example::box_count ( const unsigned box[][2])

Definition at line 69 of file FadMPAssembly/BoxElemPart.hpp.

◆ box_ghost_layer() [1/2]

KOKKOS_INLINE_FUNCTION void Kokkos::Example::box_ghost_layer ( const unsigned global_box[][2],
const unsigned local_box[][2],
const unsigned ghost_layer,
unsigned ghost_box[][2] )

Definition at line 77 of file FadMPAssembly/BoxElemPart.hpp.

◆ box_partition() [2/2]

void Kokkos::Example::box_partition ( const size_t global_size,
const size_t global_rank,
const size_t global_box[][2],
size_t box[][2] )

Definition at line 56 of file MPAssembly/BoxElemPart.cpp.

◆ box_intersect() [2/2]

KOKKOS_INLINE_FUNCTION void Kokkos::Example::box_intersect ( size_t box[][2],
const size_t boxA[][2],
const size_t boxB[][2] )

Definition at line 57 of file MPAssembly/BoxElemPart.hpp.

◆ box_count() [2/2]

KOKKOS_INLINE_FUNCTION size_t Kokkos::Example::box_count ( const size_t box[][2])

Definition at line 69 of file MPAssembly/BoxElemPart.hpp.

◆ box_ghost_layer() [2/2]

KOKKOS_INLINE_FUNCTION void Kokkos::Example::box_ghost_layer ( const size_t global_box[][2],
const size_t local_box[][2],
const size_t ghost_layer,
size_t ghost_box[][2] )

Definition at line 77 of file MPAssembly/BoxElemPart.hpp.