Intrepid2
Intrepid2_HCURL_QUAD_In_FEM.hpp
Go to the documentation of this file.
1 // @HEADER
2 // ************************************************************************
3 //
4 // Intrepid2 Package
5 // Copyright (2007) Sandia Corporation
6 //
7 // Under terms of Contract DE-AC04-94AL85000, there is a non-exclusive
8 // license for use of this work by or on behalf of the U.S. Government.
9 //
10 // Redistribution and use in source and binary forms, with or without
11 // modification, are permitted provided that the following conditions are
12 // met:
13 //
14 // 1. Redistributions of source code must retain the above copyright
15 // notice, this list of conditions and the following disclaimer.
16 //
17 // 2. Redistributions in binary form must reproduce the above copyright
18 // notice, this list of conditions and the following disclaimer in the
19 // documentation and/or other materials provided with the distribution.
20 //
21 // 3. Neither the name of the Corporation nor the names of the
22 // contributors may be used to endorse or promote products derived from
23 // this software without specific prior written permission.
24 //
25 // THIS SOFTWARE IS PROVIDED BY SANDIA CORPORATION "AS IS" AND ANY
26 // EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE
27 // IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR
28 // PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL SANDIA CORPORATION OR THE
29 // CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL,
30 // EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO,
31 // PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR
32 // PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF
33 // LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING
34 // NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS
35 // SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
36 //
37 // Questions? Contact Kyungjoo Kim (kyukim@sandia.gov), or
38 // Mauro Perego (mperego@sandia.gov)
39 //
40 // ************************************************************************
41 // @HEADER
42 
49 #ifndef __INTREPID2_HCURL_QUAD_IN_FEM_HPP__
50 #define __INTREPID2_HCURL_QUAD_IN_FEM_HPP__
51 
52 #include "Intrepid2_Basis.hpp"
54 
55 namespace Intrepid2 {
56 
57  namespace Impl {
58 
63  public:
64  typedef struct Quadrilateral<4> cell_topology_type;
65 
69  template<EOperator opType>
70  struct Serial {
71  template<typename outputValueViewType,
72  typename inputPointViewType,
73  typename workViewType,
74  typename vinvViewType>
75  KOKKOS_INLINE_FUNCTION
76  static void
77  getValues( outputValueViewType outputValues,
78  const inputPointViewType inputPoints,
79  workViewType work,
80  const vinvViewType vinvLine,
81  const vinvViewType vinvBubble );
82 
83  KOKKOS_INLINE_FUNCTION
84  static ordinal_type
85  getWorkSizePerPoint(ordinal_type order) {
86  return 2*getPnCardinality<1>(order)+getPnCardinality<1>(order-1);
87  }
88  };
89 
90  template<typename ExecSpaceType, ordinal_type numPtsPerEval,
91  typename outputValueValueType, class ...outputValueProperties,
92  typename inputPointValueType, class ...inputPointProperties,
93  typename vinvValueType, class ...vinvProperties>
94  static void
95  getValues( Kokkos::DynRankView<outputValueValueType,outputValueProperties...> outputValues,
96  const Kokkos::DynRankView<inputPointValueType, inputPointProperties...> inputPoints,
97  const Kokkos::DynRankView<vinvValueType, vinvProperties...> vinvLine,
98  const Kokkos::DynRankView<vinvValueType, vinvProperties...> vinvBubble,
99  const EOperator operatorType);
100 
104  template<typename outputValueViewType,
105  typename inputPointViewType,
106  typename vinvViewType,
107  typename workViewType,
108  EOperator opType,
109  ordinal_type numPtsEval>
110  struct Functor {
111  outputValueViewType _outputValues;
112  const inputPointViewType _inputPoints;
113  const vinvViewType _vinvLine;
114  const vinvViewType _vinvBubble;
115  workViewType _work;
116 
117  KOKKOS_INLINE_FUNCTION
118  Functor( outputValueViewType outputValues_,
119  inputPointViewType inputPoints_,
120  vinvViewType vinvLine_,
121  vinvViewType vinvBubble_,
122  workViewType work_)
123  : _outputValues(outputValues_), _inputPoints(inputPoints_),
124  _vinvLine(vinvLine_), _vinvBubble(vinvBubble_), _work(work_) {}
125 
126  KOKKOS_INLINE_FUNCTION
127  void operator()(const size_type iter) const {
128  const auto ptBegin = Util<ordinal_type>::min(iter*numPtsEval, _inputPoints.extent(0));
129  const auto ptEnd = Util<ordinal_type>::min(ptBegin+numPtsEval, _inputPoints.extent(0));
130 
131  const auto ptRange = Kokkos::pair<ordinal_type,ordinal_type>(ptBegin, ptEnd);
132  const auto input = Kokkos::subview( _inputPoints, ptRange, Kokkos::ALL() );
133 
134  typename workViewType::pointer_type ptr = _work.data() + _work.extent(0)*ptBegin*get_dimension_scalar(_work);
135 
136  auto vcprop = Kokkos::common_view_alloc_prop(_work);
137  workViewType work(Kokkos::view_wrap(ptr,vcprop), (ptEnd-ptBegin)*_work.extent(0));
138 
139  switch (opType) {
140  case OPERATOR_VALUE : {
141  auto output = Kokkos::subview( _outputValues, Kokkos::ALL(), ptRange, Kokkos::ALL() );
142  Serial<opType>::getValues( output, input, work, _vinvLine, _vinvBubble );
143  break;
144  }
145  case OPERATOR_CURL : {
146  auto output = Kokkos::subview( _outputValues, Kokkos::ALL(), ptRange );
147  Serial<opType>::getValues( output, input, work, _vinvLine, _vinvBubble );
148  break;
149  }
150  default: {
151  INTREPID2_TEST_FOR_ABORT( true,
152  ">>> ERROR: (Intrepid2::Basis_HCURL_QUAD_In_FEM::Functor) operator is not supported");
153 
154  }
155  }
156  }
157  };
158  };
159  }
160 
165  template<typename ExecSpaceType = void,
166  typename outputValueType = double,
167  typename pointValueType = double>
169  : public Basis<ExecSpaceType,outputValueType,pointValueType> {
170  public:
174 
177  Basis_HCURL_QUAD_In_FEM(const ordinal_type order,
178  const EPointType pointType = POINTTYPE_EQUISPACED);
179 
183 
185 
186  virtual
187  void
188  getValues( outputViewType outputValues,
189  const pointViewType inputPoints,
190  const EOperator operatorType = OPERATOR_VALUE ) const {
191 #ifdef HAVE_INTREPID2_DEBUG
192  Intrepid2::getValues_HCURL_Args(outputValues,
193  inputPoints,
194  operatorType,
195  this->getBaseCellTopology(),
196  this->getCardinality() );
197 #endif
198  constexpr ordinal_type numPtsPerEval = Parameters::MaxNumPtsPerBasisEval;
199  Impl::Basis_HCURL_QUAD_In_FEM::
200  getValues<ExecSpaceType,numPtsPerEval>( outputValues,
201  inputPoints,
202  this->vinvLine_,
203  this->vinvBubble_,
204  operatorType );
205  }
206 
207  virtual
208  void
209  getDofCoords( scalarViewType dofCoords ) const {
210 #ifdef HAVE_INTREPID2_DEBUG
211  // Verify rank of output array.
212  INTREPID2_TEST_FOR_EXCEPTION( dofCoords.rank() != 2, std::invalid_argument,
213  ">>> ERROR: (Intrepid2::Basis_HCURL_QUAD_In_FEM::getDofCoords) rank = 2 required for dofCoords array");
214  // Verify 0th dimension of output array.
215  INTREPID2_TEST_FOR_EXCEPTION( static_cast<ordinal_type>(dofCoords.extent(0)) != this->getCardinality(), std::invalid_argument,
216  ">>> ERROR: (Intrepid2::Basis_HCURL_QUAD_In_FEM::getDofCoords) mismatch in number of dof and 0th dimension of dofCoords array");
217  // Verify 1st dimension of output array.
218  INTREPID2_TEST_FOR_EXCEPTION( dofCoords.extent(1) != this->getBaseCellTopology().getDimension(), std::invalid_argument,
219  ">>> ERROR: (Intrepid2::Basis_HCURL_QUAD_In_FEM::getDofCoords) incorrect reference cell (1st) dimension in dofCoords array");
220 #endif
221  Kokkos::deep_copy(dofCoords, this->dofCoords_);
222  }
223 
224  virtual
225  void
226  getDofCoeffs( scalarViewType dofCoeffs ) const {
227 #ifdef HAVE_INTREPID2_DEBUG
228  // Verify rank of output array.
229  INTREPID2_TEST_FOR_EXCEPTION( dofCoeffs.rank() != 2, std::invalid_argument,
230  ">>> ERROR: (Intrepid2::Basis_HCURL_QUAD_In_FEM::getDofCoeffs) rank = 2 required for dofCoeffs array");
231  // Verify 0th dimension of output array.
232  INTREPID2_TEST_FOR_EXCEPTION( static_cast<ordinal_type>(dofCoeffs.extent(0)) != this->getCardinality(), std::invalid_argument,
233  ">>> ERROR: (Intrepid2::Basis_HCURL_QUAD_In_FEM::getDofCoeffs) mismatch in number of dof and 0th dimension of dofCoeffs array");
234  // Verify 1st dimension of output array.
235  INTREPID2_TEST_FOR_EXCEPTION( dofCoeffs.extent(1) != this->getBaseCellTopology().getDimension(), std::invalid_argument,
236  ">>> ERROR: (Intrepid2::Basis_HCURL_QUAD_In_FEM::getDofCoeffs) incorrect reference cell (1st) dimension in dofCoeffs array");
237 #endif
238  Kokkos::deep_copy(dofCoeffs, this->dofCoeffs_);
239  }
240 
241  virtual
242  const char*
243  getName() const {
244  return "Intrepid2_HCURL_QUAD_In_FEM";
245  }
246 
247  virtual
248  bool
250  return true;
251  }
252 
253  private:
254 
256  Kokkos::DynRankView<typename scalarViewType::value_type,ExecSpaceType> vinvLine_, vinvBubble_;
257  };
258 
259 }// namespace Intrepid2
260 
261 
263 
264 #endif
Header file for the Intrepid2::Basis_HGRAD_LINE_Cn_FEM class.
small utility functions
Kokkos::DynRankView< scalarType, Kokkos::LayoutStride, ExecSpaceType > scalarViewType
View type for scalars.
Implementation of the default H(curl)-compatible FEM basis on Quadrilateral cell. ...
Basis_HCURL_QUAD_In_FEM(const ordinal_type order, const EPointType pointType=POINTTYPE_EQUISPACED)
Constructor.
An abstract base class that defines interface for concrete basis implementations for Finite Element (...
Kokkos::DynRankView< outputValueType, Kokkos::LayoutStride, ExecSpaceType > outputViewType
View type for basis value output.
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.
virtual void getDofCoords(scalarViewType dofCoords) const
Returns spatial locations (coordinates) of degrees of freedom on the reference cell.
virtual void getValues(outputViewType outputValues, const pointViewType inputPoints, const EOperator operatorType=OPERATOR_VALUE) const
Evaluation of a FEM basis on a reference cell.
ordinal_type getCardinality() const
Returns cardinality of the basis.
Kokkos::View< ordinal_type ***, typename ExecSpaceType::array_layout, Kokkos::HostSpace > ordinal_type_array_3d_host
View type for 3d host array.
See Intrepid2::Basis_HCURL_QUAD_In_FEM.
Definition file for FEM basis functions of degree n for H(curl) functions on QUAD cells...
static constexpr ordinal_type MaxNumPtsPerBasisEval
The maximum number of points to eval in serial mode.
Kokkos::View< ordinal_type *,typename ExecSpaceType::array_layout, Kokkos::HostSpace > ordinal_type_array_1d_host
View type for 1d host array.
Kokkos::DynRankView< pointValueType, Kokkos::LayoutStride, ExecSpaceType > pointViewType
View type for input points.
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 > dofCoeffs_
Coefficients for computing degrees of freedom for Lagrangian basis If P is an element of the space sp...
virtual const char * getName() const
Returns basis name.
virtual bool requireOrientation() const
True if orientation is required.
Kokkos::DynRankView< typename scalarViewType::value_type, ExecSpaceType > vinvLine_
inverse of Generalized Vandermonde matrix (isotropic order)
Header file for the abstract base class Intrepid2::Basis.
Kokkos::View< ordinal_type **,typename ExecSpaceType::array_layout, Kokkos::HostSpace > ordinal_type_array_2d_host
View type for 2d host array.