Stokhos Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Classes | Public Types | Public Member Functions | Static Public Member Functions | Static Public Attributes | Private Types | Private Attributes | List of all members
Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace > Class Template Reference

#include <Stokhos_SimpleTiledCrsProductTensor.hpp>

Classes

struct  Coord
 
struct  Tile
 

Public Types

typedef ExecutionSpace execution_space
 
typedef int size_type
 
typedef ValueType value_type
 

Public Member Functions

 ~SimpleTiledCrsProductTensor ()
 
 SimpleTiledCrsProductTensor ()
 
 SimpleTiledCrsProductTensor (const SimpleTiledCrsProductTensor &rhs)
 
SimpleTiledCrsProductTensoroperator= (const SimpleTiledCrsProductTensor &rhs)
 
KOKKOS_INLINE_FUNCTION size_type dimension () const
 Dimension of the tensor. More...
 
KOKKOS_INLINE_FUNCTION size_type entry_count () const
 Number of sparse entries. More...
 
KOKKOS_INLINE_FUNCTION size_type num_i_tiles () const
 Number i-tiles. More...
 
KOKKOS_INLINE_FUNCTION size_type i_begin (const size_type i) const
 Begin entries with for tile 'i'. More...
 
KOKKOS_INLINE_FUNCTION size_type i_size (const size_type i) const
 Number of entries with for tile 'i'. More...
 
KOKKOS_INLINE_FUNCTION size_type num_j_tiles (const size_type i) const
 Number j-tiles. More...
 
KOKKOS_INLINE_FUNCTION size_type j_begin (const size_type i, const size_type j) const
 Begin entries with for tile 'i,j'. More...
 
KOKKOS_INLINE_FUNCTION size_type j_size (const size_type i, const size_type j) const
 Number of entries with for tile 'i,j'. More...
 
KOKKOS_INLINE_FUNCTION size_type num_k_tiles (const size_type i, const size_type j) const
 Number k-tiles. More...
 
KOKKOS_INLINE_FUNCTION size_type k_begin (const size_type i, const size_type j, const size_type k) const
 Begin entries with for tile 'i,j,k'. More...
 
KOKKOS_INLINE_FUNCTION size_type k_size (const size_type i, const size_type j, const size_type k) const
 Number of entries with for tile 'i,j'. More...
 
KOKKOS_INLINE_FUNCTION size_type num_entry (const size_type i, const size_type j, const size_type k, const size_type r) const
 Number of entries for tile (i,j,k) and row r. More...
 
KOKKOS_INLINE_FUNCTION size_type entry_begin (const size_type i, const size_type j, const size_type k, const size_type r) const
 Begin entries for tile (i,j,k) and row r. More...
 
KOKKOS_INLINE_FUNCTION size_type entry_end (const size_type i, const size_type j, const size_type k, const size_type r) const
 End entries for tile (i,j,k) and row r. More...
 
KOKKOS_INLINE_FUNCTION const
size_type
coord (const size_type entry, const size_type c) const
 Coordinates of an entry. More...
 
KOKKOS_INLINE_FUNCTION const
size_type
coord (const size_type entry) const
 Coordinates of an entry. More...
 
KOKKOS_INLINE_FUNCTION const
value_type
value (const size_type entry) const
 Value of an entry. More...
 
KOKKOS_INLINE_FUNCTION size_type num_non_zeros () const
 Number of non-zero's. More...
 
KOKKOS_INLINE_FUNCTION size_type num_flops () const
 Number flop's per multiply-add. More...
 
KOKKOS_INLINE_FUNCTION size_type max_i_tile_size () const
 Max size of any i tile. More...
 
KOKKOS_INLINE_FUNCTION size_type max_jk_tile_size () const
 Max size of any j/k tile. More...
 

Static Public Member Functions

template<typename OrdinalType >
static SimpleTiledCrsProductTensor create (const Stokhos::ProductBasis< OrdinalType, ValueType > &basis, const Stokhos::Sparse3Tensor< OrdinalType, ValueType > &Cijk, const Teuchos::ParameterList &params)
 

Static Public Attributes

static const size_type host_vectorsize = 2
 
static const bool use_intrinsics = false
 
static const size_type cuda_vectorsize = 32
 
static const bool is_cuda
 
static const size_type vectorsize = is_cuda ? cuda_vectorsize : host_vectorsize
 
static const size_type tensor_align = vectorsize
 

Private Types

typedef Kokkos::View
< value_type[],
execution_space
vec_type
 
typedef Kokkos::View
< value_type[],
execution_space
value_array_type
 
