|
Intrepid2
|
A class providing static members to perform Lagrangian interpolation on a finite element. More...
Static Public Member Functions | |
| template<typename basisCoeffsViewType , typename funcViewType , typename BasisType , typename ortViewType > | |
| static void | getBasisCoeffs (basisCoeffsViewType basisCoeffs, const funcViewType functionAtDofCoords, const BasisType *cellBasis, const ortViewType orts) |
| Computes the basis weights of the function interpolation. | |
A class providing static members to perform Lagrangian interpolation on a finite element.
classes
The Lagrangian interpolant 
![\[
\mathcal I_h(f) = \sum_i \alpha^f_i \phi_i, \quad \alpha_i^f := L_i(f),
\]](form_292.png)
where 


![\[
L_i(f) := f(\mathbf x_i) \cdot \beta_i, \quad L_i(\phi_j) = \delta_{ij},
\]](form_296.png)
where 

In order to perform the interpolation, evaluate the function 



Definition at line 97 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 reference DOF coordinates. |
| cellBasis | [in] - pointer to the basis for the interpolation |
| cellOrientations | [in] - rank-1 view (C) containing the Orientation objects at each cell |
Definition at line 309 of file Intrepid2_LagrangianInterpolationDef.hpp.
References Intrepid2::RealSpaceTools< DeviceType >::clone(), Intrepid2::ArrayTools< DeviceType >::dotMultiplyDataData(), and Intrepid2::OrientationTools< DeviceType >::modifyBasisByOrientationInverse().