48 #ifndef __INTREPID2_HVOL_LINE_CN_FEM_DEF_HPP__ 49 #define __INTREPID2_HVOL_LINE_CN_FEM_DEF_HPP__ 56 template<EOperator opType>
57 template<
typename OutputViewType,
58 typename inputViewType,
59 typename workViewType,
60 typename vinvViewType>
61 KOKKOS_INLINE_FUNCTION
63 Basis_HVOL_LINE_Cn_FEM::Serial<opType>::
64 getValues( OutputViewType output,
65 const inputViewType input,
67 const vinvViewType vinv,
68 const ordinal_type operatorDn ) {
69 ordinal_type opDn = operatorDn;
71 const ordinal_type card = vinv.extent(0);
72 const ordinal_type npts = input.extent(0);
74 const ordinal_type order = card - 1;
75 const double alpha = 0.0, beta = 0.0;
77 typedef typename Kokkos::DynRankView<typename workViewType::value_type, typename workViewType::memory_space> viewType;
78 auto vcprop = Kokkos::common_view_alloc_prop(work);
81 case OPERATOR_VALUE: {
82 viewType phis(Kokkos::view_wrap(work.data(), vcprop), card, npts);
84 Impl::Basis_HGRAD_LINE_Cn_FEM_JACOBI::
85 Serial<opType>::getValues(phis, input, order, alpha, beta);
87 for (ordinal_type i=0;i<card;++i)
88 for (ordinal_type j=0;j<npts;++j) {
89 output.access(i,j) = 0.0;
90 for (ordinal_type k=0;k<card;++k)
91 output.access(i,j) += vinv(k,i)*phis.access(k,j);
109 const ordinal_type dkcard = 1;
110 viewType phis(Kokkos::view_wrap(work.data(), vcprop), card, npts, dkcard);
111 Impl::Basis_HGRAD_LINE_Cn_FEM_JACOBI::
112 Serial<opType>::getValues(phis, input, order, alpha, beta, opDn);
114 for (ordinal_type i=0;i<card;++i)
115 for (ordinal_type j=0;j<npts;++j)
116 for (ordinal_type k=0;k<dkcard;++k) {
117 output.access(i,j,k) = 0.0;
118 for (ordinal_type l=0;l<card;++l)
119 output.access(i,j,k) += vinv(l,i)*phis.access(l,j,k);
124 INTREPID2_TEST_FOR_ABORT(
true,
125 ">>> ERROR: (Intrepid2::Basis_HVOL_LINE_Cn_FEM::Serial::getValues) operator is not supported." );
131 template<
typename DT, ordinal_type numPtsPerEval,
132 typename outputValueValueType,
class ...outputValueProperties,
133 typename inputPointValueType,
class ...inputPointProperties,
134 typename vinvValueType,
class ...vinvProperties>
136 Basis_HVOL_LINE_Cn_FEM::
137 getValues( Kokkos::DynRankView<outputValueValueType,outputValueProperties...> outputValues,
138 const Kokkos::DynRankView<inputPointValueType, inputPointProperties...> inputPoints,
139 const Kokkos::DynRankView<vinvValueType, vinvProperties...> vinv,
140 const EOperator operatorType ) {
141 typedef Kokkos::DynRankView<outputValueValueType,outputValueProperties...> outputValueViewType;
142 typedef Kokkos::DynRankView<inputPointValueType, inputPointProperties...> inputPointViewType;
143 typedef Kokkos::DynRankView<vinvValueType, vinvProperties...> vinvViewType;
144 typedef typename ExecSpace<typename inputPointViewType::execution_space,typename DT::execution_space>::ExecSpaceType ExecSpaceType;
147 const auto loopSizeTmp1 = (inputPoints.extent(0)/numPtsPerEval);
148 const auto loopSizeTmp2 = (inputPoints.extent(0)%numPtsPerEval != 0);
149 const auto loopSize = loopSizeTmp1 + loopSizeTmp2;
150 Kokkos::RangePolicy<ExecSpaceType,Kokkos::Schedule<Kokkos::Static> > policy(0, loopSize);
152 typedef typename inputPointViewType::value_type inputPointType;
154 const ordinal_type cardinality = outputValues.extent(0);
156 auto vcprop = Kokkos::common_view_alloc_prop(inputPoints);
157 typedef typename Kokkos::DynRankView< inputPointType, typename inputPointViewType::memory_space> workViewType;
158 workViewType work(Kokkos::view_alloc(
"Basis_HVOL_LINE_Cn_FEM::getValues::work", vcprop), cardinality, inputPoints.extent(0));
160 switch (operatorType) {
161 case OPERATOR_VALUE: {
162 typedef Functor<outputValueViewType,inputPointViewType,vinvViewType,workViewType,
163 OPERATOR_VALUE,numPtsPerEval> FunctorType;
164 Kokkos::parallel_for( policy, FunctorType(outputValues, inputPoints, vinv, work) );
178 typedef Functor<outputValueViewType,inputPointViewType,vinvViewType,workViewType,
179 OPERATOR_Dn,numPtsPerEval> FunctorType;
180 Kokkos::parallel_for( policy, FunctorType(outputValues, inputPoints, vinv, work,
185 INTREPID2_TEST_FOR_EXCEPTION(
true , std::invalid_argument,
186 ">>> ERROR (Basis_HVOL_LINE_Cn_FEM): Operator type not implemented" );
195 template<
typename DT,
typename OT,
typename PT>
199 this->pointType_ = pointType;
200 this->basisCardinality_ = order+1;
201 this->basisDegree_ = order;
202 this->basisCellTopology_ = shards::CellTopology(shards::getCellTopologyData<shards::Line<2> >() );
203 this->basisType_ = BASIS_FEM_LAGRANGIAN;
204 this->basisCoordinates_ = COORDINATES_CARTESIAN;
205 this->functionSpace_ = FUNCTION_SPACE_HVOL;
207 const ordinal_type card = this->basisCardinality_;
210 Kokkos::DynRankView<typename ScalarViewType::value_type,typename DT::execution_space::array_layout,Kokkos::HostSpace>
211 dofCoords(
"HVOL::Line::Cn::dofCoords", card, 1);
214 auto pointT = (pointType == POINTTYPE_DEFAULT) ? POINTTYPE_EQUISPACED : pointType;
217 case POINTTYPE_EQUISPACED:
218 case POINTTYPE_WARPBLEND: {
221 const ordinal_type offset = 1;
223 this->basisCellTopology_,
224 order+1+offset, offset,
243 case POINTTYPE_GAUSS: {
251 std::invalid_argument ,
252 ">>> ERROR: (Intrepid2::Basis_HVOL_LINE_Cn_FEM) invalid pointType." );
256 this->dofCoords_ = Kokkos::create_mirror_view(
typename DT::memory_space(), dofCoords);
257 Kokkos::deep_copy(this->dofCoords_, dofCoords);
261 const ordinal_type lwork = card*card;
262 Kokkos::DynRankView<typename ScalarViewType::value_type,Kokkos::LayoutLeft,Kokkos::HostSpace>
263 vmat(
"HVOL::Line::Cn::vmat", card, card),
264 work(
"HVOL::Line::Cn::work", lwork),
265 ipiv(
"HVOL::Line::Cn::ipiv", card);
267 const double alpha = 0.0, beta = 0.0;
268 Impl::Basis_HGRAD_LINE_Cn_FEM_JACOBI::
269 getValues<Kokkos::HostSpace::execution_space,Parameters::MaxNumPtsPerBasisEval>
270 (vmat, dofCoords, order, alpha, beta, OPERATOR_VALUE);
272 ordinal_type info = 0;
273 Teuchos::LAPACK<ordinal_type,typename ScalarViewType::value_type> lapack;
275 lapack.GETRF(card, card,
276 vmat.data(), vmat.stride_1(),
277 (ordinal_type*)ipiv.data(),
280 INTREPID2_TEST_FOR_EXCEPTION( info != 0,
282 ">>> ERROR: (Intrepid2::Basis_HVOL_LINE_Cn_FEM) lapack.GETRF returns nonzero info." );
285 vmat.data(), vmat.stride_1(),
286 (ordinal_type*)ipiv.data(),
290 INTREPID2_TEST_FOR_EXCEPTION( info != 0,
292 ">>> ERROR: (Intrepid2::Basis_HVOL_LINE_Cn_FEM) lapack.GETRI returns nonzero info." );
295 Kokkos::DynRankView<typename ScalarViewType::value_type,typename DT::execution_space::array_layout,Kokkos::HostSpace>
296 vinv(
"HVOL::Line::Cn::vinv", card, card);
298 for (ordinal_type i=0;i<card;++i)
299 for (ordinal_type j=0;j<card;++j)
300 vinv(i,j) = vmat(j,i);
302 this->vinv_ = Kokkos::create_mirror_view(
typename DT::memory_space(), vinv);
303 Kokkos::deep_copy(this->vinv_ , vinv);
308 const ordinal_type tagSize = 4;
309 const ordinal_type posScDim = 0;
310 const ordinal_type posScOrd = 1;
311 const ordinal_type posDfOrd = 2;
316 for (ordinal_type i=0;i<card;++i) {
323 OrdinalTypeArray1DHost tagView(&tags[0][0], card*4);
327 this->setOrdinalTagData(this->tagToOrdinal_,
330 this->basisCardinality_,
KOKKOS_FORCEINLINE_FUNCTION bool isValidPointType(const EPointType pointType)
Verifies validity of a point type enum.
EPointType
Enumeration of types of point distributions in Intrepid.
KOKKOS_INLINE_FUNCTION ordinal_type getOperatorOrder(const EOperator operatorType)
Returns order of an operator.
Basis_HVOL_LINE_Cn_FEM(const ordinal_type order, const EPointType pointType=POINTTYPE_EQUISPACED)
Constructor.
static constexpr ordinal_type MaxOrder
The maximum reconstruction order.