48 #ifndef __INTREPID2_HVOL_TET_CN_FEM_HPP__ 49 #define __INTREPID2_HVOL_TET_CN_FEM_HPP__ 54 #include "Teuchos_LAPACK.hpp" 85 template<EOperator opType>
87 template<
typename outputValueViewType,
88 typename inputPointViewType,
89 typename workViewType,
90 typename vinvViewType>
91 KOKKOS_INLINE_FUNCTION
93 getValues( outputValueViewType outputValues,
94 const inputPointViewType inputPoints,
96 const vinvViewType vinv );
99 KOKKOS_INLINE_FUNCTION
101 getWorkSizePerPoint(ordinal_type order) {
102 auto cardinality = getPnCardinality<3>(order);
107 return 7*cardinality;
109 return getDkCardinality<opType,3>()*cardinality;
114 template<
typename DeviceType, ordinal_type numPtsPerEval,
115 typename outputValueValueType,
class ...outputValueProperties,
116 typename inputPointValueType,
class ...inputPointProperties,
117 typename vinvValueType,
class ...vinvProperties>
119 getValues( Kokkos::DynRankView<outputValueValueType,outputValueProperties...> outputValues,
120 const Kokkos::DynRankView<inputPointValueType, inputPointProperties...> inputPoints,
121 const Kokkos::DynRankView<vinvValueType, vinvProperties...> vinv,
127 template<
typename outputValueViewType,
128 typename inputPointViewType,
129 typename vinvViewType,
130 typename workViewType,
132 ordinal_type numPtsEval>
134 outputValueViewType _outputValues;
135 const inputPointViewType _inputPoints;
136 const vinvViewType _vinv;
139 KOKKOS_INLINE_FUNCTION
140 Functor( outputValueViewType outputValues_,
141 inputPointViewType inputPoints_,
144 : _outputValues(outputValues_), _inputPoints(inputPoints_),
145 _vinv(vinv_), _work(work_) {}
147 KOKKOS_INLINE_FUNCTION
148 void operator()(
const size_type iter)
const {
152 const auto ptRange = Kokkos::pair<ordinal_type,ordinal_type>(ptBegin, ptEnd);
153 const auto input = Kokkos::subview( _inputPoints, ptRange, Kokkos::ALL() );
155 typename workViewType::pointer_type ptr = _work.data() + _work.extent(0)*ptBegin*get_dimension_scalar(_work);
157 auto vcprop = Kokkos::common_view_alloc_prop(_work);
158 workViewType work(Kokkos::view_wrap(ptr,vcprop), (ptEnd-ptBegin)*_work.extent(0));
161 case OPERATOR_VALUE : {
162 auto output = Kokkos::subview( _outputValues, Kokkos::ALL(), ptRange );
171 auto output = Kokkos::subview( _outputValues, Kokkos::ALL(), ptRange, Kokkos::ALL() );
176 INTREPID2_TEST_FOR_ABORT(
true,
177 ">>> ERROR: (Intrepid2::Basis_HVOL_TET_Cn_FEM::Functor) operator is not supported");
186 template<
typename DeviceType = void,
187 typename outputValueType = double,
188 typename pointValueType =
double>
190 :
public Basis<DeviceType,outputValueType,pointValueType> {
199 const EPointType pointType = POINTTYPE_EQUISPACED);
212 getValues( OutputViewType outputValues,
213 const PointViewType inputPoints,
214 const EOperator operatorType = OPERATOR_VALUE)
const override {
215 #ifdef HAVE_INTREPID2_DEBUG 223 Impl::Basis_HVOL_TET_Cn_FEM::
224 getValues<DeviceType,numPtsPerEval>( outputValues,
232 getDofCoords( ScalarViewType dofCoords )
const override {
233 #ifdef HAVE_INTREPID2_DEBUG 235 INTREPID2_TEST_FOR_EXCEPTION( dofCoords.rank() != 2, std::invalid_argument,
236 ">>> ERROR: (Intrepid2::Basis_HVOL_TET_Cn_FEM::getDofCoords) rank = 2 required for dofCoords array");
238 INTREPID2_TEST_FOR_EXCEPTION( static_cast<ordinal_type>(dofCoords.extent(0)) != this->
getCardinality(), std::invalid_argument,
239 ">>> ERROR: (Intrepid2::Basis_HVOL_TET_Cn_FEM::getDofCoords) mismatch in number of dof and 0th dimension of dofCoords array");
241 INTREPID2_TEST_FOR_EXCEPTION( dofCoords.extent(1) != this->
getBaseCellTopology().getDimension(), std::invalid_argument,
242 ">>> ERROR: (Intrepid2::Basis_HVOL_TET_Cn_FEM::getDofCoords) incorrect reference cell (1st) dimension in dofCoords array");
244 Kokkos::deep_copy(dofCoords, this->
dofCoords_);
249 getDofCoeffs( ScalarViewType dofCoeffs )
const override {
250 #ifdef HAVE_INTREPID2_DEBUG 252 INTREPID2_TEST_FOR_EXCEPTION( dofCoeffs.rank() != 1, std::invalid_argument,
253 ">>> ERROR: (Intrepid2::Basis_HVOL_TET_Cn_FEM::getdofCoeffs) rank = 1 required for dofCoeffs array");
255 INTREPID2_TEST_FOR_EXCEPTION( static_cast<ordinal_type>(dofCoeffs.extent(0)) != this->
getCardinality(), std::invalid_argument,
256 ">>> ERROR: (Intrepid2::Basis_HVOL_TET_Cn_FEM::getdofCoeffs) mismatch in number of dof and 0th dimension of dofCoeffs array");
258 Kokkos::deep_copy(dofCoeffs, 1.0);
262 getVandermondeInverse( ScalarViewType vinv )
const {
264 Kokkos::deep_copy(vinv, this->
vinv_);
270 return "Intrepid2_HVOL_TET_Cn_FEM";
288 Kokkos::DynRankView<scalarType,DeviceType>
vinv_;
ordinal_type basisDegree_
Degree of the largest complete polynomial space that can be represented by the basis.
An abstract base class that defines interface for concrete basis implementations for Finite Element (...
virtual const char * getName() const override
Returns basis name.
ordinal_type getCardinality() const
Returns cardinality of the basis.
Tetrahedron topology, 4 nodes.
BasisPtr< typename Kokkos::HostSpace::device_type, OutputType, PointType > HostBasisPtr
Pointer to a Basis whose device type is on the host (Kokkos::HostSpace::device_type), allowing host access to input and output views, and ensuring host execution of basis evaluation.
virtual bool requireOrientation() const override
True if orientation is required.
static constexpr ordinal_type MaxNumPtsPerBasisEval
The maximum number of points to eval in serial mode.
EOperator
Enumeration of primitive operators available in Intrepid. Primitive operators act on reconstructed fu...
Kokkos::DynRankView< scalarType, DeviceType > vinv_
inverse of Generalized Vandermonde matrix, whose columns store the expansion coefficients of the noda...
virtual HostBasisPtr< outputValueType, pointValueType > getHostBasis() const override
Creates and returns a Basis object whose DeviceType template argument is Kokkos::HostSpace::device_ty...
See Intrepid2::Basis_HVOL_TET_Cn_FEM.
See Intrepid2::Basis_HVOL_TET_Cn_FEM.
Basis_HVOL_TET_Cn_FEM(const ordinal_type order, const EPointType pointType=POINTTYPE_EQUISPACED)
Constructor.
void getValues_HVOL_Args(const outputValueViewType outputValues, const inputPointViewType inputPoints, const EOperator operatorType, const shards::CellTopology cellTopo, const ordinal_type basisCard)
Runtime check of the arguments for the getValues method in an HVOL-conforming FEM basis...
EPointType
Enumeration of types of point distributions in Intrepid.
Definition file for FEM basis functions of degree n for H(vol) functions on TET.
See Intrepid2::Basis_HVOL_TET_Cn_FEM.
shards::CellTopology getBaseCellTopology() const
Returns the base cell topology for which the basis is defined. See Shards documentation https://trili...
Implementation of the default HVOL-compatible Lagrange basis of arbitrary degree on Tetrahedron cell...
Kokkos::DynRankView< scalarType, DeviceType > dofCoords_
Coordinates of degrees-of-freedom for basis functions defined in physical space.
Header file for the abstract base class Intrepid2::Basis.