typedef Kokkos::View
< size_type[], execution_space
coord_array_type
 
typedef Kokkos::View
< size_type[][2],
Kokkos::LayoutLeft,
execution_space
coord2_array_type
 
typedef Kokkos::View
< size_type *, execution_space
i_begin_type
 
typedef Kokkos::View
< size_type *, execution_space
i_size_type
 
typedef Kokkos::View
< size_type *, execution_space
num_j_type
 
typedef Kokkos::View
< size_type
**, execution_space
j_begin_type
 
typedef Kokkos::View
< size_type
**, execution_space
j_size_type
 
typedef Kokkos::View
< size_type
**, execution_space
num_k_type
 
typedef Kokkos::View
< size_type
***, execution_space
k_begin_type
 
typedef Kokkos::View
< size_type
***, execution_space
k_size_type
 
typedef Kokkos::View
< size_type
****, Kokkos::LayoutRight,
execution_space
row_map_type
 
typedef Kokkos::View
< size_type
****, Kokkos::LayoutRight,
execution_space
num_entry_type
 
typedef Tile< CoordKTile
 
typedef Tile< KTileJTile
 
typedef Tile< JTileITile
 

Private Attributes

value_array_type m_value
 
coord_array_type m_coord
 
coord2_array_type m_coord2
 
i_begin_type m_i_begin
 
i_size_type m_i_size
 
num_j_type m_num_j
 
j_begin_type m_j_begin
 
j_size_type m_j_size
 
num_k_type m_num_k
 
k_begin_type m_k_begin
 
k_size_type m_k_size
 
row_map_type m_row_map
 
num_entry_type m_num_entry
 
size_type m_dimension
 
size_type m_max_i_tile_size
 
size_type m_max_jk_tile_size
 
size_type m_num_i
 
size_type m_nnz
 
size_type m_flops
 

Detailed Description

template<typename ValueType, class ExecutionSpace>
class Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >

Definition at line 29 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

Member Typedef Documentation

template<typename ValueType , class ExecutionSpace >
typedef ExecutionSpace Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::execution_space

Definition at line 32 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef int Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::size_type

Definition at line 33 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef ValueType Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::value_type

Definition at line 34 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< value_type[], execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::vec_type
private

Definition at line 61 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< value_type[], execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::value_array_type
private

Definition at line 62 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< size_type[], execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::coord_array_type
private

Definition at line 63 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< size_type[][2], Kokkos::LayoutLeft, execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::coord2_array_type
private

Definition at line 64 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< size_type*, execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::i_begin_type
private

Definition at line 65 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< size_type*, execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::i_size_type
private

Definition at line 66 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< size_type*, execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::num_j_type
private

Definition at line 67 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< size_type**, execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::j_begin_type
private

Definition at line 68 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< size_type**, execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::j_size_type
private

Definition at line 69 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< size_type**, execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::num_k_type
private

Definition at line 70 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< size_type***, execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::k_begin_type
private

Definition at line 71 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< size_type***, execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::k_size_type
private

Definition at line 72 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< size_type****, Kokkos::LayoutRight, execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::row_map_type
private

Definition at line 74 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Kokkos::View< size_type****, Kokkos::LayoutRight, execution_space > Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::num_entry_type
private

Definition at line 75 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Tile<Coord> Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::KTile
private

Definition at line 108 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Tile<KTile> Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::JTile
private

Definition at line 109 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
typedef Tile<JTile> Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::ITile
private

Definition at line 110 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

Constructor & Destructor Documentation

template<typename ValueType , class ExecutionSpace >
Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::~SimpleTiledCrsProductTensor ( )
inline

Definition at line 115 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::SimpleTiledCrsProductTensor ( )
inline

Definition at line 118 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::SimpleTiledCrsProductTensor ( const SimpleTiledCrsProductTensor< ValueType, ExecutionSpace > &  rhs)
inline

Definition at line 140 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

Member Function Documentation

template<typename ValueType , class ExecutionSpace >
SimpleTiledCrsProductTensor& Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::operator= ( const SimpleTiledCrsProductTensor< ValueType, ExecutionSpace > &  rhs)
inline

Definition at line 162 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::dimension ( ) const
inline

Dimension of the tensor.

Definition at line 189 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::entry_count ( ) const
inline

Number of sparse entries.

Definition at line 193 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::num_i_tiles ( ) const
inline

Number i-tiles.

Definition at line 197 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::i_begin ( const size_type  i) const
inline

Begin entries with for tile 'i'.

