14 #ifndef __INTREPID2_LAGRANGIANINTERPOLATION_HPP__
15 #define __INTREPID2_LAGRANGIANINTERPOLATION_HPP__
17 #include "Intrepid2_ConfigDefs.hpp"
21 #include "Shards_CellTopology.hpp"
22 #include "Shards_BasicTopologies.hpp"
67 #include "Teuchos_LAPACK.hpp"
96 template<
typename DeviceType>
118 template<
typename basisCoeffsViewType,
119 typename funcViewType,
121 typename ortViewType>
124 const funcViewType functionAtDofCoords,
125 const BasisType* cellBasis,
126 const ortViewType orts);
141 template<
typename DeviceType>
159 template<
typename BasisType,
160 class ...coordsProperties,
161 typename ortValueType,
class ...ortProperties>
164 Kokkos::DynRankView<typename BasisType::scalarType, coordsProperties...> dofCoords,
165 const BasisType* cellBasis,
166 const Kokkos::DynRankView<ortValueType, ortProperties...> cellOrientations
184 template<
typename BasisType,
185 class ...coeffsProperties,
186 typename ortValueType,
class ...ortProperties>
189 Kokkos::DynRankView<typename BasisType::scalarType, coeffsProperties...> dofCoeffs,
190 const BasisType* cellBasis,
191 const Kokkos::DynRankView<ortValueType, ortProperties...> cellOrientations
Header file for the Intrepid2::Basis_HGRAD_LINE_Cn_FEM class.
A class providing static members to perform Lagrangian interpolation on a finite element.
Header file for the Intrepid2::Basis_HDIV_TET_I1_FEM class.
Header file for the Intrepid2::Basis_HCURL_HEX_In_FEM class.
Header file for the Intrepid2::Basis_HDIV_HEX_I1_FEM class.
Header file for the Intrepid2::Basis_HDIV_WEDGE_I1_FEM class.
static void getBasisCoeffs(basisCoeffsViewType basisCoeffs, const funcViewType functionAtDofCoords, const BasisType *cellBasis, const ortViewType orts)
Computes the basis weights of the function interpolation.
Header file for the Intrepid2::Basis_HDIV_HEX_In_FEM class.
Header function for Intrepid2::Util class and other utility functions.
Header file for the Intrepid2::Basis_HGRAD_TRI_Cn_FEM class.
Header file for the Intrepid2::Basis_HVOL_LINE_Cn_FEM class.
Header file for the Intrepid2::Basis_HDIV_QUAD_I1_FEM class.
Header file for the Intrepid2::Basis_HCURL_TET_In_FEM class.
Header file for the Intrepid2::Basis_HGRAD_TET_Cn_FEM class.
Header file for the Intrepid2::Basis_HDIV_TRI_I1_FEM class.
Header file for the Intrepid2::Basis_HDIV_QUAD_In_FEM class.
Header file for the Intrepid2::Basis_HCURL_QUAD_In_FEM class.
Header file for the Intrepid2::Basis_HDIV_TRI_In_FEM class.
Contains definitions of custom data types in Intrepid2.
Header file for the Intrepid2::Basis_HGRAD_QUAD_Cn_FEM class.
Header file for the Intrepid2::Basis_HDIV_TET_In_FEM class.
Header file for the Intrepid2::Basis_HCURL_QUAD_I1_FEM class.
Header file for the Intrepid2::Basis_HCURL_WEDGE_I1_FEM class.
Header file for the Intrepid2::Basis_HCURL_TET_I1_FEM class.
Header file for the Intrepid2::Basis_HCURL_HEX_I1_FEM class.
Header file for the Intrepid2::Basis_HCURL_TRI_I1_FEM class.
Header file for the Intrepid2::Basis_HVOL_TRI_Cn_FEM class.
Header file for the Intrepid2::LagrangianInterpolation containing definitions.
Header file for the abstract base class Intrepid2::Basis.
Header file for the Intrepid2::Basis_HCURL_TRI_In_FEM class.
Header file for the Intrepid2::Basis_HGRAD_HEX_Cn_FEM class.