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

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

#include <Intrepid2_LegendreBasis_HVOL_LINE.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_HVOL_LINE_Functor (OutputFieldType output, InputPointsType inputPoints, int polyOrder, EOperator op)
 
KOKKOS_INLINE_FUNCTION void operator() (const TeamMember &teamMember) const
 
size_t team_shmem_size (int team_size) const
 

Public Attributes

OutputFieldType output_
 
InputPointsType inputPoints_
 
int polyOrder_
 
int numFields_
 
int numPoints_
 
EOperator op_
 
size_t fad_size_output_
 

Detailed Description

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

Functor for computing values for the LegendreBasis_HVOL_LINE class.

This functor is not intended for use outside of LegendreBasis_HVOL_LINE.

Definition at line 74 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

Member Typedef Documentation

◆ ExecutionSpace

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

Definition at line 76 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

◆ OutputScratchView

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

Definition at line 78 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

◆ PointScratchView

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

Definition at line 79 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

◆ ScratchSpace

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

Definition at line 77 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

◆ TeamMember

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

Definition at line 82 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

◆ TeamPolicy

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

Definition at line 81 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

Constructor & Destructor Documentation

◆ Hierarchical_HVOL_LINE_Functor()

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
Intrepid2::Hierarchical_HVOL_LINE_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::Hierarchical_HVOL_LINE_Functor ( OutputFieldType  output,
InputPointsType  inputPoints,
int  polyOrder,
EOperator  op 
)
inline

Definition at line 94 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

Member Function Documentation

◆ operator()()

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

Definition at line 106 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

◆ team_shmem_size()

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

Definition at line 157 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

Member Data Documentation

◆ fad_size_output_

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

Definition at line 92 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

◆ inputPoints_

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

Definition at line 85 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

◆ numFields_

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

Definition at line 88 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

◆ numPoints_

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

Definition at line 88 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

◆ op_

template<class DeviceType , class OutputScalar , class PointScalar , class OutputFieldType , class InputPointsType >
EOperator Intrepid2::Hierarchical_HVOL_LINE_Functor< DeviceType, OutputScalar, PointScalar, OutputFieldType, InputPointsType >::op_

Definition at line 90 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

◆ output_

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

Definition at line 84 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.

◆ polyOrder_

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

Definition at line 87 of file Intrepid2_LegendreBasis_HVOL_LINE.hpp.


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