Definition at line 201 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::i_size ( const size_type  i) const
inline

Number of entries with for tile 'i'.

Definition at line 205 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::num_j_tiles ( const size_type  i) const
inline

Number j-tiles.

Definition at line 209 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::j_begin ( const size_type  i,
const size_type  j 
) const
inline

Begin entries with for tile 'i,j'.

Definition at line 213 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::j_size ( const size_type  i,
const size_type  j 
) const
inline

Number of entries with for tile 'i,j'.

Definition at line 219 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::num_k_tiles ( const size_type  i,
const size_type  j 
) const
inline

Number k-tiles.

Definition at line 225 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::k_begin ( const size_type  i,
const size_type  j,
const size_type  k 
) const
inline

Begin entries with for tile 'i,j,k'.

Definition at line 230 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::k_size ( const size_type  i,
const size_type  j,
const size_type  k 
) const
inline

Number of entries with for tile 'i,j'.

Definition at line 237 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::num_entry ( const size_type  i,
const size_type  j,
const size_type  k,
const size_type  r 
) const
inline

Number of entries for tile (i,j,k) and row r.

Definition at line 244 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::entry_begin ( const size_type  i,
const size_type  j,
const size_type  k,
const size_type  r 
) const
inline

Begin entries for tile (i,j,k) and row r.

Definition at line 251 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::entry_end ( const size_type  i,
const size_type  j,
const size_type  k,
const size_type  r 
) const
inline

End entries for tile (i,j,k) and row r.

Definition at line 258 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION const size_type& Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::coord ( const size_type  entry,
const size_type  c 
) const
inline

Coordinates of an entry.

Definition at line 265 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION const size_type& Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::coord ( const size_type  entry) const
inline

Coordinates of an entry.

Definition at line 271 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION const value_type& Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::value ( const size_type  entry) const
inline

Value of an entry.

Definition at line 277 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::num_non_zeros ( ) const
inline

Number of non-zero's.

Definition at line 283 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::num_flops ( ) const
inline

Number flop's per multiply-add.

Definition at line 288 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::max_i_tile_size ( ) const
inline

Max size of any i tile.

Definition at line 293 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
KOKKOS_INLINE_FUNCTION size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::max_jk_tile_size ( ) const
inline

Max size of any j/k tile.

Definition at line 297 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
template<typename OrdinalType >
static SimpleTiledCrsProductTensor Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::create ( const Stokhos::ProductBasis< OrdinalType, ValueType > &  basis,
const Stokhos::Sparse3Tensor< OrdinalType, ValueType > &  Cijk,
const Teuchos::ParameterList params 
)
inlinestatic

Definition at line 301 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

Member Data Documentation

template<typename ValueType , class ExecutionSpace >
const size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::host_vectorsize = 2
static

Definition at line 44 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
const bool Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::use_intrinsics = false
static

Definition at line 45 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
const size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::cuda_vectorsize = 32
static

Definition at line 47 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
const bool Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::is_cuda
static
Initial value:
=
false

Definition at line 48 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
const size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::vectorsize = is_cuda ? cuda_vectorsize : host_vectorsize
static

Definition at line 54 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
const size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::tensor_align = vectorsize
static

Definition at line 57 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
value_array_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_value
private

Definition at line 77 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
coord_array_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_coord
private

Definition at line 78 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
coord2_array_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_coord2
private

Definition at line 79 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
i_begin_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_i_begin
private

Definition at line 80 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
i_size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_i_size
private

Definition at line 81 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
num_j_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_num_j
private

Definition at line 82 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
j_begin_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_j_begin
private

Definition at line 83 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
j_size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_j_size
private

Definition at line 84 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
num_k_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_num_k
private

Definition at line 85 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
k_begin_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_k_begin
private

Definition at line 86 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
k_size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_k_size
private

Definition at line 87 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
row_map_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_row_map
private

Definition at line 88 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
num_entry_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_num_entry
private

Definition at line 89 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_dimension
private

Definition at line 90 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_max_i_tile_size
private

Definition at line 91 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_max_jk_tile_size
private

Definition at line 92 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_num_i
private

Definition at line 93 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_nnz
private

Definition at line 94 of file Stokhos_SimpleTiledCrsProductTensor.hpp.

template<typename ValueType , class ExecutionSpace >
size_type Stokhos::SimpleTiledCrsProductTensor< ValueType, ExecutionSpace >::m_flops
private

Definition at line 95 of file Stokhos_SimpleTiledCrsProductTensor.hpp.


The documentation for this class was generated from the following file: