49 #ifndef __INTREPID2_HGRAD_QUAD_C2_FEM_HPP__ 
   50 #define __INTREPID2_HGRAD_QUAD_C2_FEM_HPP__ 
  104       template<EOperator opType>
 
  106         template<
typename OutputViewType,
 
  107                  typename inputViewType>
 
  108         KOKKOS_INLINE_FUNCTION
 
  110         getValues(       OutputViewType output,
 
  111                    const inputViewType input );
 
  115       template<
typename ExecSpaceType,
 
  116                typename outputValueValueType, 
class ...outputValueProperties,
 
  117                typename inputPointValueType,  
class ...inputPointProperties>
 
  119       getValues(       Kokkos::DynRankView<outputValueValueType,outputValueProperties...> outputValues,
 
  120                  const Kokkos::DynRankView<inputPointValueType, inputPointProperties...>  inputPoints,
 
  121                  const EOperator operatorType);
 
  126       template<
typename outputValueViewType,
 
  127                typename inputPointViewType,
 
  130               outputValueViewType _outputValues;
 
  131         const inputPointViewType  _inputPoints;
 
  133         KOKKOS_INLINE_FUNCTION
 
  134         Functor(      outputValueViewType outputValues_,
 
  135                       inputPointViewType  inputPoints_ )
 
  136           : _outputValues(outputValues_), _inputPoints(inputPoints_) {}
 
  138         KOKKOS_INLINE_FUNCTION
 
  139         void operator()(
const ordinal_type pt)
 const {
 
  141           case OPERATOR_VALUE : {
 
  142             auto       output = Kokkos::subview( _outputValues, Kokkos::ALL(), pt );
 
  143             const auto input  = Kokkos::subview( _inputPoints,                 pt, Kokkos::ALL() );
 
  153           case OPERATOR_MAX : {
 
  154             auto       output = Kokkos::subview( _outputValues, Kokkos::ALL(), pt, Kokkos::ALL() );
 
  155             const auto input  = Kokkos::subview( _inputPoints,                 pt, Kokkos::ALL() );
 
  160             INTREPID2_TEST_FOR_ABORT( opType != OPERATOR_VALUE &&
 
  161                                       opType != OPERATOR_GRAD &&
 
  162                                       opType != OPERATOR_CURL &&
 
  163                                       opType != OPERATOR_D1 &&
 
  164                                       opType != OPERATOR_D2 &&
 
  165                                       opType != OPERATOR_D3 &&
 
  166                                       opType != OPERATOR_D4 &&
 
  167                                       opType != OPERATOR_MAX,
 
  168                                       ">>> ERROR: (Intrepid2::Basis_HGRAD_QUAD_I1_FEM::Serial::getValues) operator is not supported");
 
  176   template<
typename ExecSpaceType = void,
 
  177            typename outputValueType = double,
 
  178            typename pointValueType = 
double>
 
  199                const EOperator operatorType = OPERATOR_VALUE )
 const {
 
  200 #ifdef HAVE_INTREPID2_DEBUG 
  202       Intrepid2::getValues_HGRAD_Args(outputValues,
 
  208       Impl::Basis_HGRAD_QUAD_C2_FEM::
 
  209         getValues<ExecSpaceType>( outputValues,
 
  217 #ifdef HAVE_INTREPID2_DEBUG 
  219       INTREPID2_TEST_FOR_EXCEPTION( dofCoords.rank() != 2, std::invalid_argument,
 
  220                                     ">>> ERROR: (Intrepid2::Basis_HGRAD_QUAD_C2_FEM::getDofCoords) rank = 2 required for dofCoords array");
 
  222       INTREPID2_TEST_FOR_EXCEPTION( static_cast<ordinal_type>(dofCoords.extent(0)) != this->
getCardinality(), std::invalid_argument,
 
  223                                     ">>> ERROR: (Intrepid2::Basis_HGRAD_QUAD_C2_FEM::getDofCoords) mismatch in number of dof and 0th dimension of dofCoords array");
 
  225       INTREPID2_TEST_FOR_EXCEPTION( dofCoords.extent(1) != this->
getBaseCellTopology().getDimension(), std::invalid_argument,
 
  226                                     ">>> ERROR: (Intrepid2::Basis_HGRAD_QUAD_C2_FEM::getDofCoords) incorrect reference cell (1st) dimension in dofCoords array");
 
  228       Kokkos::deep_copy(dofCoords, this->
dofCoords_);
 
  234 #ifdef HAVE_INTREPID2_DEBUG 
  236       INTREPID2_TEST_FOR_EXCEPTION( dofCoeffs.rank() != 1, std::invalid_argument,
 
  237                                     ">>> ERROR: (Intrepid2::Basis_HGRAD_QUAD_C2_FEM::getdofCoeffs) rank = 1 required for dofCoeffs array");
 
  239       INTREPID2_TEST_FOR_EXCEPTION( static_cast<ordinal_type>(dofCoeffs.extent(0)) != this->
getCardinality(), std::invalid_argument,
 
  240                                     ">>> ERROR: (Intrepid2::Basis_HGRAD_QUAD_C2_FEM::getdofCoeffs) mismatch in number of dof and 0th dimension of dofCoeffs array");
 
  242       Kokkos::deep_copy(dofCoeffs, 1.0);
 
  248       return "Intrepid2_HGRAD_QUAD_C2_FEM";
 
Kokkos::View< ordinal_type *, typename ExecSpaceType::array_layout, Kokkos::HostSpace > OrdinalTypeArray1DHost
View type for 1d host array. 
Basis_HGRAD_QUAD_C2_FEM()
Constructor. 
Kokkos::View< ordinal_type **, typename ExecSpaceType::array_layout, Kokkos::HostSpace > OrdinalTypeArray2DHost
View type for 2d host array. 
See Intrepid2::Basis_HGRAD_QUAD_C2_FEM. 
virtual const char * getName() const 
Returns basis name. 
An abstract base class that defines interface for concrete basis implementations for Finite Element (...
shards::CellTopology getBaseCellTopology() const 
Returns the base cell topology for which the basis is defined. See Shards documentation https://trili...
Kokkos::DynRankView< scalarType, ExecSpaceType > dofCoords_
Coordinates of degrees-of-freedom for basis functions defined in physical space. 
See Intrepid2::Basis_HGRAD_QUAD_C2_FEM. 
ordinal_type getCardinality() const 
Returns cardinality of the basis. 
virtual void getDofCoords(ScalarViewType dofCoords) const 
Returns spatial locations (coordinates) of degrees of freedom on the reference cell. 
virtual void getDofCoeffs(ScalarViewType dofCoeffs) const 
Coefficients for computing degrees of freedom for Lagrangian basis If P is an element of the space sp...
virtual void getValues(OutputViewType outputValues, const PointViewType inputPoints, const EOperator operatorType=OPERATOR_VALUE) const 
Evaluation of a FEM basis on a reference cell. 
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. 
Implementation of the default H(grad)-compatible FEM basis of degree 2 on Quadrilateral cell...
Kokkos::DynRankView< PointValueType, Kokkos::LayoutStride, ExecSpaceType > PointViewType
View type for input points. 
Definition file for FEM basis functions of degree 2 for H(grad) functions on QUAD cells...
Kokkos::DynRankView< scalarType, Kokkos::LayoutStride, ExecSpaceType > ScalarViewType
View type for scalars. 
See Intrepid2::Basis_HGRAD_QUAD_C2_FEM. 
Header file for the abstract base class Intrepid2::Basis.