16 #ifndef __INTREPID2_HCURL_QUAD_IN_FEM_DEF_HPP__
17 #define __INTREPID2_HCURL_QUAD_IN_FEM_DEF_HPP__
24 template<EOperator OpType>
25 template<
typename OutputViewType,
26 typename InputViewType,
27 typename WorkViewType,
28 typename VinvViewType>
29 KOKKOS_INLINE_FUNCTION
31 Basis_HCURL_QUAD_In_FEM::Serial<OpType>::
32 getValues( OutputViewType output,
33 const InputViewType input,
35 const VinvViewType vinvLine,
36 const VinvViewType vinvBubble) {
37 const ordinal_type cardLine = vinvLine.extent(0);
38 const ordinal_type cardBubble = vinvBubble.extent(0);
40 const ordinal_type npts = input.extent(0);
42 typedef Kokkos::pair<ordinal_type,ordinal_type> range_type;
43 const auto input_x = Kokkos::subview(input, Kokkos::ALL(), range_type(0,1));
44 const auto input_y = Kokkos::subview(input, Kokkos::ALL(), range_type(1,2));
46 const int dim_s = get_dimension_scalar(input);
47 auto ptr0 = work.data();
48 auto ptr1 = work.data()+cardLine*npts*dim_s;
49 auto ptr2 = work.data()+2*cardLine*npts*dim_s;
51 typedef typename Kokkos::DynRankView<typename InputViewType::value_type, typename WorkViewType::memory_space> ViewType;
52 auto vcprop = Kokkos::common_view_alloc_prop(input);
55 case OPERATOR_VALUE: {
56 ViewType workLine(Kokkos::view_wrap(ptr0, vcprop), cardLine, npts);
57 ViewType outputLine(Kokkos::view_wrap(ptr1, vcprop), cardLine, npts);
58 ViewType outputBubble(Kokkos::view_wrap(ptr2, vcprop), cardBubble, npts);
63 Impl::Basis_HGRAD_LINE_Cn_FEM::Serial<OPERATOR_VALUE>::
64 getValues(outputBubble, input_x, workLine, vinvBubble);
66 Impl::Basis_HGRAD_LINE_Cn_FEM::Serial<OPERATOR_VALUE>::
67 getValues(outputLine, input_y, workLine, vinvLine);
70 const auto output_x = outputBubble;
71 const auto output_y = outputLine;
73 for (ordinal_type j=0;j<cardLine;++j)
74 for (ordinal_type i=0;i<cardBubble;++i,++idx)
75 for (ordinal_type k=0;k<npts;++k) {
76 output.access(idx,k,0) = output_x.access(i,k)*output_y.access(j,k);
77 output.access(idx,k,1) = 0.0;
82 Impl::Basis_HGRAD_LINE_Cn_FEM::Serial<OPERATOR_VALUE>::
83 getValues(outputBubble, input_y, workLine, vinvBubble);
85 Impl::Basis_HGRAD_LINE_Cn_FEM::Serial<OPERATOR_VALUE>::
86 getValues(outputLine, input_x, workLine, vinvLine);
89 const auto output_x = outputLine;
90 const auto output_y = outputBubble;
91 for (ordinal_type j=0;j<cardBubble;++j)
92 for (ordinal_type i=0;i<cardLine;++i,++idx)
93 for (ordinal_type k=0;k<npts;++k) {
94 output.access(idx,k,0) = 0.0;
95 output.access(idx,k,1) = output_x.access(i,k)*output_y.access(j,k);
101 case OPERATOR_CURL: {
102 ordinal_type idx = 0;
104 ViewType workLine(Kokkos::view_wrap(ptr0, vcprop), cardLine, npts);
106 ViewType output_x(Kokkos::view_wrap(ptr2, vcprop), cardBubble, npts);
108 ViewType output_y(Kokkos::view_wrap(ptr1, vcprop), cardLine, npts,1);
110 Impl::Basis_HGRAD_LINE_Cn_FEM::Serial<OPERATOR_VALUE>::
111 getValues(output_x, input_x, workLine, vinvBubble);
113 Impl::Basis_HGRAD_LINE_Cn_FEM::Serial<OPERATOR_Dn>::
114 getValues(output_y, input_y, workLine, vinvLine, 1);
117 for (ordinal_type j=0;j<cardLine;++j)
118 for (ordinal_type i=0;i<cardBubble;++i,++idx)
119 for (ordinal_type k=0;k<npts;++k)
120 output.access(idx,k) = -output_x.access(i,k)*output_y.access(j,k,0);
123 ViewType workLine(Kokkos::view_wrap(ptr0, vcprop), cardLine, npts);
125 ViewType output_x(Kokkos::view_wrap(ptr1, vcprop), cardLine, npts,1);
127 ViewType output_y(Kokkos::view_wrap(ptr2, vcprop), cardBubble, npts);
129 Impl::Basis_HGRAD_LINE_Cn_FEM::Serial<OPERATOR_VALUE>::
130 getValues(output_y, input_y, workLine, vinvBubble);
132 Impl::Basis_HGRAD_LINE_Cn_FEM::Serial<OPERATOR_Dn>::
133 getValues(output_x, input_x, workLine, vinvLine, 1);
136 for (ordinal_type j=0;j<cardBubble;++j)
137 for (ordinal_type i=0;i<cardLine;++i,++idx)
138 for (ordinal_type k=0;k<npts;++k)
139 output.access(idx,k) = output_x.access(i,k,0)*output_y.access(j,k);
144 INTREPID2_TEST_FOR_ABORT(
true,
145 ">>> ERROR: (Intrepid2::Basis_HCURL_QUAD_In_FEM::Serial::getValues) operator is not supported" );
150 template<
typename DT, ordinal_type numPtsPerEval,
151 typename outputValueValueType,
class ...outputValueProperties,
152 typename inputPointValueType,
class ...inputPointProperties,
153 typename vinvValueType,
class ...vinvProperties>
155 Basis_HCURL_QUAD_In_FEM::
156 getValues( Kokkos::DynRankView<outputValueValueType,outputValueProperties...> outputValues,
157 const Kokkos::DynRankView<inputPointValueType, inputPointProperties...> inputPoints,
158 const Kokkos::DynRankView<vinvValueType, vinvProperties...> vinvLine,
159 const Kokkos::DynRankView<vinvValueType, vinvProperties...> vinvBubble,
160 const EOperator operatorType ) {
161 typedef Kokkos::DynRankView<outputValueValueType,outputValueProperties...> outputValueViewType;
162 typedef Kokkos::DynRankView<inputPointValueType, inputPointProperties...> inputPointViewType;
163 typedef Kokkos::DynRankView<vinvValueType, vinvProperties...> vinvViewType;
164 typedef typename ExecSpace<typename inputPointViewType::execution_space,typename DT::execution_space>::ExecSpaceType ExecSpaceType;
167 const auto loopSizeTmp1 = (inputPoints.extent(0)/numPtsPerEval);
168 const auto loopSizeTmp2 = (inputPoints.extent(0)%numPtsPerEval != 0);
169 const auto loopSize = loopSizeTmp1 + loopSizeTmp2;
170 Kokkos::RangePolicy<ExecSpaceType,Kokkos::Schedule<Kokkos::Static> > policy(0, loopSize);
172 typedef typename inputPointViewType::value_type inputPointType;
174 const ordinal_type cardinality = outputValues.extent(0);
176 ordinal_type order = 0;
177 ordinal_type cardBubble;
178 ordinal_type cardLine;
180 cardBubble = Intrepid2::getPnCardinality<1>(order);
181 cardLine = Intrepid2::getPnCardinality<1>(++order);
184 auto vcprop = Kokkos::common_view_alloc_prop(inputPoints);
185 typedef typename Kokkos::DynRankView< inputPointType, typename inputPointViewType::memory_space> workViewType;
187 switch (operatorType) {
188 case OPERATOR_VALUE: {
189 auto workSize = Serial<OPERATOR_VALUE>::getWorkSizePerPoint(order);
190 workViewType work(Kokkos::view_alloc(
"Basis_HCURL_QUAD_In_FEM::getValues::work", vcprop), workSize, inputPoints.extent(0));
191 typedef Functor<outputValueViewType,inputPointViewType,vinvViewType, workViewType,
192 OPERATOR_VALUE,numPtsPerEval> FunctorType;
193 Kokkos::parallel_for( policy, FunctorType(outputValues, inputPoints, vinvLine, vinvBubble, work) );
196 case OPERATOR_CURL: {
197 auto workSize = Serial<OPERATOR_CURL>::getWorkSizePerPoint(order);
198 workViewType work(Kokkos::view_alloc(
"Basis_HCURL_QUAD_In_FEM::getValues::work", vcprop), workSize, inputPoints.extent(0));
199 typedef Functor<outputValueViewType,inputPointViewType,vinvViewType, workViewType,
200 OPERATOR_CURL,numPtsPerEval> FunctorType;
201 Kokkos::parallel_for( policy, FunctorType(outputValues, inputPoints, vinvLine, vinvBubble, work) );
205 INTREPID2_TEST_FOR_EXCEPTION(
true , std::invalid_argument,
206 ">>> ERROR (Basis_HCURL_QUAD_In_FEM): Operator type not implemented" );
213 template<
typename DT,
typename OT,
typename PT>
216 const EPointType pointType ) {
218 INTREPID2_TEST_FOR_EXCEPTION( !(pointType == POINTTYPE_EQUISPACED ||
219 pointType == POINTTYPE_WARPBLEND), std::invalid_argument,
220 ">>> ERROR (Basis_HCURL_QUAD_In_FEM): pointType must be either equispaced or warpblend.");
230 this->vinvLine_ = Kokkos::DynRankView<typename ScalarViewType::value_type,DT>(
"Hcurl::Quad::In::vinvLine", cardLine, cardLine);
231 this->vinvBubble_ = Kokkos::DynRankView<typename ScalarViewType::value_type,DT>(
"Hcurl::Quad::In::vinvBubble", cardBubble, cardBubble);
233 lineBasis.getVandermondeInverse(this->vinvLine_);
234 bubbleBasis.getVandermondeInverse(this->vinvBubble_);
236 const ordinal_type spaceDim = 2;
237 this->basisCardinality_ = 2*cardLine*cardBubble;
238 this->basisDegree_ = order;
239 this->basisCellTopologyKey_ = shards::Quadrilateral<4>::key;
240 this->basisType_ = BASIS_FEM_LAGRANGIAN;
241 this->basisCoordinates_ = COORDINATES_CARTESIAN;
242 this->functionSpace_ = FUNCTION_SPACE_HCURL;
243 pointType_ = pointType;
248 const ordinal_type tagSize = 4;
249 const ordinal_type posScDim = 0;
250 const ordinal_type posScOrd = 1;
251 const ordinal_type posDfOrd = 2;
255 INTREPID2_TEST_FOR_EXCEPTION( order >
Parameters::MaxOrder, std::invalid_argument,
"polynomial order exceeds the max supported by this class");
260 ordinal_type tags[2*maxCardLine*maxCardBubble][4];
262 const ordinal_type edge_x[2] = {0,2};
263 const ordinal_type edge_y[2] = {3,1};
265 ordinal_type idx = 0;
275 intr_ndofs_per_direction = (cardLine-2)*cardBubble,
276 intr_ndofs = 2*intr_ndofs_per_direction;
279 for (ordinal_type j=0;j<cardLine;++j) {
280 const auto tag_y = lineBasis.
getDofTag(j);
281 for (ordinal_type i=0;i<cardBubble;++i,++idx) {
282 const auto tag_x = bubbleBasis.
getDofTag(i);
284 if (tag_x(0) == 1 && tag_y(0) == 0) {
287 tags[idx][1] = edge_x[tag_y(1)];
288 tags[idx][2] = tag_x(2);
289 tags[idx][3] = tag_x(3);
294 tags[idx][2] = tag_x(2) + tag_x(3)*tag_y(2);
295 tags[idx][3] = intr_ndofs;
301 for (ordinal_type j=0;j<cardBubble;++j) {
302 const auto tag_y = bubbleBasis.
getDofTag(j);
303 for (ordinal_type i=0;i<cardLine;++i,++idx) {
304 const auto tag_x = lineBasis.
getDofTag(i);
306 if (tag_x(0) == 0 && tag_y(0) == 1) {
309 tags[idx][1] = edge_y[tag_x(1)];
310 tags[idx][2] = tag_y(2);
311 tags[idx][3] = tag_y(3);
316 tags[idx][2] = intr_ndofs_per_direction + tag_x(2) + tag_x(3)*tag_y(2);
317 tags[idx][3] = intr_ndofs;
321 INTREPID2_TEST_FOR_EXCEPTION( idx != this->basisCardinality_ , std::runtime_error,
322 ">>> ERROR (Basis_HCURL_QUAD_In_FEM): " \
323 "counted tag index is not same as cardinality." );
326 OrdinalTypeArray1DHost tagView(&tags[0][0], this->basisCardinality_*4);
330 this->setOrdinalTagData(this->tagToOrdinal_,
333 this->basisCardinality_,
341 Kokkos::DynRankView<typename ScalarViewType::value_type,typename DT::execution_space::array_layout,Kokkos::HostSpace>
342 dofCoordsHost(
"dofCoordsHost", this->basisCardinality_, spaceDim);
345 Kokkos::DynRankView<typename ScalarViewType::value_type,typename DT::execution_space::array_layout,Kokkos::HostSpace>
346 dofCoeffsHost(
"dofCoeffsHost", this->basisCardinality_, spaceDim);
348 Kokkos::DynRankView<typename ScalarViewType::value_type,DT>
349 dofCoordsLine(
"dofCoordsLine", cardLine, 1),
350 dofCoordsBubble(
"dofCoordsBubble", cardBubble, 1);
353 auto dofCoordsLineHost = Kokkos::create_mirror_view(dofCoordsLine);
354 Kokkos::deep_copy(dofCoordsLineHost, dofCoordsLine);
357 auto dofCoordsBubbleHost = Kokkos::create_mirror_view(dofCoordsBubble);
358 Kokkos::deep_copy(dofCoordsBubbleHost, dofCoordsBubble);
361 ordinal_type idx = 0;
364 for (ordinal_type j=0;j<cardLine;++j) {
365 for (ordinal_type i=0;i<cardBubble;++i,++idx) {
366 dofCoordsHost(idx,0) = dofCoordsBubbleHost(i,0);
367 dofCoordsHost(idx,1) = dofCoordsLineHost(j,0);
368 dofCoeffsHost(idx,0) = 1.0;
373 for (ordinal_type j=0;j<cardBubble;++j) {
374 for (ordinal_type i=0;i<cardLine;++i,++idx) {
375 dofCoordsHost(idx,0) = dofCoordsLineHost(i,0);
376 dofCoordsHost(idx,1) = dofCoordsBubbleHost(j,0);
377 dofCoeffsHost(idx,1) = 1.0;
382 this->dofCoords_ = Kokkos::create_mirror_view(
typename DT::memory_space(), dofCoordsHost);
383 Kokkos::deep_copy(this->dofCoords_, dofCoordsHost);
385 this->dofCoeffs_ = Kokkos::create_mirror_view(
typename DT::memory_space(), dofCoeffsHost);
386 Kokkos::deep_copy(this->dofCoeffs_, dofCoeffsHost);
389 template<
typename DT,
typename OT,
typename PT>
392 ordinal_type& perTeamSpaceSize,
393 ordinal_type& perThreadSpaceSize,
394 const PointViewType inputPoints,
395 const EOperator operatorType)
const {
396 perTeamSpaceSize = 0;
397 perThreadSpaceSize = (2*this->vinvLine_.extent(0)+this->vinvBubble_.extent(0))*get_dimension_scalar(inputPoints)*
sizeof(
typename BasisBase::scalarType);
400 template<
typename DT,
typename OT,
typename PT>
401 KOKKOS_INLINE_FUNCTION
403 Basis_HCURL_QUAD_In_FEM<DT,OT,PT>::getValues(
404 OutputViewType outputValues,
405 const PointViewType inputPoints,
406 const EOperator operatorType,
407 const typename Kokkos::TeamPolicy<typename DT::execution_space>::member_type& team_member,
408 const typename DT::execution_space::scratch_memory_space & scratchStorage,
409 const ordinal_type subcellDim,
410 const ordinal_type subcellOrdinal)
const {
412 INTREPID2_TEST_FOR_ABORT( !((subcellDim == -1) && (subcellOrdinal == -1)),
413 ">>> ERROR: (Intrepid2::Basis_HCURL_QUAD_In_FEM::getValues), The capability of selecting subsets of basis functions has not been implemented yet.");
415 const int numPoints = inputPoints.extent(0);
416 using ScalarType =
typename ScalarTraits<typename PointViewType::value_type>::scalar_type;
417 using WorkViewType = Kokkos::DynRankView< ScalarType,typename DT::execution_space::scratch_memory_space,Kokkos::MemoryTraits<Kokkos::Unmanaged> >;
418 ordinal_type sizePerPoint = (2*this->vinvLine_.extent(0)+this->vinvBubble_.extent(0))*get_dimension_scalar(inputPoints);
419 WorkViewType workView(scratchStorage, sizePerPoint*team_member.team_size());
420 using range_type = Kokkos::pair<ordinal_type,ordinal_type>;
422 switch(operatorType) {
424 Kokkos::parallel_for (Kokkos::TeamThreadRange (team_member, numPoints), [=] (ordinal_type& pt) {
425 auto output = Kokkos::subview( outputValues, Kokkos::ALL(), range_type (pt,pt+1), Kokkos::ALL() );
426 const auto input = Kokkos::subview( inputPoints, range_type(pt, pt+1), Kokkos::ALL() );
427 WorkViewType work(workView.data() + sizePerPoint*team_member.team_rank(), sizePerPoint);
428 Impl::Basis_HCURL_QUAD_In_FEM::Serial<OPERATOR_VALUE>::getValues( output, input, work, this->vinvLine_, this->vinvBubble_ );
432 Kokkos::parallel_for (Kokkos::TeamThreadRange (team_member, numPoints), [=] (ordinal_type& pt) {
433 auto output = Kokkos::subview( outputValues, Kokkos::ALL(), range_type(pt,pt+1), Kokkos::ALL() );
434 const auto input = Kokkos::subview( inputPoints, range_type(pt,pt+1), Kokkos::ALL() );
435 WorkViewType work(workView.data() + sizePerPoint*team_member.team_rank(), sizePerPoint);
436 Impl::Basis_HCURL_QUAD_In_FEM::Serial<OPERATOR_CURL>::getValues( output, input, work, this->vinvLine_, this->vinvBubble_ );
440 INTREPID2_TEST_FOR_ABORT(
true,
441 ">>> ERROR (Basis_HCURL_QUAD_In_FEM): getValues not implemented for this operator");
const OrdinalTypeArrayStride1DHost getDofTag(const ordinal_type dofOrd) const
DoF ordinal to DoF tag lookup.
virtual void getDofCoords(ScalarViewType dofCoords) const override
Returns spatial locations (coordinates) of degrees of freedom on the reference cell.
ordinal_type getCardinality() const
Returns cardinality of the basis.
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.
virtual void getDofCoords(ScalarViewType dofCoords) const override
Returns spatial locations (coordinates) of degrees of freedom on the reference cell.
Implementation of the locally H(grad)-compatible FEM basis of variable order on the [-1...
Implementation of the locally HVOL-compatible FEM basis of variable order on the [-1,1] reference line cell, using Lagrange polynomials.
static constexpr ordinal_type MaxOrder
The maximum reconstruction order.