48 #ifndef __INTREPID2_HVOL_TRI_CN_FEM_HPP__ 49 #define __INTREPID2_HVOL_TRI_CN_FEM_HPP__ 54 #include "Teuchos_LAPACK.hpp" 83 template<EOperator opType>
85 template<
typename outputValueViewType,
86 typename inputPointViewType,
87 typename workViewType,
88 typename vinvViewType>
89 KOKKOS_INLINE_FUNCTION
91 getValues( outputValueViewType outputValues,
92 const inputPointViewType inputPoints,
94 const vinvViewType vinv );
97 KOKKOS_INLINE_FUNCTION
99 getWorkSizePerPoint(ordinal_type order) {
100 auto cardinality = getPnCardinality<2>(order);
105 return 5*cardinality;
107 return getDkCardinality<opType,2>()*cardinality;
112 template<
typename ExecSpaceType, ordinal_type numPtsPerEval,
113 typename outputValueValueType,
class ...outputValueProperties,
114 typename inputPointValueType,
class ...inputPointProperties,
115 typename vinvValueType,
class ...vinvProperties>
117 getValues( Kokkos::DynRankView<outputValueValueType,outputValueProperties...> outputValues,
118 const Kokkos::DynRankView<inputPointValueType, inputPointProperties...> inputPoints,
119 const Kokkos::DynRankView<vinvValueType, vinvProperties...> vinv,
125 template<
typename outputValueViewType,
126 typename inputPointViewType,
127 typename vinvViewType,
128 typename workViewType,
130 ordinal_type numPtsEval>
132 outputValueViewType _outputValues;
133 const inputPointViewType _inputPoints;
134 const vinvViewType _vinv;
137 KOKKOS_INLINE_FUNCTION
138 Functor( outputValueViewType outputValues_,
139 inputPointViewType inputPoints_,
142 : _outputValues(outputValues_), _inputPoints(inputPoints_),
143 _vinv(vinv_), _work(work_) {}
145 KOKKOS_INLINE_FUNCTION
146 void operator()(
const size_type iter)
const {
150 const auto ptRange = Kokkos::pair<ordinal_type,ordinal_type>(ptBegin, ptEnd);
151 const auto input = Kokkos::subview( _inputPoints, ptRange, Kokkos::ALL() );
153 typename workViewType::pointer_type ptr = _work.data() + _work.extent(0)*ptBegin*get_dimension_scalar(_work);
155 auto vcprop = Kokkos::common_view_alloc_prop(_work);
156 workViewType work(Kokkos::view_wrap(ptr,vcprop), (ptEnd-ptBegin)*_work.extent(0));
159 case OPERATOR_VALUE : {
160 auto output = Kokkos::subview( _outputValues, Kokkos::ALL(), ptRange );
166 auto output = Kokkos::subview( _outputValues, Kokkos::ALL(), ptRange, Kokkos::ALL() );
171 INTREPID2_TEST_FOR_ABORT(
true,
172 ">>> ERROR: (Intrepid2::Basis_HVOL_TRI_Cn_FEM::Functor) operator is not supported");
181 template<
typename ExecSpaceType = void,
182 typename outputValueType = double,
183 typename pointValueType =
double>
185 :
public Basis<ExecSpaceType,outputValueType,pointValueType> {
194 const EPointType pointType = POINTTYPE_EQUISPACED);
209 const EOperator operatorType = OPERATOR_VALUE)
const {
210 #ifdef HAVE_INTREPID2_DEBUG 218 Impl::Basis_HVOL_TRI_Cn_FEM::
219 getValues<ExecSpaceType,numPtsPerEval>( outputValues,
228 #ifdef HAVE_INTREPID2_DEBUG 230 INTREPID2_TEST_FOR_EXCEPTION( dofCoords.rank() != 2, std::invalid_argument,
231 ">>> ERROR: (Intrepid2::Basis_HVOL_TRI_Cn_FEM::getDofCoords) rank = 2 required for dofCoords array");
233 INTREPID2_TEST_FOR_EXCEPTION( static_cast<ordinal_type>(dofCoords.extent(0)) != this->
getCardinality(), std::invalid_argument,
234 ">>> ERROR: (Intrepid2::Basis_HVOL_TRI_Cn_FEM::getDofCoords) mismatch in number of dof and 0th dimension of dofCoords array");
236 INTREPID2_TEST_FOR_EXCEPTION( dofCoords.extent(1) != this->
getBaseCellTopology().getDimension(), std::invalid_argument,
237 ">>> ERROR: (Intrepid2::Basis_HVOL_TRI_Cn_FEM::getDofCoords) incorrect reference cell (1st) dimension in dofCoords array");
239 Kokkos::deep_copy(dofCoords, this->
dofCoords_);
245 #ifdef HAVE_INTREPID2_DEBUG 247 INTREPID2_TEST_FOR_EXCEPTION( dofCoeffs.rank() != 1, std::invalid_argument,
248 ">>> ERROR: (Intrepid2::Basis_HVOL_TRI_Cn_FEM::getdofCoeffs) rank = 1 required for dofCoeffs array");
250 INTREPID2_TEST_FOR_EXCEPTION( static_cast<ordinal_type>(dofCoeffs.extent(0)) != this->
getCardinality(), std::invalid_argument,
251 ">>> ERROR: (Intrepid2::Basis_HVOL_TRI_Cn_FEM::getdofCoeffs) mismatch in number of dof and 0th dimension of dofCoeffs array");
253 Kokkos::deep_copy(dofCoeffs, 1.0);
257 getVandermondeInverse( ScalarViewType vinv )
const {
259 Kokkos::deep_copy(vinv, this->
vinv_);
265 return "Intrepid2_HVOL_TRI_Cn_FEM";
278 Kokkos::DynRankView<scalarType,ExecSpaceType>
vinv_;
Implementation of the default HVOL-compatible Lagrange basis of arbitrary degree on Triangle cell...
virtual void getValues(OutputViewType outputValues, const PointViewType inputPoints, const EOperator operatorType=OPERATOR_VALUE) const
Evaluation of a FEM basis on a reference cell.
virtual void getDofCoords(ScalarViewType dofCoords) const
Returns spatial locations (coordinates) of degrees of freedom on the reference cell.
Kokkos::View< ordinal_type *, typename ExecSpaceType::array_layout, Kokkos::HostSpace > OrdinalTypeArray1DHost
View type for 1d host array.
Kokkos::View< ordinal_type **, typename ExecSpaceType::array_layout, Kokkos::HostSpace > OrdinalTypeArray2DHost
View type for 2d host array.
ordinal_type getCardinality() const
Returns cardinality of the basis.
An abstract base class that defines interface for concrete basis implementations for Finite Element (...
virtual void getDofCoeffs(ScalarViewType dofCoeffs) const
Coefficients for computing degrees of freedom for Lagrangian basis If P is an element of the space sp...
Kokkos::DynRankView< scalarType, ExecSpaceType > dofCoords_
Coordinates of degrees-of-freedom for basis functions defined in physical space.
shards::CellTopology getBaseCellTopology() const
Returns the base cell topology for which the basis is defined. See Shards documentation https://trili...
See Intrepid2::Basis_HVOL_TRI_Cn_FEM.
See Intrepid2::Basis_HVOL_TRI_Cn_FEM.
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< OutputValueType, Kokkos::LayoutStride, ExecSpaceType > OutputViewType
View type for basis value output.
Kokkos::View< ordinal_type ***, typename ExecSpaceType::array_layout, Kokkos::HostSpace > OrdinalTypeArray3DHost
View type for 3d host array.
virtual const char * getName() const
Returns basis name.
Kokkos::DynRankView< PointValueType, Kokkos::LayoutStride, ExecSpaceType > PointViewType
View type for input points.
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.
Triangle topology, 3 nodes.
virtual bool requireOrientation() const
True if orientation is required.
Kokkos::DynRankView< scalarType, ExecSpaceType > vinv_
inverse of Generalized Vandermonde matrix, whose columns store the expansion coefficients of the noda...
Kokkos::DynRankView< scalarType, Kokkos::LayoutStride, ExecSpaceType > ScalarViewType
View type for scalars.
ScalarTraits< pointValueType >::scalar_type scalarType
Scalar type for point values.
Definition file for FEM basis functions of degree n for H(vol) functions on TRI.
Header file for the abstract base class Intrepid2::Basis.
Basis_HVOL_TRI_Cn_FEM(const ordinal_type order, const EPointType pointType=POINTTYPE_EQUISPACED)
Constructor.
See Intrepid2::Basis_HVOL_TRI_Cn_FEM.