ArrayTools | |
matmatProductDataDataTempSpecRight< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight,-1 > | |
matmatProductDataDataTempSpecRight< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 3 > | |
matmatProductDataDataTempSpecRight< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 4 > | |
matmatProductDataDataTempSpecLeft< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight,-1,-1 > | |
matmatProductDataDataTempSpecLeft< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 2,-1 > | |
matmatProductDataDataTempSpecLeft< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 2, 3 > | |
matmatProductDataDataTempSpecLeft< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 2, 4 > | |
matmatProductDataDataTempSpecLeft< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 3,-1 > | |
matmatProductDataDataTempSpecLeft< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 3, 3 > | |
matmatProductDataDataTempSpecLeft< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 3, 4 > | |
matmatProductDataDataTempSpecLeft< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 4,-1 > | |
matmatProductDataDataTempSpecLeft< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 4, 3 > | |
matmatProductDataDataTempSpecLeft< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 4, 4 > | |
Intrepid | |
CellTools | A stateless class for operations on cell data. Provides methods for: |
mapToPhysicalFrameTempSpec | Computes F, the reference-to-physical frame map |
setJacobianTempSpec | Computes the Jacobian matrix DF of the reference-to-physical frame map F |
ArrayTools | Utility class that provides methods for higher-order algebraic manipulation of user-defined arrays, such as tensor contractions. For low-order operations, see Intrepid::RealSpaceTools |
cloneFields2 | |
matmatProductDataDataTempSpecLeft | |
matmatProductDataDataTempSpecRight | |
scalarMultiplyDataData2 | There are two use cases: (1) dot product of a rank-3, 4 or 5 container inputFields with dimensions (C,F,P) (C,F,P,D1) or (C,F,P,D1,D2), representing the values of a set of scalar, vector or tensor fields, by the values in a rank-2, 3 or 4 container inputData indexed by (C,P), (C,P,D1), or (C,P,D1,D2) representing the values of scalar, vector or tensor data, OR (2) dot product of a rank-2, 3 or 4 container inputFields with dimensions (F,P), (F,P,D1) or (F,P,D1,D2), representing the values of a scalar, vector or tensor field, by the values in a rank-2 container inputData indexed by (C,P), (C,P,D1) or (C,P,D1,D2), representing the values of scalar, vector or tensor data; the output value container outputFields is indexed by (C,F,P), regardless of which of the two use cases is considered |
scalarMultiplyDataField2 | |
IntrepidBurkardtRules | Providing integration rules, created by John Burkardt, Scientific Computing, Florida State University, modified and redistributed by D. Kouri |
FieldContainer | Implementation of a templated lexicographical container for a multi-indexed scalar quantity. FieldContainer object stores a multi-indexed scalar value using the lexicographical index ordering: the rightmost index changes first and the leftmost index changes last. FieldContainer can be viewed as a dynamic multidimensional array whose values can be accessed in two ways: by their multi-index or by their enumeration, using an overloaded [] operator. The enumeration of a value gives the sequential order of the multi-indexed value in the container. The number of indices, i.e., the rank of the container is unlimited. For containers with ranks up to 5 many of the methods are optimized for faster execution. An overloaded () operator is also provided for such low-rank containers to allow element access by multi-index without having to create an auxiliary array for the multi-index |
PointTools | Utility class that provides methods for calculating distributions of points on different cells |
IntrepidPolylib | Providing orthogonal polynomial calculus and interpolation, created by Spencer Sherwin, Aeronautics, Imperial College London, modified and redistributed by D. Ridzal |
RealSpaceTools | Implementation of basic linear algebra functionality in Euclidean space |
detTempSpec | |
CubatureTemplate | Template for the cubature rules used by Intrepid. Cubature template consists of cubature points and cubature weights. Intrepid provides a collection of cubature templates for most standard cell topologies. The templates are defined in reference coordinates using a standard reference cell for each canonical cell type. Cubature points are always specified by a triple of (X,Y,Z) coordinates even if the cell dimension is less than 3. The unused dimensions should be padded by zeroes |
Basis | An abstract base class that defines interface for concrete basis implementations for Finite Element (FEM) and Finite Volume/Finite Difference (FVD) discrete spaces |
DofCoordsInterface | This is an interface class for bases whose degrees of freedom can be associated with spatial locations in a reference element (typically interpolation points for interpolatory bases) |
Basis_HCURL_HEX_I1_FEM | Implementation of the default H(curl)-compatible FEM basis of degree 1 on Hexahedron cell |
Basis_HCURL_HEX_In_FEM | Implementation of the default H(div)-compatible FEM basis of degree 1 on Hexahedral cell |
Basis_HCURL_QUAD_I1_FEM | Implementation of the default H(curl)-compatible FEM basis of degree 1 on Quadrilateral cell |
Basis_HCURL_QUAD_In_FEM | Implementation of the default H(div)-compatible FEM basis of degree 1 on Quadrilateral cell |
Basis_HCURL_TET_I1_FEM | Implementation of the default H(curl)-compatible FEM basis of degree 1 on Tetrahedron cell |
Basis_HCURL_TET_In_FEM | Implementation of the default H(curl)-compatible Nedelec (first kind) basis of arbitrary degree on Tetrahedron cell. The lowest order space is indexted with 1 rather than 0. Implements nodal basis of degree n (n>=1) on the reference Tetrahedron cell. The basis has cardinality n*(n+2)*(n+3)/2 and spans an INCOMPLETE polynomial space of degree n. Basis functions are dual to a unisolvent set of degrees-of-freedom (DoF) defined by |
Basis_HCURL_TRI_I1_FEM | Implementation of the default H(curl)-compatible FEM basis of degree 1 on Triangle cell |
Basis_HCURL_TRI_In_FEM | Implementation of the default H(curl)-compatible Nedelec (first kind) basis of arbitrary degree on Triangle cell. The lowest order space is indexed with 1 rather than 0. Implements nodal basis of degree n (n>=1) on the reference Triangle cell. The basis has cardinality n(n+2) and spans an INCOMPLETE polynomial space of degree n. Basis functions are dual to a unisolvent set of degrees-of-freedom (DoF) defined by |
Basis_HCURL_WEDGE_I1_FEM | Implementation of the default H(curl)-compatible FEM basis of degree 1 on Wedge cell |
Basis_HDIV_HEX_I1_FEM | Implementation of the default H(div)-compatible FEM basis of degree 1 on Hexahedron cell |
Basis_HDIV_HEX_In_FEM | Implementation of the default H(div)-compatible FEM basis of degree 1 on Hexahedral cell |
Basis_HDIV_QUAD_I1_FEM | Implementation of the default H(div)-compatible FEM basis of degree 1 on Quadrilateral cell |
Basis_HDIV_QUAD_In_FEM | Implementation of the default H(div)-compatible FEM basis of degree 1 on Quadrilateral cell |
Basis_HDIV_TET_I1_FEM | Implementation of the default H(div)-compatible FEM basis of degree 1 on Tetrahedron cell |
Basis_HDIV_TET_In_FEM | Implementation of the default H(div)-compatible Raviart-Thomas basis of arbitrary degree on Tetrahedron cell. The lowest order instance starts with n. Implements the nodal basis of degree n the reference Tetrahedron cell. The basis has cardinality n(n+1)(n+3)/2 and spans an INCOMPLETE polynomial space of degree n. Basis functions are dual to a unisolvent set of degrees-of-freedom (DoF) defined and enumerated as follows: |
Basis_HDIV_TRI_I1_FEM | Implementation of the default H(div)-compatible FEM basis of degree 1 on a Triangle cell |
Basis_HDIV_TRI_In_FEM | Implementation of the default H(div)-compatible Raviart-Thomas basis of arbitrary degree on Triangle cell |
Basis_HDIV_WEDGE_I1_FEM | Implementation of the default H(div)-compatible FEM basis of degree 1 on Wedge cell |
Basis_HGRAD_HEX_C1_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Hexahedron cell |
Basis_HGRAD_HEX_C2_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Hexahedron cell |
Basis_HGRAD_HEX_Cn_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Hexahedron cell |
Basis_HGRAD_HEX_I2_FEM | Implementation of the serendipity-family H(grad)-compatible FEM basis of degree 2 on a Hexahedron cell |
Basis_HGRAD_LINE_C1_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Line cell |
Basis_HGRAD_LINE_Cn_FEM | Implementation of the locally H(grad)-compatible FEM basis of variable order on the [-1,1] reference line cell, using Lagrange polynomials |
Basis_HGRAD_LINE_Cn_FEM_JACOBI | Implementation of the locally H(grad)-compatible FEM basis of variable order on the [-1,1] reference line cell, using Jacobi polynomials |
Basis_HGRAD_LINE_Hermite_FEM | Implements Hermite interpolant basis of degree n on the reference Line cell. The basis has cardinality 2n and spans a COMPLETE linear polynomial space |
Basis_HGRAD_POLY_C1_FEM | |
Basis_HGRAD_PYR_C1_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Pyramid cell |
Basis_HGRAD_PYR_I2_FEM | Implementation of an H(grad)-compatible FEM basis of degree 2 on a Pyramid cell |
Basis_HGRAD_QUAD_C1_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Quadrilateral cell |
Basis_HGRAD_QUAD_C2_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Quadrilateral cell |
Basis_HGRAD_QUAD_Cn_FEM | |
Basis_HGRAD_TET_C1_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Tetrahedron cell |
Basis_HGRAD_TET_C2_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Tetrahedron cell |
Basis_HGRAD_TET_Cn_FEM | Implementation of the default H(grad)-compatible Lagrange basis of arbitrary degree on Tetrahedron cell |
Basis_HGRAD_TET_Cn_FEM_ORTH | Implementation of the default H(grad)-compatible orthogonal basis of arbitrary degree on tetrahedron |
TabulatorTet | This is an internal class with a static member function for tabulating derivatives of orthogonal expansion functions |
TabulatorTet< Scalar, ArrayScalar, 0 > | This is specialized on 0th derivatives to make the tabulate function run through recurrence relations |
TabulatorTet< Scalar, ArrayScalar, 1 > | This is specialized on 1st derivatives since it recursively calls the 0th derivative class with Sacado AD types, and so the outputValues it passes to that function needs to have a rank 2 rather than rank 3 |
Basis_HGRAD_TET_COMP12_FEM | |
Basis_HGRAD_TRI_C1_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Triangle cell |
Basis_HGRAD_TRI_C2_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Triangle cell |
Basis_HGRAD_TRI_Cn_FEM | Implementation of the default H(grad)-compatible Lagrange basis of arbitrary degree on Triangle cell |
Basis_HGRAD_TRI_Cn_FEM_ORTH | Implementation of the default H(grad)-compatible orthogonal basis (Dubiner) of arbitrary degree on triangle |
TabulatorTri | This is an internal class with a static member function for tabulating derivatives of orthogonal expansion functions |
TabulatorTri< Scalar, ArrayScalar, 0 > | This is specialized on 0th derivatives to make the tabulate function run through recurrence relations |
TabulatorTri< Scalar, ArrayScalar, 1 > | This is specialized on 1st derivatives since it recursively calls the 0th derivative class with Sacado AD types, and so the outputValues it passes to that function needs to have a rank 2 rather than rank 3 |
Basis_HGRAD_WEDGE_C1_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 1 on Wedge cell |
Basis_HGRAD_WEDGE_C2_FEM | Implementation of the default H(grad)-compatible FEM basis of degree 2 on Wedge cell |
Basis_HGRAD_WEDGE_I2_FEM | Implementation of an H(grad)-compatible FEM basis of degree 2 on Wedge cell |
OrthogonalBases | |
ProductTopology | Utility class that provides methods for calculating distributions of points on different cells |
TensorBasis | An abstract base class that defines interface for bases that are tensor products of simpler bases |
FunctionSpaceTools | 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 |
integrateTempSpec | |
tensorMultiplyDataDataTempSpec | |
tensorMultiplyDataDataTempSpec< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 3 > | |
tensorMultiplyDataDataTempSpec< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight, 4 > | |
tensorMultiplyDataDataTempSpec< Scalar, ArrayOutData, ArrayInDataLeft, ArrayInDataRight,-1 > | |
FunctionSpaceToolsInPlace | 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 |
AdaptiveSparseGrid | Builds general adaptive sparse grid rules (Gerstner and Griebel) using the 1D cubature rules in the Intrepid::CubatureLineSorted class |
AdaptiveSparseGridInterface | |
Cubature | Defines the base class for cubature (integration) rules in Intrepid |
CubatureCompositeTet | Defines integration rules for the composite tetrahedron |
CubatureControlVolume | Defines cubature (integration) rules over control volumes |
CubatureControlVolumeBoundary | Defines cubature (integration) rules over Neumann boundaries for control volume method |
CubatureControlVolumeSide | Defines cubature (integration) rules over control volumes |
CubatureDirect | Defines direct cubature (integration) rules in Intrepid |
CubatureDirectLineGauss | Defines Gauss integration rules on a line |
CubatureDirectLineGaussJacobi20 | Defines GaussJacobi20 integration rules on a line |
CubatureDirectTetDefault | Defines direct integration rules on a tetrahedron |
CubatureDirectTriDefault | Defines direct integration rules on a triangle |
CubatureGenSparse | |
CubatureLineSorted | Utilizes cubature (integration) rules contained in the library sandia_rules (John Burkardt, Scientific Computing, Florida State University) within Intrepid |
CubaturePolygon | |
CubaturePolylib | Utilizes cubature (integration) rules contained in the library Polylib (Spencer Sherwin, Aeronautics, Imperial College London) within Intrepid |
CubatureSparse | |
SGPoint | |
SGNodes | |
CubatureTensor | Defines tensor-product cubature (integration) rules in Intrepid |
CubatureTensorPyr | Defines tensor-product cubature (integration) rules in Intrepid |
CubatureTensorSorted | Utilizes 1D cubature (integration) rules contained in the library sandia_rules (John Burkardt, Scientific Computing, Florida State University) within Intrepid |
DefaultCubatureFactory | A factory class that generates specific instances of cubatures |
TensorProductSpaceTools | Defines expert-level interfaces for the evaluation, differentiation and integration of finite element-functions defined by tensor products of one-dimensional spaces. These are useful in implementing spectral element methods |
HGRAD_POLY_C1_FEM | Implementation of the default H(grad) compatible FEM basis of degree 1 on a polygon cell |
OrthgonalBases | Basic implementation of general orthogonal polynomials on a range of shapes, including the triangle, and tetrahedron |
ArrayWrapper | |
ArrayWrapper< Scalar, ArrayType, 1, false > | |
ArrayWrapper< Scalar, ArrayType, 1, true > | |
ArrayWrapper< Scalar, ArrayType, 2, false > | |
ArrayWrapper< Scalar, ArrayType, 2, true > | |
ArrayWrapper< Scalar, ArrayType, 3, false > | |
ArrayWrapper< Scalar, ArrayType, 3, true > | |
ArrayWrapper< Scalar, ArrayType, 4, false > | |
ArrayWrapper< Scalar, ArrayType, 4, true > | |
ArrayWrapper< Scalar, ArrayType, 5, false > | |
ArrayWrapper< Scalar, ArrayType, 5, true > | |
ArrayWrapper< Scalar, ArrayType, 6, false > | |
ArrayWrapper< Scalar, ArrayType, 6, true > | |
ArrayWrapper< Scalar, ArrayType, 7, false > | |
ArrayWrapper< Scalar, ArrayType, 7, true > | |
ArrayWrapper< Scalar, ArrayType, 8, false > | |
ArrayWrapper< Scalar, ArrayType, 8, true > | |
ArrayWrapper< Scalar, ArrayType,-1, false > | |
ArrayWrapper< Scalar, ArrayType,-1, true > | |
ASGdata | |
CheckType | |
Rank | |
RankSpec | |
RankSpec< DataT, 1 > | |
RankSpec< DataT, 2 > | |
RankSpec< DataT, 3 > | |
RankSpec< DataT, 4 > | |
RankSpec< DataT, 5 > | |
RankSpec< DataT, 6 > | |
RankSpec< DataT, 7 > | |
RankSpec< DataT, 8 > | |
RankSpec< DataT,-1 > | |
Return_Type | |
StdVector | |