Intrepid2
|
An helper class to compute the evaluation points and weights needed for performing projections. More...
#include <Intrepid2_ProjectionStruct.hpp>
Public Types | |
enum | EvalPointsType { BASIS , TARGET } |
typedef Kokkos::pair< ordinal_type, ordinal_type > | range_type |
typedef Kokkos::DefaultHostExecutionSpace | HostExecutionSpaceType |
KK : do we really need this complication instead of using default host exec space ???? | |
typedef Kokkos::HostSpace | HostMemorySpaceType |
typedef Kokkos::Device< HostExecutionSpaceType, HostMemorySpaceType > | HostDeviceType |
typedef Kokkos::DynRankView< ValueType, HostDeviceType > | view_type |
typedef Kokkos::View< range_type **, HostDeviceType > | range_tag |
typedef std::array< std::array< view_type, maxSubCellsCount >, numberSubCellDims > | view_tag |
typedef Kokkos::View< unsigned **, HostDeviceType > | key_tag |
Public Member Functions | |
ordinal_type | getNumBasisEvalPoints () |
Returns number of basis evaluation points. | |
ordinal_type | getNumBasisDerivEvalPoints () |
Returns number of evaluation points for basis derivatives. | |
ordinal_type | getNumTargetEvalPoints () |
Returns number of points where to evaluate the target function. | |
ordinal_type | getNumTargetDerivEvalPoints () |
Returns number of points where to evaluate the derivatives of the target function. | |
ordinal_type | getMaxNumDerivPoints (const EvalPointsType type) const |
Returns the maximum number of derivative evaluation points across all the subcells. | |
ordinal_type | getMaxNumEvalPoints (const EvalPointsType type) const |
Returns the maximum number of evaluation points across all the subcells. | |
view_type | getBasisEvalPoints (const ordinal_type subCellDim, const ordinal_type subCellId) |
Returns the basis evaluation points on a subcell. | |
view_type | getBasisDerivEvalPoints (const ordinal_type subCellDim, const ordinal_type subCellId) |
Returns the evaluation points for basis derivatives on a subcell. | |
view_type | getTargetEvalPoints (const ordinal_type subCellDim, const ordinal_type subCellId) |
Returns the points where to evaluate the target function on a subcell. | |
view_type | getTargetDerivEvalPoints (const ordinal_type subCellDim, const ordinal_type subCellId) |
Returns the points where to evaluate the derivatives of the target function on a subcell. | |
view_type | getEvalPoints (const ordinal_type subCellDim, const ordinal_type subCellId, EvalPointsType type) const |
Returns the basis/target evaluation points on a subcell. | |
view_type | getDerivEvalPoints (const ordinal_type subCellDim, const ordinal_type subCellId, EvalPointsType type) const |
Returns the evaluation points for basis/target derivatives on a subcell. | |
view_type | getBasisEvalWeights (const ordinal_type subCellDim, const ordinal_type subCellId) |
Returns the basis evaluation weights on a subcell. | |
view_type | getBasisDerivEvalWeights (const ordinal_type subCellDim, const ordinal_type subCellId) |
Returns the basis derivatives evaluation weights on a subcell. | |
view_type | getTargetEvalWeights (const ordinal_type subCellDim, const ordinal_type subCellId) |
Returns the function evaluation weights on a subcell. | |
view_type | getTargetDerivEvalWeights (const ordinal_type subCellDim, const ordinal_type subCellId) |
Returns the function derivatives evaluation weights on a subcell. | |
const range_tag | getBasisPointsRange () const |
Returns the range tag of the basis evaluation points subcells. | |
const range_tag | getPointsRange (const EvalPointsType type) const |
Returns the range tag of the basis/target evaluation points in subcells. | |
const range_tag | getBasisDerivPointsRange () const |
Returns the range tag of the derivative evaluation points on subcell. | |
const range_tag | getDerivPointsRange (const EvalPointsType type) const |
Returns the range tag of the basis/target derivative evaluation points on subcells. | |
const range_tag | getTargetPointsRange () const |
Returns the range of the target function evaluation points on subcells. | |
const range_tag | getTargetDerivPointsRange () const |
Returns the range tag of the target function derivative evaluation points on subcells. | |
const key_tag | getTopologyKey () const |
Returns the key tag for subcells. | |
template<typename BasisPtrType > | |
void | createL2ProjectionStruct (const BasisPtrType cellBasis, const ordinal_type targetCubDegree) |
Initialize the ProjectionStruct for L2 projections. | |
template<typename BasisPtrType > | |
void | createL2DGProjectionStruct (const BasisPtrType cellBasis, const ordinal_type targetCubDegree) |
Initialize the ProjectionStruct for (discontinuous local-L2) projection. | |
template<typename BasisPtrType > | |
void | createHGradProjectionStruct (const BasisPtrType cellBasis, const ordinal_type targetCubDegree, const ordinal_type targetGradCubDegre) |
Initialize the ProjectionStruct for HGRAD projections. | |
template<typename BasisPtrType > | |
void | createHCurlProjectionStruct (const BasisPtrType cellBasis, const ordinal_type targetCubDegree, const ordinal_type targetCurlCubDegre) |
Initialize the ProjectionStruct for HCURL projections. | |
template<typename BasisPtrType > | |
void | createHDivProjectionStruct (const BasisPtrType cellBasis, const ordinal_type targetCubDegree, const ordinal_type targetDivCubDegre) |
Initialize the ProjectionStruct for HDIV projections. | |
template<typename BasisPtrType > | |
void | createHVolProjectionStruct (const BasisPtrType cellBasis, const ordinal_type targetCubDegree) |
Initialize the ProjectionStruct for HVOL (local-L2) projection. | |
Public Attributes | |
key_tag | subCellTopologyKey |
range_tag | basisPointsRange |
range_tag | basisDerivPointsRange |
range_tag | targetPointsRange |
range_tag | targetDerivPointsRange |
view_tag | basisCubPoints |
view_tag | basisCubWeights |
view_tag | basisDerivCubPoints |
view_tag | basisDerivCubWeights |
view_tag | targetCubPoints |
view_tag | targetCubWeights |
view_tag | targetDerivCubPoints |
view_tag | targetDerivCubWeights |
ordinal_type | numBasisEvalPoints |
ordinal_type | numBasisDerivEvalPoints |
ordinal_type | numTargetEvalPoints |
ordinal_type | numTargetDerivEvalPoints |
ordinal_type | maxNumBasisEvalPoints |
ordinal_type | maxNumTargetEvalPoints |
ordinal_type | maxNumBasisDerivEvalPoints |
ordinal_type | maxNumTargetDerivEvalPoints |
Static Public Attributes | |
static constexpr int | numberSubCellDims = 4 |
static constexpr int | maxSubCellsCount = 12 |
An helper class to compute the evaluation points and weights needed for performing projections.
In order to perform projections, the basis functions and the target function need to be evaluated at several sets of evaluation points (cubature points) defined on subcell entities (edges, faces, volumes). Depending on the projection, the evaluation of derivatives of the basis functions and of the target function may be needed as well. This class provides a struct to store the evaluation points/weights on the reference cell.
Use: create the proper ProjectionStruct rule by calling one of the functions: createL2ProjectionStruct, createHGradProjectionStruct, createHCurlProjectionStruct, createHDivProjectionStruct, createHVolProjectionStruct, depending on the type of projection wanted.
The created class is then used with the Projection Tools. See ProjectionTools class for more info.
Definition at line 87 of file Intrepid2_ProjectionStruct.hpp.
typedef Kokkos::Device<HostExecutionSpaceType,HostMemorySpaceType> Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::HostDeviceType |
Definition at line 96 of file Intrepid2_ProjectionStruct.hpp.
typedef Kokkos::DefaultHostExecutionSpace Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::HostExecutionSpaceType |
KK : do we really need this complication instead of using default host exec space ????
Definition at line 94 of file Intrepid2_ProjectionStruct.hpp.
typedef Kokkos::HostSpace Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::HostMemorySpaceType |
Definition at line 95 of file Intrepid2_ProjectionStruct.hpp.
typedef Kokkos::View<unsigned**,HostDeviceType > Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::key_tag |
Definition at line 105 of file Intrepid2_ProjectionStruct.hpp.
typedef Kokkos::View<range_type**,HostDeviceType> Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::range_tag |
Definition at line 98 of file Intrepid2_ProjectionStruct.hpp.
typedef Kokkos::pair<ordinal_type,ordinal_type> Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::range_type |
Definition at line 92 of file Intrepid2_ProjectionStruct.hpp.
typedef std::array<std::array<view_type, maxSubCellsCount>, numberSubCellDims> Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::view_tag |
Definition at line 104 of file Intrepid2_ProjectionStruct.hpp.
typedef Kokkos::DynRankView<ValueType,HostDeviceType > Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::view_type |
Definition at line 97 of file Intrepid2_ProjectionStruct.hpp.
enum Intrepid2::Experimental::ProjectionStruct::EvalPointsType |
Definition at line 90 of file Intrepid2_ProjectionStruct.hpp.
void Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::createHCurlProjectionStruct | ( | const BasisPtrType | cellBasis, |
const ordinal_type | targetCubDegree, | ||
const ordinal_type | targetCurlCubDegre ) |
Initialize the ProjectionStruct for HCURL projections.
cellBasis | [in] - HCURL basis functions for the projection |
targetCubDegree | [in] - degree of the cubature needed to integrate the target function |
targetGradCubDegre | [in] - degree of the cubature needed to integrate the derivative of target function |
Definition at line 311 of file Intrepid2_ProjectionStructDef.hpp.
References Intrepid2::DefaultCubatureFactory::create().
void Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::createHDivProjectionStruct | ( | const BasisPtrType | cellBasis, |
const ordinal_type | targetCubDegree, | ||
const ordinal_type | targetDivCubDegre ) |
Initialize the ProjectionStruct for HDIV projections.
cellBasis | [in] - HDIV basis functions for the projection |
targetCubDegree | [in] - degree of the cubature needed to integrate the target function |
targetGradCubDegre | [in] - degree of the cubature needed to integrate the derivative of target function |
Definition at line 440 of file Intrepid2_ProjectionStructDef.hpp.
References Intrepid2::DefaultCubatureFactory::create(), and Intrepid2::Basis< Device, outputValueType, pointValueType >::getDofCount().
void Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::createHGradProjectionStruct | ( | const BasisPtrType | cellBasis, |
const ordinal_type | targetCubDegree, | ||
const ordinal_type | targetGradCubDegre ) |
Initialize the ProjectionStruct for HGRAD projections.
cellBasis | [in] - HGRAD basis functions for the projection |
targetCubDegree | [in] - degree of the cubature needed to integrate the target function |
targetGradCubDegre | [in] - degree of the cubature needed to integrate the derivative of target function |
Definition at line 194 of file Intrepid2_ProjectionStructDef.hpp.
References Intrepid2::DefaultCubatureFactory::create(), and Intrepid2::CellTools< DeviceType >::getReferenceVertex().
void Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::createHVolProjectionStruct | ( | const BasisPtrType | cellBasis, |
const ordinal_type | targetCubDegree ) |
Initialize the ProjectionStruct for HVOL (local-L2) projection.
cellBasis | [in] - HVOL basis functions for the projection |
targetCubDegree | [in] - degree of the cubature needed to integrate the target function |
Definition at line 556 of file Intrepid2_ProjectionStructDef.hpp.
References Intrepid2::DefaultCubatureFactory::create().
Referenced by Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::createL2DGProjectionStruct().
|
inline |
Initialize the ProjectionStruct for (discontinuous local-L2) projection.
cellBasis | [in] - basis functions for the projection |
targetCubDegree | [in] - degree of the cubature needed to integrate the target function |
Definition at line 419 of file Intrepid2_ProjectionStruct.hpp.
References Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::createHVolProjectionStruct().
void Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::createL2ProjectionStruct | ( | const BasisPtrType | cellBasis, |
const ordinal_type | targetCubDegree ) |
Initialize the ProjectionStruct for L2 projections.
cellBasis | [in] - basis functions for the projection |
targetCubDegree | [in] - degree of the cubature needed to integrate the target function |
Definition at line 67 of file Intrepid2_ProjectionStructDef.hpp.
References Intrepid2::DefaultCubatureFactory::create(), and Intrepid2::CellTools< DeviceType >::getReferenceVertex().
|
inline |
Returns the evaluation points for basis derivatives on a subcell.
subCellDim | [in] - dimension of the subcell |
subCellId | [in] - ordinal of the subcell defined by cell topology |
Definition at line 186 of file Intrepid2_ProjectionStruct.hpp.
|
inline |
Returns the basis derivatives evaluation weights on a subcell.
subCellDim | [in] - dimension of the subcell |
subCellId | [in] - ordinal of the subcell defined by cell topology |
Definition at line 296 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivBasisCoeffs(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradBasisCoeffs().
|
inline |
Returns the range tag of the derivative evaluation points on subcell.
Definition at line 359 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivBasisCoeffs(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradBasisCoeffs().
|
inline |
Returns the basis evaluation points on a subcell.
subCellDim | [in] - dimension of the subcell |
subCellId | [in] - ordinal of the subcell defined by cell topology |
Definition at line 169 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs().
|
inline |
Returns the basis evaluation weights on a subcell.
subCellDim | [in] - dimension of the subcell |
subCellId | [in] - ordinal of the subcell defined by cell topology |
Definition at line 280 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHVolBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2BasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2DGBasisCoeffs(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2DGBasisCoeffs().
|
inline |
Returns the range tag of the basis evaluation points subcells.
Definition at line 337 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHVolBasisCoeffs(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2BasisCoeffs().
|
inline |
Returns the evaluation points for basis/target derivatives on a subcell.
subCellDim | [in] - dimension of the subcell |
subCellId | [in] - ordinal of the subcell defined by cell topology |
evalPointType | [in] - enum selecting whether the points should be computed for the basis functions or for the target function |
Definition at line 260 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlEvaluationPoints(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivEvaluationPoints(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradEvaluationPoints().
|
inline |
Returns the range tag of the basis/target derivative evaluation points on subcells.
evalPointType | [in] - enum selecting whether the points should be computed for the basis functions or for the target function |
Definition at line 369 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlEvaluationPoints(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivEvaluationPoints(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradEvaluationPoints().
|
inline |
Returns the basis/target evaluation points on a subcell.
subCellDim | [in] - dimension of the subcell |
subCellId | [in] - ordinal of the subcell defined by cell topology |
evalPointType | [in] - enum selecting whether the points should be computed for the basis functions or for the target function |
Definition at line 239 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlEvaluationPoints(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivEvaluationPoints(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradEvaluationPoints(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHVolEvaluationPoints(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2DGBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2DGBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2DGEvaluationPoints(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2EvaluationPoints().
|
inline |
Returns the maximum number of derivative evaluation points across all the subcells.
evalPointType | [in] - enum selecting whether the points should be computed for the basis functions or for the target function |
Definition at line 137 of file Intrepid2_ProjectionStruct.hpp.
|
inline |
Returns the maximum number of evaluation points across all the subcells.
evalPointType | [in] - enum selecting whether the points should be computed for the basis functions or for the target function |
Definition at line 150 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2EvaluationPoints().
|
inline |
Returns number of evaluation points for basis derivatives.
Definition at line 115 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivBasisCoeffs(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradBasisCoeffs().
|
inline |
Returns number of basis evaluation points.
Definition at line 109 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHVolBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2BasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2DGBasisCoeffs(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2DGBasisCoeffs().
|
inline |
Returns number of points where to evaluate the derivatives of the target function.
Definition at line 127 of file Intrepid2_ProjectionStruct.hpp.
|
inline |
Returns number of points where to evaluate the target function.
Definition at line 121 of file Intrepid2_ProjectionStruct.hpp.
|
inline |
Returns the range tag of the basis/target evaluation points in subcells.
evalPointType | [in] - enum selecting whether the points should be computed for the basis functions or for the target function |
Definition at line 347 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlEvaluationPoints(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivEvaluationPoints(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradEvaluationPoints(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHVolEvaluationPoints(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2EvaluationPoints().
|
inline |
Returns the points where to evaluate the derivatives of the target function on a subcell.
subCellDim | [in] - dimension of the subcell |
subCellId | [in] - ordinal of the subcell defined by cell topology |
Definition at line 220 of file Intrepid2_ProjectionStruct.hpp.
|
inline |
Returns the function derivatives evaluation weights on a subcell.
subCellDim | [in] - dimension of the subcell |
subCellId | [in] - ordinal of the subcell defined by cell topology |
Definition at line 328 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivBasisCoeffs(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradBasisCoeffs().
|
inline |
Returns the range tag of the target function derivative evaluation points on subcells.
Definition at line 390 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivBasisCoeffs(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradBasisCoeffs().
|
inline |
Returns the points where to evaluate the target function on a subcell.
subCellDim | [in] - dimension of the subcell |
subCellId | [in] - ordinal of the subcell defined by cell topology |
Definition at line 203 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivEvaluationPoints().
|
inline |
Returns the function evaluation weights on a subcell.
subCellDim | [in] - dimension of the subcell |
subCellId | [in] - ordinal of the subcell defined by cell topology |
Definition at line 312 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHVolBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2BasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2DGBasisCoeffs(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2DGBasisCoeffs().
|
inline |
Returns the range of the target function evaluation points on subcells.
Definition at line 381 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHVolBasisCoeffs(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2BasisCoeffs().
|
inline |
Returns the key tag for subcells.
Definition at line 398 of file Intrepid2_ProjectionStruct.hpp.
Referenced by Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHCurlEvaluationPoints(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHDivEvaluationPoints(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradBasisCoeffs(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getHGradEvaluationPoints(), Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2BasisCoeffs(), and Intrepid2::Experimental::ProjectionTools< DeviceType >::getL2EvaluationPoints().
view_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::basisCubPoints |
Definition at line 470 of file Intrepid2_ProjectionStruct.hpp.
view_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::basisCubWeights |
Definition at line 471 of file Intrepid2_ProjectionStruct.hpp.
view_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::basisDerivCubPoints |
Definition at line 472 of file Intrepid2_ProjectionStruct.hpp.
view_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::basisDerivCubWeights |
Definition at line 473 of file Intrepid2_ProjectionStruct.hpp.
range_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::basisDerivPointsRange |
Definition at line 467 of file Intrepid2_ProjectionStruct.hpp.
range_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::basisPointsRange |
Definition at line 466 of file Intrepid2_ProjectionStruct.hpp.
ordinal_type Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::maxNumBasisDerivEvalPoints |
Definition at line 484 of file Intrepid2_ProjectionStruct.hpp.
ordinal_type Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::maxNumBasisEvalPoints |
Definition at line 482 of file Intrepid2_ProjectionStruct.hpp.
ordinal_type Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::maxNumTargetDerivEvalPoints |
Definition at line 485 of file Intrepid2_ProjectionStruct.hpp.
ordinal_type Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::maxNumTargetEvalPoints |
Definition at line 483 of file Intrepid2_ProjectionStruct.hpp.
|
staticconstexpr |
Definition at line 103 of file Intrepid2_ProjectionStruct.hpp.
ordinal_type Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::numBasisDerivEvalPoints |
Definition at line 479 of file Intrepid2_ProjectionStruct.hpp.
ordinal_type Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::numBasisEvalPoints |
Definition at line 478 of file Intrepid2_ProjectionStruct.hpp.
|
staticconstexpr |
Definition at line 99 of file Intrepid2_ProjectionStruct.hpp.
ordinal_type Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::numTargetDerivEvalPoints |
Definition at line 481 of file Intrepid2_ProjectionStruct.hpp.
ordinal_type Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::numTargetEvalPoints |
Definition at line 480 of file Intrepid2_ProjectionStruct.hpp.
key_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::subCellTopologyKey |
Definition at line 465 of file Intrepid2_ProjectionStruct.hpp.
view_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::targetCubPoints |
Definition at line 474 of file Intrepid2_ProjectionStruct.hpp.
view_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::targetCubWeights |
Definition at line 475 of file Intrepid2_ProjectionStruct.hpp.
view_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::targetDerivCubPoints |
Definition at line 476 of file Intrepid2_ProjectionStruct.hpp.
view_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::targetDerivCubWeights |
Definition at line 477 of file Intrepid2_ProjectionStruct.hpp.
range_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::targetDerivPointsRange |
Definition at line 469 of file Intrepid2_ProjectionStruct.hpp.
range_tag Intrepid2::Experimental::ProjectionStruct< DeviceType, ValueType >::targetPointsRange |
Definition at line 468 of file Intrepid2_ProjectionStruct.hpp.