Intrepid2
Public Types | Public Member Functions | Public Attributes | Static Public Attributes | List of all members
Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType > Class Template Reference

Functor for computing values for the IntegratedLegendreBasis_HGRAD_TRI class. More...

#include <Intrepid2_IntegratedLegendreBasis_HGRAD_TRI.hpp>

Public Types

using ExecutionSpace = typename DeviceType::execution_space
 
using ScratchSpace = typename ExecutionSpace::scratch_memory_space
 
using OutputScratchView = Kokkos::View<OutputScalar*,ScratchSpace,Kokkos::MemoryTraits<Kokkos::Unmanaged>>
 
using PointScratchView = Kokkos::View<PointScalar*, ScratchSpace,Kokkos::MemoryTraits<Kokkos::Unmanaged>>
 
using TeamPolicy = Kokkos::TeamPolicy<ExecutionSpace>
 
using TeamMember = typename TeamPolicy::member_type
 

Public Member Functions

 Hierarchical_HGRAD_TRI_Functor (EOperator opType, OutputFieldType output, InputPointsType inputPoints, int polyOrder, bool defineVertexFunctions)
 
KOKKOS_INLINE_FUNCTION void operator() (const TeamMember &teamMember) const
 
size_t team_shmem_size (int team_size) const
 

Public Attributes

EOperator opType_
 
OutputFieldType output_
 
InputPointsType inputPoints_
 
int polyOrder_
 
bool defineVertexFunctions_
 
int numFields_
 
int numPoints_
 
size_t fad_size_output_
 
const int edge_start_ [numEdges] = {0,1,0}
 
const int edge_end_ [numEdges] = {1,2,2}
 

Static Public Attributes

static const int numVertices = 3
 
static const int numEdges = 3
 

Detailed Description

template<class DeviceType, class OutputScalar, class PointScalar, class OutputFieldType, class InputPointsType>
class Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >

Functor for computing values for the IntegratedLegendreBasis_HGRAD_TRI class.

This functor is not intended for use outside of IntegratedLegendreBasis_HGRAD_TRI.

Definition at line 70 of file Intrepid2_IntegratedLegendreBasis_HGRAD_TRI.hpp.

Member Typedef Documentation

◆ ExecutionSpace

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
using Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::ExecutionSpace = typename DeviceType::execution_space

◆ OutputScratchView

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
using Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::OutputScratchView = Kokkos::View<OutputScalar*,ScratchSpace,Kokkos::MemoryTraits<Kokkos::Unmanaged>>

◆ PointScratchView

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
using Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::PointScratchView = Kokkos::View<PointScalar*, ScratchSpace,Kokkos::MemoryTraits<Kokkos::Unmanaged>>

◆ ScratchSpace

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
using Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::ScratchSpace = typename ExecutionSpace::scratch_memory_space

◆ TeamMember

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
using Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::TeamMember = typename TeamPolicy::member_type

◆ TeamPolicy

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
using Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::TeamPolicy = Kokkos::TeamPolicy<ExecutionSpace>

Constructor & Destructor Documentation

◆ Hierarchical_HGRAD_TRI_Functor()

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::Hierarchical_HGRAD_TRI_Functor ( EOperator opType,
OutputFieldType output,
InputPointsType inputPoints,
int polyOrder,
bool defineVertexFunctions )
inline

Member Function Documentation

◆ operator()()

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
KOKKOS_INLINE_FUNCTION void Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::operator() ( const TeamMember & teamMember) const
inline

◆ team_shmem_size()

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
size_t Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::team_shmem_size ( int team_size) const
inline

Member Data Documentation

◆ defineVertexFunctions_

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
bool Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::defineVertexFunctions_

◆ edge_end_

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
const int Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::edge_end_[numEdges] = {1,2,2}

◆ edge_start_

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
const int Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::edge_start_[numEdges] = {0,1,0}

◆ fad_size_output_

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
size_t Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::fad_size_output_

◆ inputPoints_

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
InputPointsType Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::inputPoints_

◆ numEdges

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
const int Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::numEdges = 3
static

◆ numFields_

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
int Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::numFields_

◆ numPoints_

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
int Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::numPoints_

◆ numVertices

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
const int Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::numVertices = 3
static

◆ opType_

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
EOperator Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::opType_

◆ output_

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
OutputFieldType Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::output_

◆ polyOrder_

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
int Intrepid2::Hierarchical_HGRAD_TRI_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::polyOrder_

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