Stokhos Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Classes | Namespaces | Macros | Functions
KokkosBlas2_gemv_MP_Vector.hpp File Reference
#include <type_traits>
#include "Sacado_ConfigDefs.h"
#include "Stokhos_ViewStorage.hpp"
#include "Sacado_MP_Vector.hpp"
#include "Kokkos_View_MP_Vector.hpp"
#include "Kokkos_ArithTraits_MP_Vector.hpp"
#include "KokkosBlas.hpp"
#include "Stokhos_Sacado_Kokkos_MP_Vector.hpp"
#include "Kokkos_Core.hpp"
#include "Stokhos_config.h"
Include dependency graph for KokkosBlas2_gemv_MP_Vector.hpp:

Go to the source code of this file.

Classes

struct  updateF< AViewType, XViewType, YViewType, IndexType >
 
struct  innerF< AViewType, XViewType, YViewType, IndexType >
 

Namespaces

 KokkosBlas
 

Macros

#define Sacado_MP_Vector_GEMV_Tile_Size(size)   (STOKHOS_GEMV_CACHE_SIZE / size)
 

Functions

template<class Scalar , class VA , class VX , class VY >
void update_MP (typename VA::const_value_type &alpha, const VA &A, const VX &x, typename VY::const_value_type &beta, const VY &y)
 
template<class Scalar , class VA , class VX , class VY >
void inner_products_MP (typename VA::const_value_type &alpha, const VA &A, const VX &x, typename VY::const_value_type &beta, const VY &y)
 
template<typename DA , typename... PA, typename DX , typename... PX, typename DY , typename... PY>
std::enable_if
< Kokkos::is_view_mp_vector
< Kokkos::View< DA, PA...>
>::value
&&Kokkos::is_view_mp_vector
< Kokkos::View< DX, PX...>
>::value
&&Kokkos::is_view_mp_vector
< Kokkos::View< DY, PY...>
>::value >::type 
KokkosBlas::gemv (const char trans[], typename Kokkos::View< DA, PA...>::const_value_type &alpha, const Kokkos::View< DA, PA...> &A, const Kokkos::View< DX, PX...> &x, typename Kokkos::View< DY, PY...>::const_value_type &beta, const Kokkos::View< DY, PY...> &y)
 

Macro Definition Documentation

#define Sacado_MP_Vector_GEMV_Tile_Size (   size)    (STOKHOS_GEMV_CACHE_SIZE / size)

Definition at line 27 of file KokkosBlas2_gemv_MP_Vector.hpp.

Function Documentation

template<class Scalar , class VA , class VX , class VY >
void update_MP ( typename VA::const_value_type &  alpha,
const VA &  A,
const VX &  x,
typename VY::const_value_type &  beta,
const VY &  y 
)

Definition at line 164 of file KokkosBlas2_gemv_MP_Vector.hpp.

template<class Scalar , class VA , class VX , class VY >
void inner_products_MP ( typename VA::const_value_type &  alpha,
const VA &  A,
const VX &  x,
typename VY::const_value_type &  beta,
const VY &  y 
)

Definition at line 196 of file KokkosBlas2_gemv_MP_Vector.hpp.