Intrepid2::ArrayTools< ExecSpaceType > | Utility class that provides methods for higher-order algebraic manipulation of user-defined arrays, such as tensor contractions. For low-order operations, see Intrepid2::RealSpaceTools |
Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType > | An abstract base class that defines interface for concrete basis implementations for Finite Element (FEM) and Finite Volume/Finite Difference (FVD) discrete spaces |
Intrepid2::Basis_HCURL_HEX_I1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(curl)-compatible FEM basis of degree 1 on Hexahedron cell |
Intrepid2::Basis_HCURL_HEX_In_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(curl)-compatible FEM basis on Hexahedral cell |
Intrepid2::Basis_HCURL_QUAD_I1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(curl)-compatible FEM basis of degree 1 on Quadrilateral cell |
Intrepid2::Basis_HCURL_QUAD_In_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(curl)-compatible FEM basis on Quadrilateral cell |
Intrepid2::Basis_HCURL_TET_I1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(curl)-compatible FEM basis of degree 1 on Tetrahedron cell |
Intrepid2::Basis_HCURL_TET_In_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(curl)-compatible Nedelec (first kind) basis of arbitrary degree on Tetrahedron cell |
Intrepid2::Basis_HCURL_TRI_I1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(curl)-compatible FEM basis of degree 1 on Triangle cell |
Intrepid2::Basis_HCURL_TRI_In_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(curl)-compatible Nedelec (first kind) basis of arbitrary degree on Triangle cell |
Intrepid2::Basis_HCURL_WEDGE_I1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(curl)-compatible FEM basis of degree 1 on Wedge cell |
Intrepid2::Basis_HDIV_HEX_I1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(div)-compatible FEM basis of degree 1 on Hexahedron cell |
Intrepid2::Basis_HDIV_HEX_In_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(div)-compatible FEM basis on Hexahedral cell |
Intrepid2::Basis_HDIV_QUAD_I1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(div)-compatible FEM basis of degree 1 on Quadrilateral cell |
Intrepid2::Basis_HDIV_QUAD_In_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(div)-compatible FEM basis on Quadrilateral cell |
Intrepid2::Basis_HDIV_TET_I1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(div)-compatible FEM basis of degree 1 on a Tetrahedron cell |
Intrepid2::Basis_HDIV_TET_In_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(div)-compatible Raviart-Thomas basis of arbitrary degree on Tetrahedral cells |
Intrepid2::Basis_HDIV_TRI_I1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(div)-compatible FEM basis of degree 1 on a Triangle cell |
Intrepid2::Basis_HDIV_TRI_In_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(div)-compatible Raviart-Thomas basis of arbitrary degree on Triangle cell |
Intrepid2::Basis_HDIV_WEDGE_I1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Wedge cell |
Intrepid2::Basis_HGRAD_HEX_C1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Hexahedron cell |
Intrepid2::Basis_HGRAD_HEX_C2_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Hexahedron cell |
Intrepid2::Basis_HGRAD_HEX_Cn_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Hexahedron cell |
Intrepid2::Basis_HGRAD_LINE_C1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Line cell |
Intrepid2::Basis_HGRAD_LINE_Cn_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the locally H(grad)-compatible FEM basis of variable order on the [-1,1] reference line cell, using Lagrange polynomials |
Intrepid2::Basis_HGRAD_LINE_Cn_FEM_JACOBI< ExecSpaceType, outputValueType, pointValueType > | Implementation of the locally H(grad)-compatible FEM basis of variable order on the [-1,1] reference line cell, using Jacobi polynomials |
Intrepid2::Basis_HGRAD_PYR_C1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Pyramid cell |
Intrepid2::Basis_HGRAD_QUAD_C1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Quadrilateral cell |
Intrepid2::Basis_HGRAD_QUAD_C2_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Quadrilateral cell |
Intrepid2::Basis_HGRAD_QUAD_Cn_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree n on Quadrilateral cell Implements Lagrangian basis of degree n on the reference Quadrilateral cell using a tensor product of points |
Intrepid2::Basis_HGRAD_TET_C1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Tetrahedron cell |
Intrepid2::Basis_HGRAD_TET_C2_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Tetrahedron cell |
Intrepid2::Basis_HGRAD_TET_Cn_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible Lagrange basis of arbitrary degree on Tetrahedron cell |
Intrepid2::Basis_HGRAD_TET_Cn_FEM_ORTH< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible orthogonal basis of arbitrary degree on tetrahedron |
Intrepid2::Basis_HGRAD_TET_COMP12_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Tetrahedron cell |
Intrepid2::Basis_HGRAD_TRI_C1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Triangle cell |
Intrepid2::Basis_HGRAD_TRI_C2_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Triangle cell |
Intrepid2::Basis_HGRAD_TRI_Cn_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible Lagrange basis of arbitrary degree on Triangle cell |
Intrepid2::Basis_HGRAD_TRI_Cn_FEM_ORTH< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible orthogonal basis (Dubiner) of arbitrary degree on triangle |
Intrepid2::Basis_HGRAD_WEDGE_C1_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Wedge cell |
Intrepid2::Basis_HGRAD_WEDGE_C2_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Wedge cell |
Intrepid2::Basis_HVOL_C0_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default HVOL-compatible FEM contstant basis on triangle, quadrilateral, hexahedral and tetrahedral cells |
Intrepid2::Basis_HVOL_HEX_Cn_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default HVOL-compatible FEM basis of degree n on Hexahedron cell |
Intrepid2::Basis_HVOL_LINE_Cn_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the locally HVOL-compatible FEM basis of variable order on the [-1,1] reference line cell, using Lagrange polynomials |
Intrepid2::Basis_HVOL_QUAD_Cn_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default HVOL-compatible FEM basis of degree n on Quadrilateral cell Implements Lagrangian basis of degree n on the reference Quadrilateral cell using a tensor product of points. The degrees of freedom are point evaluation at points in the interior of the Quadrilateral |
Intrepid2::Basis_HVOL_TET_Cn_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default HVOL-compatible Lagrange basis of arbitrary degree on Tetrahedron cell |
Intrepid2::Basis_HVOL_TRI_Cn_FEM< ExecSpaceType, outputValueType, pointValueType > | Implementation of the default HVOL-compatible Lagrange basis of arbitrary degree on Triangle cell |
Intrepid2::Impl::Basis_HCURL_HEX_I1_FEM | See Intrepid2::Basis_HCURL_HEX_I1_FEM |
Intrepid2::Impl::Basis_HCURL_HEX_In_FEM | See Intrepid2::Basis_HCURL_HEX_In_FEM |
Intrepid2::Impl::Basis_HCURL_QUAD_I1_FEM | See Intrepid2::Basis_HCURL_QUAD_I1_FEM |
Intrepid2::Impl::Basis_HCURL_QUAD_In_FEM | See Intrepid2::Basis_HCURL_QUAD_In_FEM |
Intrepid2::Impl::Basis_HCURL_TET_I1_FEM | See Intrepid2::Basis_HCURL_TET_I1_FEM |
Intrepid2::Impl::Basis_HCURL_TET_In_FEM | See Intrepid2::Basis_HCURL_TET_In_FEM |
Intrepid2::Impl::Basis_HCURL_TRI_I1_FEM | See Intrepid2::Basis_HCURL_TRI_I1_FEM |
Intrepid2::Impl::Basis_HCURL_TRI_In_FEM | See Intrepid2::Basis_HCURL_TRI_In_FEM |
Intrepid2::Impl::Basis_HCURL_WEDGE_I1_FEM | See Intrepid2::Basis_HCURL_WEDGE_I1_FEM |
Intrepid2::Impl::Basis_HDIV_HEX_I1_FEM | See Intrepid2::Basis_HDIV_HEX_I1_FEM |
Intrepid2::Impl::Basis_HDIV_HEX_In_FEM | See Intrepid2::Basis_HDIV_HEX_In_FEM |
Intrepid2::Impl::Basis_HDIV_QUAD_I1_FEM | See Intrepid2::Basis_HDIV_QUAD_I1_FEM |
Intrepid2::Impl::Basis_HDIV_QUAD_In_FEM | See Intrepid2::Basis_HDIV_QUAD_In_FEM |
Intrepid2::Impl::Basis_HDIV_TET_I1_FEM | See Intrepid2::Basis_HDIV_TET_I1_FEM |
Intrepid2::Impl::Basis_HDIV_TET_In_FEM | See Intrepid2::Basis_HDIV_TET_In_FEM |
Intrepid2::Impl::Basis_HDIV_TRI_I1_FEM | See Intrepid2::Basis_HDIV_TRI_I1_FEM |
Intrepid2::Impl::Basis_HDIV_TRI_In_FEM | See Intrepid2::Basis_HDIV_TRI_In_FEM |
Intrepid2::Impl::Basis_HDIV_WEDGE_I1_FEM | See Intrepid2::Basis_HDIV_WEDGE_I1_FEM |
Intrepid2::Impl::Basis_HGRAD_HEX_C1_FEM | See Intrepid2::Basis_HGRAD_HEX_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_HEX_C2_FEM | See Intrepid2::Basis_HGRAD_HEX_C2_FEM |
Intrepid2::Impl::Basis_HGRAD_HEX_Cn_FEM | See Intrepid2::Basis_HGRAD_HEX_Cn_FEM |
Intrepid2::Impl::Basis_HGRAD_LINE_C1_FEM | See Intrepid2::Basis_HGRAD_LINE_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_LINE_Cn_FEM | See Intrepid2::Basis_HGRAD_LINE_Cn_FEM |
Intrepid2::Impl::Basis_HGRAD_LINE_Cn_FEM_JACOBI | See Intrepid2::Basis_HGRAD_LINE_Cn_FEM_JACOBI |
Intrepid2::Impl::Basis_HGRAD_PYR_C1_FEM | See Intrepid2::Basis_HGRAD_PYR_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_QUAD_C1_FEM | See Intrepid2::Basis_HGRAD_QUAD_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_QUAD_C2_FEM | See Intrepid2::Basis_HGRAD_QUAD_C2_FEM |
Intrepid2::Impl::Basis_HGRAD_QUAD_Cn_FEM | See Intrepid2::Basis_HGRAD_QUAD_Cn_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_C1_FEM | See Intrepid2::Basis_HGRAD_TET_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_C2_FEM | See Intrepid2::Basis_HGRAD_TET_C2_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_Cn_FEM | See Intrepid2::Basis_HGRAD_TET_Cn_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_Cn_FEM_ORTH | See Intrepid2::Basis_HGRAD_TET_Cn_FEM_ORTH |
Intrepid2::Impl::Basis_HGRAD_TET_COMP12_FEM | See Intrepid2::Basis_HGRAD_TET_COMP12_FEM |
Intrepid2::Impl::Basis_HGRAD_TRI_C1_FEM | See Intrepid2::Basis_HGRAD_TRI_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_TRI_C2_FEM | See Intrepid2::Basis_HGRAD_TRI_C2_FEM |
Intrepid2::Impl::Basis_HGRAD_TRI_Cn_FEM | See Intrepid2::Basis_HGRAD_TRI_Cn_FEM |
Intrepid2::Impl::Basis_HGRAD_TRI_Cn_FEM_ORTH | See Intrepid2::Basis_HGRAD_TRI_Cn_FEM_ORTH |
Intrepid2::Impl::Basis_HGRAD_WEDGE_C1_FEM | See Intrepid2::Basis_HGRAD_WEDGE_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_WEDGE_C2_FEM | See Intrepid2::Basis_HGRAD_WEDGE_C2_FEM |
Intrepid2::Impl::Basis_HVOL_C0_FEM | See Intrepid2::Basis_HVOL_C0_FEM |
Intrepid2::Impl::Basis_HVOL_HEX_Cn_FEM | See Intrepid2::Basis_HVOL_HEX_Cn_FEM |
Intrepid2::Impl::Basis_HVOL_LINE_Cn_FEM | See Intrepid2::Basis_HVOL_LINE_Cn_FEM |
Intrepid2::Impl::Basis_HVOL_QUAD_Cn_FEM | See Intrepid2::Basis_HVOL_QUAD_Cn_FEM |
Intrepid2::Impl::Basis_HVOL_TET_Cn_FEM | See Intrepid2::Basis_HVOL_TET_Cn_FEM |
Intrepid2::Impl::Basis_HVOL_TRI_Cn_FEM | See Intrepid2::Basis_HVOL_TRI_Cn_FEM |
Intrepid2::Impl::CellTools | See Intrepid2::CellTools |
Intrepid2::CellTools< ExecSpaceType > | A stateless class for operations on cell data. Provides methods for: |
Intrepid2::Polylib::Serial::Cubature< polyType > | Gauss-Jacobi/Gauss-Radau-Jacobi/Gauss-Lobatto zeros and weights |
Intrepid2::Cubature< ExecSpaceType, pointValueType, weightValueType > | Defines the base class for cubature (integration) rules in Intrepid |
Intrepid2::CubatureControlVolume< ExecSpaceType, pointValueType, weightValueType > | Defines cubature (integration) rules over control volumes |
Intrepid2::CubatureControlVolumeBoundary< ExecSpaceType, pointValueType, weightValueType > | Defines cubature (integration) rules over Neumann boundaries for control volume method |
Intrepid2::CubatureControlVolumeSide< ExecSpaceType, pointValueType, weightValueType > | Defines cubature (integration) rules over control volumes |
Intrepid2::CubatureDirect< ExecSpaceType, pointValueType, weightValueType > | Defines direct cubature (integration) rules in Intrepid |
Intrepid2::CubatureDirectLineGauss< ExecSpaceType, pointValueType, weightValueType > | Defines Gauss integration rules on a line |
Intrepid2::CubatureDirectLineGaussJacobi20< ExecSpaceType, pointValueType, weightValueType > | Defines GaussJacobi20 integration rules on a line used for Pyramid only |
Intrepid2::CubatureDirectTetDefault< ExecSpaceType, pointValueType, weightValueType > | Defines direct integration rules on a tetrahedron |
Intrepid2::CubatureDirectTriDefault< ExecSpaceType, pointValueType, weightValueType > | Defines direct integration rules on a triangle |
Intrepid2::CubaturePolylib< ExecSpaceType, pointValueType, weightValueType > | Utilizes cubature (integration) rules contained in the library Polylib (Spencer Sherwin, Aeronautics, Imperial College London) within Intrepid |
Intrepid2::CubatureTensor< ExecSpaceType, pointValueType, weightValueType > | Defines tensor-product cubature (integration) rules in Intrepid |
Intrepid2::CubatureTensorPyr< ExecSpaceType, pointValueType, weightValueType > | Defines tensor-product cubature (integration) rules in Intrepid |
Intrepid2::CubatureDirect< ExecSpaceType, pointValueType, weightValueType >::CubatureData | Cubature data is defined on exec space and deep-copied when an object is created |
Intrepid2::CubatureDirect< ExecSpaceType, pointValueType, weightValueType >::CubatureDataStatic | Cubature data is defined on the host space and is static |
Intrepid2::DeduceLayout< ViewType > | Layout deduction (temporary meta-function) |
Intrepid2::DefaultCubatureFactory | A factory class that generates specific instances of cubatures |
Intrepid2::Polylib::Serial::Derivative< polyType > | Compute the Derivative Matrix and its transpose associated with the Gauss-Jacobi/Gauss-Radau-Jacobi/Gauss-Lobatto-Jacobi zeros |
Intrepid2::ExecSpace< ViewSpaceType, UserSpaceType > | Space overload |
Intrepid2::ExecSpace< ViewSpaceType, void > | Space overload |
Intrepid2::FunctorRealSpaceTools::F_absval< absArrayViewType, inArrayViewType > | Functor to compute absolute value see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctorRealSpaceTools::F_add< sumArrayViewType, inArray1Viewtype, inArray2ViewType > | Functor to add md arrays see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctorFunctionSpaceTools::F_applyFieldSigns< inoutFunctionViewType, fieldSignViewType > | Functor for applyFieldSigns, see Intrepid2::FunctionSpaceTools for more |
Intrepid2::FunctorFunctionSpaceTools::F_applyLeftFieldSigns< inoutOperatorViewType, fieldSignViewType > | Functor for applyLeftFieldSigns, see Intrepid2::FunctionSpaceTools for more |
Intrepid2::FunctorFunctionSpaceTools::F_applyRightFieldSigns< inoutOperatorViewType, fieldSignViewType > | Functor for applyRightFieldSigns, see Intrepid2::FunctionSpaceTools for more |
Intrepid2::FunctorArrayTools::F_clone< outputViewType, inputViewType, valRank > | Functor for clone see Intrepid2::ArrayTools for more |
Intrepid2::FunctorRealSpaceTools::F_clone< outputViewType, inputViewType > | Functor for clone see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctorFunctionSpaceTools::F_computeCellMeasure< outputValViewType, inputDetViewType, inputWeightViewType > | Functor for calculation of cell measure, see Intrepid2::FunctionSpaceTools for more |
Intrepid2::FunctorArrayTools::F_contractDataData< outputDataViewType, inputDataLeftViewType, inputDataRightViewType > | Functor to contractDataData see Intrepid2::ArrayTools for more |
Intrepid2::FunctorArrayTools::F_contractDataField< outputFieldsViewType, inputDataViewType, inputFieldsViewType > | Functor to contractDataField see Intrepid2::ArrayTools for more |
Intrepid2::FunctorArrayTools::F_contractFieldField< outFieldViewType, leftFieldViewType, rightFieldViewType > | Functor to contractFieldField see Intrepid2::ArrayTools for more |
Intrepid2::FunctorArrayTools::F_crossProduct< outputViewType, leftInputViewType, rightInputViewType > | Functor for crossProduct see Intrepid2::ArrayTools for more |
Intrepid2::FunctorRealSpaceTools::F_det< detArrayViewType, inMatViewType > | Functor to compute determinant see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctorRealSpaceTools::F_dot< dotArrayViewType, inVec1ViewType, inVec2ViewType > | Functor to compute dot product see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctorArrayTools::F_dotMultiply< outputViewType, leftInputViewType, rightInputViewType > | Functor for dotMultiply see Intrepid2::ArrayTools for more |
Intrepid2::FunctorFunctionSpaceTools::F_evaluate< outputPointViewType, inputCoeffViewType, inputFieldViewType > | Functor to evaluate functions, see Intrepid2::FunctionSpaceTools for more |
Intrepid2::FunctorRealSpaceTools::F_extractScalarValues< outputViewType, inputViewType > | Functor for extractScalarValues see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctorCellTools::F_getSubcvCoords_Hexahedron< subcvCoordViewType, cellCoordViewType, mapViewType > | Functor for calculation of sub-control volume coordinates on hexahedra see Intrepid2::CellTools for more |
Intrepid2::FunctorCellTools::F_getSubcvCoords_Polygon2D< subcvCoordViewType, cellCoordViewType, mapViewType > | Functor for calculation of sub-control volume coordinates on polygons see Intrepid2::CellTools for more |
Intrepid2::FunctorCellTools::F_getSubcvCoords_Tetrahedron< subcvCoordViewType, cellCoordViewType, mapViewType > | Functor for calculation of sub-control volume coordinates on tetrahedra see Intrepid2::CellTools for more |
Intrepid2::FunctorFunctionSpaceTools::F_HGRADtransformGRAD< outputViewType, jacInverseViewType, inputViewType, spaceDim > | Functor for calculation HGRADtransformGRAD, see Intrepid2::FunctionSpaceTools for more |
Intrepid2::FunctorRealSpaceTools::F_inverse< inverseMatViewType, inMatViewType > | Functor to compute inverse see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctorCellTools::F_mapToPhysicalFrame< physPointViewType, worksetCellType, basisValType > | Functor for mapping reference points to physical frame see Intrepid2::CellTools for more |
Intrepid2::FunctorArrayTools::F_matmatProduct< outputViewType, leftInputViewType, rightInputViewType > | Functor for matmatProduct see Intrepid2::ArrayTools for more |
Intrepid2::FunctorRealSpaceTools::F_matvec< matVecViewType, inMatViewType, inVecViewType > | Functor to compute matvec see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctorArrayTools::F_matvecProduct< outputViewType, leftInputViewType, rightInputViewType > | Functor for matvecProduct see Intrepid2::ArrayTools for more |
Intrepid2::FunctorArrayTools::F_outerProduct< outputViewType, leftInputViewType, rightInputViewType > | Functor for outerProduct see Intrepid2::ArrayTools for more |
Intrepid2::FunctorArrayTools::F_scalarMultiply< outputViewType, inputLeftViewType, inputRightViewType, equalRank, reciprocal > | Functor for scalarMultiply see Intrepid2::ArrayTools for more |
Intrepid2::FunctorRealSpaceTools::F_scale< ValueType, scaledArrayViewType, inArrayViewType > | Functor to scale md arrays see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctorCellTools::F_setJacobian< jacobianViewType, worksetCellType, basisGradType > | Functor for calculation of Jacobian on cell workset see Intrepid2::CellTools for more |
Intrepid2::FunctorRealSpaceTools::F_subtract< diffArrayViewType, inArray1ViewType, inArray2ViewType > | Functor to subtract md arrays see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctorRealSpaceTools::F_transpose< transposeMatViewType, inMatViewType > | Functor to compute transpose see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctorRealSpaceTools::F_vecprod< vecProdViewType, inLeftViewType, inRightViewType > | Functor to compute vecprod see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctorRealSpaceTools::F_vectorNorm< normArrayViewType, inVecViewType > | Functor to compute vector norm see Intrepid2::RealSpaceTools for more |
Intrepid2::FunctionSpaceTools< ExecSpaceType > | Defines expert-level interfaces for the evaluation of functions and operators in physical space (supported for FE, FV, and FD methods) and FE reference space; in addition, provides several function transformation utilities |
Intrepid2::Impl::Basis_HCURL_WEDGE_I1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HCURL_WEDGE_I1_FEM |
Intrepid2::Impl::Basis_HGRAD_QUAD_C1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_QUAD_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_LINE_C1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_LINE_C1_FEM |
Intrepid2::Impl::Basis_HDIV_QUAD_I1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HDIV_QUAD_I1_FEM |
Intrepid2::Impl::Basis_HCURL_TRI_In_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HCURL_TRI_In_FEM |
Intrepid2::Impl::Basis_HGRAD_QUAD_C2_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_QUAD_C2_FEM |
Intrepid2::Impl::Basis_HGRAD_HEX_Cn_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HGRAD_HEX_Cn_FEM |
Intrepid2::Impl::Basis_HCURL_TET_I1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HCURL_TET_I1_FEM |
Intrepid2::Impl::Basis_HGRAD_QUAD_Cn_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HGRAD_QUAD_Cn_FEM |
Intrepid2::CubatureTensorPyr< ExecSpaceType, pointValueType, weightValueType >::Functor< cubPointViewType, cubWeightViewType > | |
Intrepid2::Impl::Basis_HGRAD_TET_C1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_TET_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_C2_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_TET_C2_FEM |
Intrepid2::Impl::Basis_HDIV_HEX_I1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HDIV_HEX_I1_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_Cn_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HGRAD_TET_Cn_FEM |
Intrepid2::Impl::Basis_HGRAD_HEX_C2_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_HEX_C2_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_Cn_FEM_ORTH::Functor< outputValueViewType, inputPointViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HGRAD_TET_Cn_FEM_ORTH |
Intrepid2::Impl::Basis_HDIV_HEX_In_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HDIV_HEX_In_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_COMP12_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_TET_COMP12_FEM |
Intrepid2::Impl::Basis_HCURL_TRI_I1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HCURL_TRI_I1_FEM |
Intrepid2::Impl::Basis_HCURL_HEX_I1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HCURL_HEX_I1_FEM |
Intrepid2::Impl::Basis_HGRAD_TRI_C1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_TRI_C1_FEM |
Intrepid2::CubatureControlVolumeSide< ExecSpaceType, pointValueType, weightValueType >::Functor< cubPointViewType, cubWeightViewType, subcvCoordViewType, subcvSideNormalViewType, mapViewType > | |
Intrepid2::Impl::Basis_HGRAD_TRI_C2_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_TRI_C2_FEM |
Intrepid2::Impl::Basis_HGRAD_PYR_C1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_PYR_C1_FEM |
Intrepid2::Impl::Basis_HDIV_QUAD_In_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HDIV_QUAD_In_FEM |
Intrepid2::Impl::Basis_HGRAD_TRI_Cn_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HGRAD_TRI_Cn_FEM |
Intrepid2::CubatureControlVolume< ExecSpaceType, pointValueType, weightValueType >::Functor< cubPointViewType, cubWeightViewType, subcvCoordViewType, subcvWeightViewType, jacDetViewType > | |
Intrepid2::Impl::Basis_HDIV_WEDGE_I1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HDIV_WEDGE_I1_FEM |
Intrepid2::Impl::Basis_HCURL_TET_In_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HCURL_TET_In_FEM |
Intrepid2::Impl::Basis_HGRAD_TRI_Cn_FEM_ORTH::Functor< outputValueViewType, inputPointViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HGRAD_TRI_Cn_FEM_ORTH |
Intrepid2::Impl::Basis_HDIV_TET_I1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HDIV_TET_I1_FEM |
Intrepid2::Impl::Basis_HGRAD_WEDGE_C1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_WEDGE_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_WEDGE_C2_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_WEDGE_C2_FEM |
Intrepid2::Impl::Basis_HDIV_TET_In_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HDIV_TET_In_FEM |
Intrepid2::Impl::Basis_HCURL_QUAD_In_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HCURL_QUAD_In_FEM |
Intrepid2::Impl::Basis_HVOL_C0_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HVOL_C0_FEM |
Intrepid2::Impl::Basis_HGRAD_LINE_Cn_FEM_JACOBI::Functor< outputValueViewType, inputPointViewType, opType, numPtsEval > | See Intrepid2::Basis_HGRAD_LINE_Cn_FEM_JACOBI |
Intrepid2::Impl::Basis_HVOL_HEX_Cn_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HVOL_HEX_Cn_FEM |
Intrepid2::Impl::Basis_HDIV_TRI_I1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HDIV_TRI_I1_FEM |
Intrepid2::Impl::Basis_HVOL_LINE_Cn_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HVOL_LINE_Cn_FEM |
Intrepid2::Impl::Basis_HVOL_QUAD_Cn_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HVOL_QUAD_Cn_FEM |
Intrepid2::Impl::Basis_HDIV_TRI_In_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HDIV_TRI_In_FEM |
Intrepid2::Impl::Basis_HCURL_QUAD_I1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HCURL_QUAD_I1_FEM |
Intrepid2::Impl::Basis_HVOL_TET_Cn_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HVOL_TET_Cn_FEM |
Intrepid2::Impl::Basis_HVOL_TRI_Cn_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HVOL_TRI_Cn_FEM |
Intrepid2::Impl::Basis_HGRAD_HEX_C1_FEM::Functor< outputValueViewType, inputPointViewType, opType > | See Intrepid2::Basis_HGRAD_HEX_C1_FEM |
Intrepid2::CubatureControlVolumeBoundary< ExecSpaceType, pointValueType, weightValueType >::Functor< cubPointViewType, subcvCoordViewType, mapViewType > | |
Intrepid2::Impl::Basis_HGRAD_LINE_Cn_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HGRAD_LINE_Cn_FEM |
Intrepid2::Impl::Basis_HCURL_HEX_In_FEM::Functor< outputValueViewType, inputPointViewType, vinvViewType, workViewType, opType, numPtsEval > | See Intrepid2::Basis_HCURL_HEX_In_FEM |
Intrepid2::Impl::Hexahedron< N > | |
Intrepid2::Impl::Hexahedron< 20 > | Hexahedron topology, 20 nodes |
Intrepid2::Impl::Hexahedron< 27 > | Hexahedron topology, 27 nodes |
Intrepid2::Impl::Hexahedron< 8 > | Hexahedron topology, 8 nodes |
Intrepid2::ArrayTools< ExecSpaceType >::Internal | |
Intrepid2::Polylib::Serial::InterpolationOperator< polyType > | Interpolation Operator from Gauss-Jacobi points to an arbitrary distribution at points zm |
Intrepid2::Polylib::Serial::LagrangianInterpolant< polyType > | Compute the value of the i th Lagrangian interpolant through the np Gauss-Jacobi/Gauss-Radau-Jacobi/Gauss-Lobatto points zgj at the arbitrary location z |
Intrepid2::Experimental::LagrangianInterpolation< ExecSpaceType > | A class providing static members to perform Lagrangian interpolation on a finite element |
Intrepid2::Impl::Line< N > | |
Intrepid2::Impl::Line< 2 > | Line topology, 2 nodes |
Intrepid2::Impl::Line< 3 > | Line topology, 3 nodes |
Intrepid2::Orientation | Orientation encoding and decoding |
Intrepid2::OrientationTools< ExecSpaceType > | Tools to compute orientations for degrees-of-freedom |
Intrepid2::Impl::OrientationTools | Tools to compute orientations for degrees-of-freedom |
Intrepid2::Impl::OrthPolynomialTet< outputViewType, inputViewType, workViewType, hasDeriv, n > | See Intrepid2::Basis_HGRAD_TET_Cn_FEM_ORTH |
Intrepid2::Impl::OrthPolynomialTet< outputViewType, inputViewType, workViewType, hasDeriv, 0 > | See Intrepid2::Basis_HGRAD_TET_Cn_FEM_ORTH |
Intrepid2::Impl::OrthPolynomialTet< outputViewType, inputViewType, workViewType, hasDeriv, 1 > | See Intrepid2::Basis_HGRAD_TET_Cn_FEM_ORTH |
Intrepid2::Impl::OrthPolynomialTri< outputViewType, inputViewType, workViewType, hasDeriv, n > | See Intrepid2::Basis_HGRAD_TRI_Cn_FEM_ORTH |
Intrepid2::Impl::OrthPolynomialTri< outputViewType, inputViewType, workViewType, hasDeriv, 0 > | See Intrepid2::Basis_HGRAD_TRI_Cn_FEM_ORTH |
Intrepid2::Impl::OrthPolynomialTri< outputViewType, inputViewType, workViewType, hasDeriv, 1 > | See Intrepid2::Basis_HGRAD_TRI_Cn_FEM_ORTH |
Intrepid2::Parameters | Define constants |
Intrepid2::PointTools | Utility class that provides methods for calculating distributions of points on different cells |
Intrepid2::Polylib | Providing orthogonal polynomial calculus and interpolation, created by Spencer Sherwin, Aeronautics, Imperial College London, modified and redistributed by D. Ridzal |
Intrepid2::Experimental::ProjectionStruct< SpT, ValueType > | An helper class to compute the evaluation points and weights needed for performing projections |
Intrepid2::Experimental::ProjectionTools< ExecSpaceType > | A class providing static members to perform projection-based interpolations: |
Intrepid2::Impl::Pyramid< N > | |
Intrepid2::Impl::Pyramid< 13 > | Pyramid topology, 13 nodes |
Intrepid2::Impl::Pyramid< 14 > | Pyramid topology, 14 nodes |
Intrepid2::Impl::Pyramid< 5 > | Pyramid topology, 5 nodes |
Intrepid2::Impl::Quadrilateral< N > | |
Intrepid2::Impl::Quadrilateral< 4 > | Quadrilateral topology, 4 nodes |
Intrepid2::Impl::Quadrilateral< 8 > | Quadrilateral topology, 8 nodes |
Intrepid2::Impl::Quadrilateral< 9 > | Quadrilateral topology, 9 nodes |
Intrepid2::RealSpaceTools< ExecSpaceType > | Implementation of basic linear algebra functionality in Euclidean space |
Intrepid2::CellTools< ExecSpaceType >::ReferenceNodeData | Reference node data for each supported topology |
Intrepid2::CellTools< ExecSpaceType >::ReferenceNodeDataStatic | Reference node containers for each supported topology |
Intrepid2::Impl::CellTools::ReferenceNodeDataType | |
Intrepid2::ScalarTraits< T > | Scalar type traits |
Intrepid2::ScalarTraits< double > | Built in support for double |
Intrepid2::ScalarTraits< float > | Built in support for float |
Intrepid2::ScalarTraits< int > | Built in support for int |
Intrepid2::ScalarTraits< long int > | Built in support for long int |
Intrepid2::ScalarTraits< long long > | Built in support for long long |
Intrepid2::Impl::Basis_HCURL_TET_In_FEM::Serial< opType > | See Intrepid2::Basis_HCURL_TET_In_FEM |
Intrepid2::Impl::Basis_HCURL_QUAD_I1_FEM::Serial< opType > | See Intrepid2::Basis_HCURL_QUAD_I1_FEM |
Intrepid2::Impl::Basis_HGRAD_TRI_C2_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_TRI_C2_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_C1_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_TET_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_WEDGE_C2_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_WEDGE_C2_FEM |
Intrepid2::Impl::Basis_HGRAD_QUAD_C1_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_QUAD_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_QUAD_Cn_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_QUAD_Cn_FEM work is a rank 1 view having the same value_type of inputPoints and having size equal to getWorkSizePerPoint()*inputPoints.extent(0); |
Intrepid2::Impl::Basis_HVOL_TRI_Cn_FEM::Serial< opType > | See Intrepid2::Basis_HVOL_TRI_Cn_FEM |
Intrepid2::Impl::Basis_HCURL_HEX_In_FEM::Serial< opType > | See Intrepid2::Basis_HCURL_HEX_In_FEM |
Intrepid2::Impl::Basis_HDIV_WEDGE_I1_FEM::Serial< opType > | See Intrepid2::Basis_HDIV_WEDGE_I1_FEM |
Intrepid2::Impl::Basis_HGRAD_LINE_Cn_FEM_JACOBI::Serial< opType > | See Intrepid2::Basis_HGRAD_LINE_Cn_FEM_JACOBI |
Intrepid2::Impl::Basis_HGRAD_PYR_C1_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_PYR_C1_FEM |
Intrepid2::Impl::Basis_HDIV_TRI_I1_FEM::Serial< opType > | See Intrepid2::Basis_HDIV_TRI_I1_FEM |
Intrepid2::Impl::Basis_HGRAD_HEX_C1_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_HEX_C1_FEM |
Intrepid2::Impl::CellTools::Serial | |
Intrepid2::Impl::Basis_HCURL_QUAD_In_FEM::Serial< opType > | See Intrepid2::Basis_HCURL_QUAD_In_FEM |
Intrepid2::Impl::Basis_HDIV_QUAD_I1_FEM::Serial< opType > | See Intrepid2::Basis_HDIV_QUAD_I1_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_C2_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_TET_C2_FEM |
Intrepid2::Impl::Basis_HVOL_C0_FEM::Serial< opType > | See Intrepid2::Basis_HVOL_C0_FEM |
Intrepid2::Impl::Basis_HCURL_TRI_In_FEM::Serial< opType > | See Intrepid2::Basis_HCURL_TRI_In_FEM |
Intrepid2::Impl::Basis_HGRAD_LINE_C1_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_LINE_C1_FEM |
Intrepid2::Impl::Basis_HDIV_HEX_In_FEM::Serial< opType > | See Intrepid2::Basis_HDIV_HEX_In_FEM |
Intrepid2::Basis_HDIV_HEX_I1_FEM< ExecSpaceType, outputValueType, pointValueType >::Serial< opType > | |
Intrepid2::RealSpaceTools< ExecSpaceType >::Serial | |
Intrepid2::Impl::Basis_HGRAD_TRI_Cn_FEM_ORTH::Serial< opType > | See Intrepid2::Basis_HGRAD_TRI_Cn_FEM_ORTH |
Intrepid2::Kernels::Serial | |
Intrepid2::Impl::Basis_HCURL_HEX_I1_FEM::Serial< opType > | See Intrepid2::Basis_HCURL_HEX_I1_FEM |
Intrepid2::Impl::Basis_HVOL_LINE_Cn_FEM::Serial< opType > | See Intrepid2::Basis_HVOL_LINE_Cn_FEM |
Intrepid2::Impl::Basis_HGRAD_WEDGE_C1_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_WEDGE_C1_FEM |
Intrepid2::Impl::Basis_HGRAD_HEX_C2_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_HEX_C2_FEM |
Intrepid2::Impl::Basis_HDIV_QUAD_In_FEM::Serial< opType > | See Intrepid2::Basis_HDIV_QUAD_In_FEM |
Intrepid2::Impl::Basis_HGRAD_TRI_C1_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_TRI_C1_FEM |
Intrepid2::Impl::Basis_HVOL_QUAD_Cn_FEM::Serial< opType > | See Intrepid2::Basis_HVOL_QUAD_Cn_FEM |
Intrepid2::Impl::Basis_HDIV_HEX_I1_FEM::Serial< opType > | See Intrepid2::Basis_HDIV_HEX_I1_FEM |
Intrepid2::Impl::Basis_HGRAD_TRI_Cn_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_TRI_Cn_FEM work is a rank 1 view having the same value_type of inputPoints and having size equal to getWorkSizePerPoint()*inputPoints.extent(0); |
Intrepid2::Impl::Basis_HCURL_WEDGE_I1_FEM::Serial< opType > | See Intrepid2::Basis_HCURL_WEDGE_I1_FEM |
Intrepid2::Impl::Basis_HCURL_TET_I1_FEM::Serial< opType > | See Intrepid2::Basis_HCURL_TET_I1_FEM |
Intrepid2::Impl::Basis_HVOL_HEX_Cn_FEM::Serial< opType > | See Intrepid2::Basis_HVOL_HEX_Cn_FEM |
Intrepid2::Impl::Basis_HDIV_TRI_In_FEM::Serial< opType > | See Intrepid2::Basis_HDIV_TRI_In_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_Cn_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_TET_Cn_FEM |
Intrepid2::Impl::Basis_HVOL_TET_Cn_FEM::Serial< opType > | See Intrepid2::Basis_HVOL_TET_Cn_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_COMP12_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_TET_COMP12_FEM |
Intrepid2::Impl::Basis_HDIV_TET_I1_FEM::Serial< opType > | See Intrepid2::Basis_HDIV_TET_I1_FEM |
Intrepid2::Impl::Basis_HGRAD_QUAD_C2_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_QUAD_C2_FEM |
Intrepid2::Impl::Basis_HDIV_TET_In_FEM::Serial< opType > | See Intrepid2::Basis_HDIV_TET_In_FEM |
Intrepid2::Impl::Basis_HGRAD_TET_Cn_FEM_ORTH::Serial< opType > | See Intrepid2::Basis_HGRAD_TET_Cn_FEM_ORTH |
Intrepid2::Impl::Basis_HGRAD_LINE_Cn_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_LINE_Cn_FEM |
Intrepid2::Impl::Basis_HGRAD_HEX_Cn_FEM::Serial< opType > | See Intrepid2::Basis_HGRAD_HEX_Cn_FEM |
Intrepid2::Impl::Basis_HCURL_TRI_I1_FEM::Serial< opType > | See Intrepid2::Basis_HCURL_TRI_I1_FEM |
Intrepid2::Polylib::Serial | |
Intrepid2::CellTools< ExecSpaceType >::SubcellParamData | Parametrization coefficients of edges and faces of reference cells |
Intrepid2::Impl::CellTools::SubcellParamDataType | |
Intrepid2::Impl::Tetrahedron< N > | |
Intrepid2::Impl::Tetrahedron< 10 > | Tetrahedron topology, 10 nodes |
Intrepid2::Impl::Tetrahedron< 11 > | Tetrahedron topology, 11 nodes |
Intrepid2::Impl::Tetrahedron< 4 > | Tetrahedron topology, 4 nodes |
Intrepid2::Impl::Tetrahedron< 8 > | Tetrahedron topology, 8 nodes |
Intrepid2::Impl::Triangle< N > | |
Intrepid2::Impl::Triangle< 3 > | Triangle topology, 3 nodes |
Intrepid2::Impl::Triangle< 4 > | Triangle topology, 4 nodes |
Intrepid2::Impl::Triangle< 6 > | Triangle topology, 6 nodes |
Intrepid2::Util< T > | Small utility functions |
Intrepid2::Impl::Wedge< N > | |
Intrepid2::Impl::Wedge< 15 > | Wedge topology, 15 nodes |
Intrepid2::Impl::Wedge< 18 > | Wedge topology, 18 nodes |
Intrepid2::Impl::Wedge< 6 > | Wedge topology, 6 nodes |