Intrepid2
|
A class providing static members to perform Lagrangian interpolation on a finite element. More...
#include <Intrepid2_LagrangianInterpolation.hpp>
Static Public Member Functions | |
template<typename BasisType , class ... coordsProperties, class ... coeffsProperties, typename ortValueType , class ... ortProperties> | |
static void | getDofCoordsAndCoeffs (Kokkos::DynRankView< typename BasisType::scalarType, coordsProperties... > dofCoords, Kokkos::DynRankView< typename BasisType::scalarType, coeffsProperties... > dofCoeffs, const BasisType *cellBasis, const Kokkos::DynRankView< ortValueType, ortProperties... > cellOrientations) |
Computes the points and coefficients associated with the basis DOFs for the reference oriented element. | |
template<typename basisCoeffsViewType , typename funcViewType , typename dofCoeffViewType > | |
static void | getBasisCoeffs (basisCoeffsViewType basisCoeffs, const funcViewType functionAtDofCoords, const dofCoeffViewType dofCoeffs) |
Computes the basis weights of the function interpolation. | |
A class providing static members to perform Lagrangian interpolation on a finite element.
The Lagrangian interpolant
where
where
In order to perform the interpolation, call the member getDofCoordsAndCoeffs that returns a set of points
Definition at line 136 of file Intrepid2_LagrangianInterpolation.hpp.
|
static |
Computes the basis weights of the function interpolation.
basisCoeffs | [out] - rank-2 view (C,F) that will contain the basis coefficients of the interpolation. |
functionAtDofCoords | [in] - variable rank view that contains the function evaluated at DOF coordinates. |
dofCoeffs | [in] - variable rank view that contains coefficients associated with the basis DOFs. |
Definition at line 446 of file Intrepid2_LagrangianInterpolationDef.hpp.
References Intrepid2::ArrayTools< DeviceType >::dotMultiplyDataData().
|
static |
Computes the points and coefficients associated with the basis DOFs for the reference oriented element.
dofCoords | [out] - rank-3 view (C,F,D), that will contain coordinates associated with the basis DOFs. |
dofCoeffs | [out] - variable rank view that will contain coefficients associated with the basis DOFs. |
cellBasis | [in] - pointer to the basis for the interpolation |
basisPointType | [in] - enum of the point type functions or for the target function |
cellOrientations | [in] - rank-1 view (C) containing the Orientation objects at each cell |
Definition at line 265 of file Intrepid2_LagrangianInterpolationDef.hpp.
References Intrepid2::RealSpaceTools< DeviceType >::clone(), and Intrepid2::RefSubcellParametrization< DeviceType >::get().