Intrepid2
|
This is the complete list of members for Intrepid2::CellTools< DeviceType >, including all inherited members.
allocateJacobianDet(const Data< PointScalar, DeviceType > &jacobian) | Intrepid2::CellTools< DeviceType > | static |
allocateJacobianInv(const Data< PointScalar, DeviceType > &jacobian) | Intrepid2::CellTools< DeviceType > | static |
CellTools()=default | Intrepid2::CellTools< DeviceType > | |
checkPointInclusion(const PointViewType point, const shards::CellTopology cellTopo, const typename ScalarTraits< typename PointViewType::value_type >::scalar_type thres=threshold< typename ScalarTraits< typename PointViewType::value_type >::scalar_type >()) | Intrepid2::CellTools< DeviceType > | static |
checkPointwiseInclusion(OutputViewType inCell, const InputViewType points, const typename ScalarTraits< typename InputViewType::value_type >::scalar_type thresh=threshold< typename ScalarTraits< typename InputViewType::value_type >::scalar_type >()) | Intrepid2::CellTools< DeviceType > | static |
checkPointwiseInclusion(InCellViewType inCell, const PointViewType points, const shards::CellTopology cellTopo, const typename ScalarTraits< typename PointViewType::value_type >::scalar_type thres=threshold< typename ScalarTraits< typename PointViewType::value_type >::scalar_type >()) | Intrepid2::CellTools< DeviceType > | static |
checkPointwiseInclusion(Kokkos::DynRankView< inCellValueType, inCellProperties...> inCell, const Kokkos::DynRankView< pointValueType, pointProperties...> points, const Kokkos::DynRankView< cellWorksetValueType, cellWorksetProperties...> cellWorkset, const shards::CellTopology cellTopo, const typename ScalarTraits< pointValueType >::scalar_type thres=threshold< typename ScalarTraits< pointValueType >::scalar_type >()) | Intrepid2::CellTools< DeviceType > | static |
checkPointwiseInclusion(InCellViewType inCell, const InputViewType points, const shards::CellTopology cellTopo, const typename ScalarTraits< typename InputViewType::value_type >::scalar_type threshold) (defined in Intrepid2::CellTools< DeviceType >) | Intrepid2::CellTools< DeviceType > | |
createHGradBasis(const shards::CellTopology cellTopo) | Intrepid2::CellTools< DeviceType > | inlineprivatestatic |
ExecSpaceType typedef (defined in Intrepid2::CellTools< DeviceType >) | Intrepid2::CellTools< DeviceType > | private |
getPhysicalEdgeTangents(Kokkos::DynRankView< edgeTangentValueType, edgeTangentProperties...> edgeTangents, const Kokkos::DynRankView< worksetJacobianValueType, worksetJacobianProperties...> worksetJacobians, const ordinal_type worksetEdgeOrd, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getPhysicalEdgeTangents(Kokkos::DynRankView< edgeTangentValueType, edgeTangentProperties...> edgeTangents, const Kokkos::DynRankView< worksetJacobianValueType, worksetJacobianProperties...> worksetJacobians, const Kokkos::DynRankView< edgeOrdValueType, edgeOrdProperties...> worksetEdgeOrds, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getPhysicalFaceNormals(Kokkos::DynRankView< faceNormalValueType, faceNormalProperties...> faceNormals, const Kokkos::DynRankView< worksetJacobianValueType, worksetJacobianProperties...> worksetJacobians, const ordinal_type worksetFaceOrd, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getPhysicalFaceNormals(Kokkos::DynRankView< faceNormalValueType, faceNormalProperties...> faceNormals, const Kokkos::DynRankView< worksetJacobianValueType, worksetJacobianProperties...> worksetJacobians, const Kokkos::DynRankView< faceOrdValueType, faceOrdProperties...> worksetFaceOrds, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getPhysicalFaceTangents(Kokkos::DynRankView< faceTanValueType, faceTanProperties...> faceTanU, Kokkos::DynRankView< faceTanValueType, faceTanProperties...> faceTanV, const Kokkos::DynRankView< worksetJacobianValueType, worksetJacobianProperties...> worksetJacobians, const ordinal_type worksetFaceOrd, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getPhysicalFaceTangents(Kokkos::DynRankView< faceTanValueType, faceTanProperties...> faceTanU, Kokkos::DynRankView< faceTanValueType, faceTanProperties...> faceTanV, const Kokkos::DynRankView< worksetJacobianValueType, worksetJacobianProperties...> worksetJacobians, const Kokkos::DynRankView< faceOrdValueType, faceOrdProperties...> worksetFaceOrds, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getPhysicalSideNormals(Kokkos::DynRankView< sideNormalValueType, sideNormalProperties...> sideNormals, const Kokkos::DynRankView< worksetJacobianValueType, worksetJacobianProperties...> worksetJacobians, const ordinal_type worksetSideOrd, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getPhysicalSideNormals(Kokkos::DynRankView< sideNormalValueType, sideNormalProperties...> sideNormals, const Kokkos::DynRankView< worksetJacobianValueType, worksetJacobianProperties...> worksetJacobians, const Kokkos::DynRankView< edgeOrdValueType, edgeOrdProperties...> worksetSideOrds, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getReferenceCellCenter(Kokkos::DynRankView< cellCenterValueType, cellCenterProperties...> cellCenter, const shards::CellTopology cell) | Intrepid2::CellTools< DeviceType > | static |
getReferenceEdgeTangent(RefEdgeTangentViewType refEdgeTangent, const ordinal_type edgeOrd, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getReferenceFaceNormal(RefFaceNormalViewType refFaceNormal, const ordinal_type faceOrd, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getReferenceFaceTangents(RefFaceTanViewType refFaceTanU, RefFaceTanViewType refFaceTanV, const ordinal_type faceOrd, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getReferenceNode(Kokkos::DynRankView< cellNodeValueType, cellNodeProperties...> cellNode, const shards::CellTopology cell, const ordinal_type nodeOrd) | Intrepid2::CellTools< DeviceType > | static |
getReferenceSideNormal(RefSideNormalViewType refSideNormal, const ordinal_type sideOrd, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getReferenceSubcellNodes(SubcellNodeViewType subcellNodes, const ordinal_type subcellDim, const ordinal_type subcellOrd, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getReferenceSubcellVertices(Kokkos::DynRankView< subcellVertexValueType, subcellVertexProperties...> subcellVertices, const ordinal_type subcellDim, const ordinal_type subcellOrd, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
getReferenceVertex(Kokkos::DynRankView< cellVertexValueType, cellVertexProperties...> cellVertex, const shards::CellTopology cell, const ordinal_type vertexOrd) | Intrepid2::CellTools< DeviceType > | static |
getSubcvCoords(Kokkos::DynRankView< subcvCoordValueType, subcvCoordProperties...> subcvCoords, const Kokkos::DynRankView< cellCoordValueType, cellCoordProperties...> cellCoords, const shards::CellTopology primaryCell) | Intrepid2::CellTools< DeviceType > | static |
hasReferenceCell(const shards::CellTopology cellTopo) | Intrepid2::CellTools< DeviceType > | inlinestatic |
mapToPhysicalFrame(PhysPointValueType physPoints, const RefPointValueType refPoints, const WorksetType worksetCell, const HGradBasisPtrType basis) | Intrepid2::CellTools< DeviceType > | static |
mapToPhysicalFrame(PhysPointViewType physPoints, const RefPointViewType refPoints, const WorksetCellViewType worksetCell, const shards::CellTopology cellTopo) | Intrepid2::CellTools< DeviceType > | inlinestatic |
mapToPhysicalFrame(PhysPointViewType physPoints, const RefPointViewType refPoints, const WorksetType worksetCell, const HGradBasisPtrType basis) (defined in Intrepid2::CellTools< DeviceType >) | Intrepid2::CellTools< DeviceType > | |
mapToReferenceFrame(Kokkos::DynRankView< refPointValueType, refPointProperties...> refPoints, const Kokkos::DynRankView< physPointValueType, physPointProperties...> physPoints, const Kokkos::DynRankView< worksetCellValueType, worksetCellProperties...> worksetCell, const shards::CellTopology cellTopo) | Intrepid2::CellTools< DeviceType > | static |
mapToReferenceFrameInitGuess(Kokkos::DynRankView< refPointValueType, refPointProperties...> refPoints, const Kokkos::DynRankView< initGuessValueType, initGuessProperties...> initGuess, const Kokkos::DynRankView< physPointValueType, physPointProperties...> physPoints, const Kokkos::DynRankView< worksetCellValueType, worksetCellProperties...> worksetCell, const HGradBasisPtrType basis) | Intrepid2::CellTools< DeviceType > | static |
mapToReferenceFrameInitGuess(Kokkos::DynRankView< refPointValueType, refPointProperties...> refPoints, const Kokkos::DynRankView< initGuessValueType, initGuessProperties...> initGuess, const Kokkos::DynRankView< physPointValueType, physPointProperties...> physPoints, const Kokkos::DynRankView< worksetCellValueType, worksetCellProperties...> worksetCell, const shards::CellTopology cellTopo) | Intrepid2::CellTools< DeviceType > | inlinestatic |
mapToReferenceSubcell(refSubcellViewType refSubcellPoints, const paramPointViewType paramPoints, const ordinal_type subcellDim, const ordinal_type subcellOrd, const shards::CellTopology parentCell) | Intrepid2::CellTools< DeviceType > | static |
mapToReferenceSubcell(refSubcellViewType refSubcellPoints, const paramPointViewType paramPoints, const typename RefSubcellParametrization< DeviceType >::ConstViewType subcellParametrization, const ordinal_type subcellOrd) | Intrepid2::CellTools< DeviceType > | static |
mapToReferenceSubcell(refSubcellViewType refSubcellPoints, const paramPointViewType paramPoints, const typename RefSubcellParametrization< DeviceType >::ConstViewType subcellParametrization, const ordViewType subcellOrd) | Intrepid2::CellTools< DeviceType > | static |
mapToReferenceSubcell(refSubcellViewType refSubcellPoints, const paramViewType paramPoints, const ordinal_type subcellDim, const ordinal_type subcellOrd, const shards::CellTopology parentCell) (defined in Intrepid2::CellTools< DeviceType >) | Intrepid2::CellTools< DeviceType > | |
mapToReferenceSubcell(refSubcellViewType refSubcellPoints, const paramViewType paramPoints, const typename RefSubcellParametrization< DeviceType >::ConstViewType subcellParametrization, const ordinal_type subcellOrd) (defined in Intrepid2::CellTools< DeviceType >) | Intrepid2::CellTools< DeviceType > | |
mapToReferenceSubcell(refSubcellViewType refSubcellPoints, const paramViewType paramPoints, const typename RefSubcellParametrization< DeviceType >::ConstViewType subcellParametrization, const ordViewType subcellOrd) (defined in Intrepid2::CellTools< DeviceType >) | Intrepid2::CellTools< DeviceType > | |
MemSpaceType typedef (defined in Intrepid2::CellTools< DeviceType >) | Intrepid2::CellTools< DeviceType > | private |
setJacobian(JacobianViewType jacobian, const PointViewType points, const WorksetType worksetCell, const Teuchos::RCP< HGradBasisType > basis, const int startCell=0, const int endCell=-1) | Intrepid2::CellTools< DeviceType > | static |
setJacobian(JacobianViewType jacobian, const WorksetType worksetCell, const BasisGradientsType gradients, const int startCell=0, const int endCell=-1) | Intrepid2::CellTools< DeviceType > | static |
setJacobian(JacobianViewType jacobian, const PointViewType points, const WorksetCellViewType worksetCell, const shards::CellTopology cellTopo) | Intrepid2::CellTools< DeviceType > | inlinestatic |
setJacobianDet(JacobianDetViewType jacobianDet, const JacobianViewType jacobian) | Intrepid2::CellTools< DeviceType > | static |
setJacobianDet(Data< PointScalar, DeviceType > &jacobianDet, const Data< PointScalar, DeviceType > &jacobian) | Intrepid2::CellTools< DeviceType > | static |
setJacobianDetInv(Data< PointScalar, DeviceType > &jacobianDetInv, const Data< PointScalar, DeviceType > &jacobian) | Intrepid2::CellTools< DeviceType > | static |
setJacobianDividedByDet(Data< PointScalar, DeviceType > &jacobianDividedByDet, const Data< PointScalar, DeviceType > &jacobian, const Data< PointScalar, DeviceType > &jacobianDetInv) | Intrepid2::CellTools< DeviceType > | static |
setJacobianDividedByDet(Data< Scalar, DeviceType > &jacobianDividedByDet, const Data< Scalar, DeviceType > &jacobian, const Data< Scalar, DeviceType > &jacobianDetInv) (defined in Intrepid2::CellTools< DeviceType >) | Intrepid2::CellTools< DeviceType > | |
setJacobianInv(JacobianInvViewType jacobianInv, const JacobianViewType jacobian) | Intrepid2::CellTools< DeviceType > | static |
setJacobianInv(Data< PointScalar, DeviceType > &jacobianInv, const Data< PointScalar, DeviceType > &jacobian) | Intrepid2::CellTools< DeviceType > | static |
~CellTools()=default | Intrepid2::CellTools< DeviceType > |