example | |
CellTools | |
example_02.cpp | Example of the CellTools class |
example_03.cpp | Example of the CellTools class |
example_04.cpp | Example of the CellTools class |
Drivers | |
example_01.cpp | |
example_02.cpp | |
example_03.cpp | |
example_03AD.cpp | Example building stiffness matrix and right hand side for a Poisson equation using nodal (Hgrad) elements. Here we exercise Sacado's Fad types for an automated construction of PDE Jacobians through automatic differentiation |
example_03NL.cpp | Example building PDE Jacobian for a nonlinear reaction-diffusion equation using nodal (Hgrad) elements. Here we exercise Sacado's Fad types for an automated construction of PDE Jacobians through automatic differentiation |
example_04.cpp | |
example_05.cpp | Demonstrate diagonalized mass matrices for H(grad) elements in 1d using Gauss-Legendre quadrature |
example_06.cpp | Matrix-free application of the Laplace stiffness matrix for polynomials of degree d on an NX x NY mesh. We are using a reference element stiffness matrix and level 3 BLAS for the application, but not using any tensor-product decomposition |
example_07.cpp | Example building stiffness matrix for a Poisson equation using nodal (Hgrad) elements on squares. This shows how to use the local-global mapping to preallocate the matrix graph. This leads to an improvement in the time it takes to construct the global matrix |
example_08.cpp | Example building stiffness matrix and right hand side for a Poisson equation using nodal (Hgrad) elements on squares. This code transforms the basis function gradients to each cell and performs quadrature |
example_09.cpp | |
example_10.cpp | Construction of Laplace operator on a uniform hexahedral mesh using arbitrary-degree elements. This is the most naive implementation wherein we form the stiffness matrix on each cell by quadrature and do not preallocate the global matrix graph before assembling |
example_11.cpp | Construction of Laplace operator on a uniform hexahedral mesh using arbitrary-degree elements. This is the second most naive implementation wherein we form the stiffness matrix on each cell by quadrature, but we do preallocate the global matrix graph before assembling |
example_12.cpp | Construction of Laplace operator on a uniform hexahedral mesh using arbitrary-degree elements. We preallocate the global matrix graph, and then construct a single element stiffness matrix that is replicated across all cells |
example_13.cpp | Application of Laplace operator on a uniform hexahedral mesh using arbitrary-degree elements by using a single reference stiffness matrix and DGEMM |
example_14.cpp | Application of Laplace operator on a uniform hexahedral mesh using arbitrary-degree elements by using tensor product structure and Gauss-Lobatto quadrature |
example_15.cpp | Construction of Laplace operator on a uniform hexahedral mesh using arbitrary-degree elements. This assembles the matrix into STL data structures vector<map<int,double> > to get logarithmic access to columns |
example_16.cpp | Application of Laplace operator on a hexahedral mesh using arbitrary-degree elements by using TensorProductSpaceTools |
example_17.cpp | Application of Laplace operator on a hexahedral mesh using arbitrary-degree elements by using DGEMM and dual transformations |
FieldContainer | |
example_01.cpp | Illustrates use of the FieldContainer class |
example_02.cpp | Illustrates use of the FieldContainer class |
src | |
Cell | |
Intrepid_CellTools.hpp | Header file for the Intrepid::CellTools class |
Intrepid_CellToolsDef.hpp | Definition file for the Intrepid::CellTools class |
Discretization | |
Basis | |
Intrepid_Basis.hpp | Header file for the abstract base class Intrepid::Basis |
Intrepid_BasisDef.hpp | Implementation file for the abstract base class Intrepid::Basis |
Intrepid_HCURL_HEX_I1_FEM.hpp | Header file for the Intrepid::HCURL_HEX_I1_FEM class |
Intrepid_HCURL_HEX_I1_FEMDef.hpp | Definition file for FEM basis functions of degree 1 for H(curl) functions on HEX cells |
Intrepid_HCURL_HEX_In_FEM.hpp | Header file for the Intrepid::HCURL_HEX_In_FEM class |
Intrepid_HCURL_HEX_In_FEMDef.hpp | Definition file for FEM basis functions of degree n for H(div) functions on HEX cells |
Intrepid_HCURL_QUAD_I1_FEM.hpp | Header file for the Intrepid::HCURL_QUAD_I1_FEM class |
Intrepid_HCURL_QUAD_I1_FEMDef.hpp | Definition file for default FEM basis functions of degree 1 for H(curl) functions on Qadrilateral cells |
Intrepid_HCURL_QUAD_In_FEM.hpp | Header file for the Intrepid::HCURL_QUAD_In_FEM class |
Intrepid_HCURL_QUAD_In_FEMDef.hpp | Definition file for FEM basis functions of degree n for H(div) functions on HEX cells |
Intrepid_HCURL_TET_I1_FEM.hpp | Header file for the Intrepid::HCURL_TET_I1_FEM class |
Intrepid_HCURL_TET_I1_FEMDef.hpp | Definition file for FEM basis functions of degree 1 for H(curl) functions on TET cells |
Intrepid_HCURL_TET_In_FEM.hpp | Header file for the Intrepid::HCURL_TET_In_FEM class |
Intrepid_HCURL_TET_In_FEMDef.hpp | |
Intrepid_HCURL_TRI_I1_FEM.hpp | Header file for the Intrepid::HCURL_TRI_I1_FEM class |
Intrepid_HCURL_TRI_I1_FEMDef.hpp | Definition file for default FEM basis functions of degree 1 for H(curl) functions on Triangle cells |
Intrepid_HCURL_TRI_In_FEM.hpp | Header file for the Intrepid::HCURL_TRI_In_FEM class |
Intrepid_HCURL_TRI_In_FEMDef.hpp | |
Intrepid_HCURL_WEDGE_I1_FEM.hpp | Header file for the Intrepid::HCURL_WEDGE_I1_FEM class |
Intrepid_HCURL_WEDGE_I1_FEMDef.hpp | Definition file for FEM basis functions of degree 1 for H(curl) functions on WEDGE cells |
Intrepid_HDIV_HEX_I1_FEM.hpp | Header file for the Intrepid::HDIV_HEX_I1_FEM class |
Intrepid_HDIV_HEX_I1_FEMDef.hpp | Definition file for FEM basis functions of degree 1 for H(div) functions on HEX cells |
Intrepid_HDIV_HEX_In_FEM.hpp | Header file for the Intrepid::HDIV_HEX_In_FEM class |
Intrepid_HDIV_HEX_In_FEMDef.hpp | Definition file for FEM basis functions of degree n for H(div) functions on HEX cells |
Intrepid_HDIV_QUAD_I1_FEM.hpp | Header file for the Intrepid::HDIV_QUAD_I1_FEM class |
Intrepid_HDIV_QUAD_I1_FEMDef.hpp | Definition file for FEM basis functions of degree 1 for H(div) functions on HEX cells |
Intrepid_HDIV_QUAD_In_FEM.hpp | Header file for the Intrepid::HDIV_QUAD_In_FEM class |
Intrepid_HDIV_QUAD_In_FEMDef.hpp | Definition file for FEM basis functions of degree n for H(div) functions on HEX cells |
Intrepid_HDIV_TET_I1_FEM.hpp | Header file for the Intrepid::HDIV_TET_I1_FEM class |
Intrepid_HDIV_TET_I1_FEMDef.hpp | Definition file for FEM basis functions of degree 1 for H(div) functions on TET cells |
Intrepid_HDIV_TET_In_FEM.hpp | Header file for the Intrepid::HDIV_TET_In_FEM class |
Intrepid_HDIV_TET_In_FEMDef.hpp | |
Intrepid_HDIV_TRI_I1_FEM.hpp | Header file for the Intrepid::HDIV_TRI_I1_FEM class |
Intrepid_HDIV_TRI_I1_FEMDef.hpp | Definition file for FEM basis functions of degree 1 for H(div) functions on Triangle cells |
Intrepid_HDIV_TRI_In_FEM.hpp | Header file for the Intrepid::HDIV_TRI_In_FEM class |
Intrepid_HDIV_TRI_In_FEMDef.hpp | |
Intrepid_HDIV_WEDGE_I1_FEM.hpp | Header file for the Intrepid::HDIV_WEDGE_I1_FEM class |
Intrepid_HDIV_WEDGE_I1_FEMDef.hpp | Definition file for FEM basis functions of degree 1 for H(div) functions on WEDGE cells |
Intrepid_HGRAD_HEX_C1_FEM.hpp | |
Intrepid_HGRAD_HEX_C1_FEMDef.hpp | Definition file for bi-linear FEM basis functions for H(grad) functions on Hexahedron cells |
Intrepid_HGRAD_HEX_C2_FEM.hpp | Header file for the Intrepid::HGRAD_HEX_C2_FEM class |
Intrepid_HGRAD_HEX_C2_FEMDef.hpp | Definition file for bi-linear FEM basis functions for H(grad) functions on Hexahedron cells |
Intrepid_HGRAD_HEX_Cn_FEM.hpp | Header file for the Intrepid::HGRAD_HEX_Cn_FEM class |
Intrepid_HGRAD_HEX_Cn_FEMDef.hpp | Definition file for the Intrepid::HGRAD_HEX_Cn_FEM class |
Intrepid_HGRAD_HEX_I2_FEM.hpp | Header file for the Intrepid::HGRAD_HEX_I2_FEM class |
Intrepid_HGRAD_HEX_I2_FEMDef.hpp | Definition file for the serendipity-family H(grad)-compatible FEM basis of degree 2 on a Hexadedron |
Intrepid_HGRAD_LINE_C1_FEM.hpp | Header file for the Intrepid::HGRAD_LINE_C1_FEM class |
Intrepid_HGRAD_LINE_C1_FEMDef.hpp | Definition file for FEM basis functions of degree 1 for H(grad) functions on a Line |
Intrepid_HGRAD_LINE_Cn_FEM.hpp | |
Intrepid_HGRAD_LINE_Cn_FEM_JACOBI.hpp | Header file for the Intrepid::HGRAD_LINE_Cn_FEM class |
Intrepid_HGRAD_LINE_Cn_FEM_JACOBIDef.hpp | Definition file for FEM basis functions of degree n for H(grad) orthogonal on LINE |
Intrepid_HGRAD_LINE_Cn_FEMDef.hpp | |
Intrepid_HGRAD_LINE_Hermite_FEM.hpp | Header file for the Intrepid::HGRAD_LINE_Hermite_FEM class |
Intrepid_HGRAD_LINE_Hermite_FEMDef.hpp | Definition file for Hermite FEM basis functions of degree 2n for H(grad) functions on a Line |
Intrepid_HGRAD_POLY_C1_FEM.hpp | Header file for the Intrepid::HGRAD_POLY_C1_FEM class |
Intrepid_HGRAD_POLY_C1_FEMDef.hpp | |
Intrepid_HGRAD_PYR_C1_FEM.hpp | |
Intrepid_HGRAD_PYR_C1_FEMDef.hpp | Definition file for linear FEM basis functions for H(grad) functions on PYR cells |
Intrepid_HGRAD_PYR_I2_FEM.hpp | Header file for the Intrepid::HGRAD_PYR_I2_FEM class |
Intrepid_HGRAD_PYR_I2_FEMDef.hpp | Definition file for an incomplete bi-quadratic FEM basis function for H(grad) functions on PYRAMID cells |
Intrepid_HGRAD_QUAD_C1_FEM.hpp | |
Intrepid_HGRAD_QUAD_C1_FEMDef.hpp | Definition file for bi-linear FEM basis functions for H(grad) functions on QUAD cells |
Intrepid_HGRAD_QUAD_C2_FEM.hpp | |
Intrepid_HGRAD_QUAD_C2_FEMDef.hpp | Definition file for bi-linear FEM basis functions for H(grad) functions on QUAD cells |
Intrepid_HGRAD_QUAD_Cn_FEM.hpp | Header file for the Intrepid::HGRAD_QUAD_Cn_FEM class |
Intrepid_HGRAD_QUAD_Cn_FEMDef.hpp | Definition file for the Intrepid::HGRAD_QUAD_Cn_FEM class |
Intrepid_HGRAD_TET_C1_FEM.hpp | |
Intrepid_HGRAD_TET_C1_FEMDef.hpp | Definition file for linear FEM basis functions for H(grad) functions on TET cells |
Intrepid_HGRAD_TET_C2_FEM.hpp | Header file for the Intrepid::HGRAD_TET_C2_FEM class |
Intrepid_HGRAD_TET_C2_FEMDef.hpp | Definition file for the default H(grad)-compatible FEM basis of degree 2 on Tetrahedron cell |
Intrepid_HGRAD_TET_Cn_FEM.hpp | Header file for the Intrepid::HGRAD_TET_Cn_FEM class |
Intrepid_HGRAD_TET_Cn_FEM_ORTH.hpp | |
Intrepid_HGRAD_TET_Cn_FEM_ORTHDef.hpp | Definition file for FEM orthogonal basis functions of arbitrary degree for H(grad) functions on TET |
Intrepid_HGRAD_TET_Cn_FEMDef.hpp | |
Intrepid_HGRAD_TET_COMP12_FEM.hpp | Header file for the Intrepid::HGRAD_TET_COMP12_FEM class |
Intrepid_HGRAD_TET_COMP12_FEMDef.hpp | Definition file for the composite H(grad)-compatible FEM basis of degree 1 on Tetrahedron cell with 12 sub-tetrahedrons |
Intrepid_HGRAD_TRI_C1_FEM.hpp | Header file for the Intrepid::HGRAD_TRI_C1_FEM class |
Intrepid_HGRAD_TRI_C1_FEMDef.hpp | |
Intrepid_HGRAD_TRI_C2_FEM.hpp | Header file for the Intrepid::HGRAD_TRI_C2_FEM class |
Intrepid_HGRAD_TRI_C2_FEMDef.hpp | |
Intrepid_HGRAD_TRI_Cn_FEM.hpp | Header file for the Intrepid::HGRAD_TRI_Cn_FEM class |
Intrepid_HGRAD_TRI_Cn_FEM_ORTH.hpp | |
Intrepid_HGRAD_TRI_Cn_FEM_ORTHDef.hpp | Definition file for FEM orthogonal basis functions of arbitrary degree for H(grad) functions on TRI |
Intrepid_HGRAD_TRI_Cn_FEMDef.hpp | |
Intrepid_HGRAD_WEDGE_C1_FEM.hpp | |
Intrepid_HGRAD_WEDGE_C1_FEMDef.hpp | Definition file for linear FEM basis functions for H(grad) functions on WEDGE cells |
Intrepid_HGRAD_WEDGE_C2_FEM.hpp | Header file for the Intrepid::G_WEDGE_C2_FEM class |
Intrepid_HGRAD_WEDGE_C2_FEMDef.hpp | Definition file for bi-quadratic FEM basis functions for H(grad) functions on WEDGE cells |
Intrepid_HGRAD_WEDGE_I2_FEM.hpp | Header file for the Intrepid::HGRAD_WEDGE_I2_FEM class |
Intrepid_HGRAD_WEDGE_I2_FEMDef.hpp | Definition file for an incomplete bi-quadratic FEM basis function for H(grad) functions on WEDGE cells |
Intrepid_OrthogonalBases.hpp | Header file for orthogonal bases on various cell types |
Intrepid_OrthogonalBasesDef.hpp | |
Intrepid_ProductTopology.hpp | Header file for utility class to take Cartesion products, of cell topologies. Currently just for products of lines |
Intrepid_ProductTopologyDef.hpp | Implementation file for products of lines |
Intrepid_TensorBasis.hpp | |
FunctionSpaceTools | |
Intrepid_FunctionSpaceTools.hpp | Header file for the Intrepid::FunctionSpaceTools class |
Intrepid_FunctionSpaceToolsDef.hpp | Definition file for the Intrepid::FunctionSpaceTools class |
Intrepid_FunctionSpaceToolsInPlace.hpp | Header file for the Intrepid::FunctionSpaceToolsInPlace class |
Intrepid_FunctionSpaceToolsInPlaceDef.hpp | Definition file for the Intrepid::FunctionSpaceToolsInPlace class |
Integration | |
Intrepid_AdaptiveSparseGrid.hpp | Header file for the Intrepid::AdaptiveSparseGrid class |
Intrepid_AdaptiveSparseGridDef.hpp | Definition file for the Intrepid::AdaptiveSparseGrid class |
Intrepid_AdaptiveSparseGridInterface.hpp | Header file for the Intrepid::AdaptiveSparseGridInterface class |
Intrepid_AdaptiveSparseGridInterfaceDef.hpp | Definition file for the Intrepid::AdaptiveSparseGridInterface class |
Intrepid_Cubature.hpp | Header file for the Intrepid::Cubature class |
Intrepid_CubatureCompositeTet.hpp | |
Intrepid_CubatureCompositeTetDef.hpp | Definition file for the Intrepid::CubatureCompositeTet class |
Intrepid_CubatureControlVolume.hpp | Header file for the Intrepid::CubatureControlVolume class |
Intrepid_CubatureControlVolumeBoundary.hpp | Header file for the Intrepid::CubatureControlVolumeBoundary class |
Intrepid_CubatureControlVolumeBoundaryDef.hpp | Definition file for the Intrepid::CubatureControlVolumeBoundary class |
Intrepid_CubatureControlVolumeDef.hpp | |
Intrepid_CubatureControlVolumeSide.hpp | Header file for the Intrepid::CubatureControlVolumeSide class |
Intrepid_CubatureControlVolumeSideDef.hpp | |
Intrepid_CubatureDirect.hpp | Header file for the Intrepid::CubatureDirect class |
Intrepid_CubatureDirectDef.hpp | Definition file for the Intrepid::CubatureDirect class |
Intrepid_CubatureDirectLineGauss.hpp | Header file for the Intrepid::CubatureDirectLineGauss class |
Intrepid_CubatureDirectLineGaussDef.hpp | Definition file for the Intrepid::CubatureDirectLineGauss class |
Intrepid_CubatureDirectLineGaussJacobi20.hpp | Header file for the Intrepid::CubatureDirectLineGaussJacobi20 class |
Intrepid_CubatureDirectLineGaussJacobi20Def.hpp | Definition file for the Intrepid::CubatureDirectLineGaussJacobi20 class |
Intrepid_CubatureDirectTetDefault.hpp | Header file for the Intrepid::CubatureDirectTetDefault class |
Intrepid_CubatureDirectTetDefaultDef.hpp | Definition file for the Intrepid::CubatureDirectTetDefault class |
Intrepid_CubatureDirectTriDefault.hpp | Header file for the Intrepid::CubatureDirectTriDefault class |
Intrepid_CubatureDirectTriDefaultDef.hpp | Definition file for the Intrepid::CubatureDirectTriDefault class |
Intrepid_CubatureGenSparse.hpp | Header file for the Intrepid::CubatureGenSparse class |
Intrepid_CubatureGenSparseDef.hpp | Definition file for the Intrepid::CubatureGenSparse class |
Intrepid_CubatureLineSorted.hpp | Header file for the Intrepid::CubatureLineSorted class |
Intrepid_CubatureLineSortedDef.hpp | Definition file for the Intrepid::CubatureLineSorted class |
Intrepid_CubaturePolygon.hpp | |
Intrepid_CubaturePolygonDef.hpp | Definition file for the Intrepid::CubaturePolygon class |
Intrepid_CubaturePolylib.hpp | Header file for the Intrepid::CubaturePolylib class |
Intrepid_CubaturePolylibDef.hpp | Definition file for the Intrepid::CubaturePolylib class |
Intrepid_CubatureSparse.hpp | Header file for the Intrepid::CubatureSparse class |
Intrepid_CubatureSparseDef.hpp | Definition file for the Intrepid::CubatureSparse class |
Intrepid_CubatureSparseHelper.hpp | |
Intrepid_CubatureTensor.hpp | Header file for the Intrepid::CubatureTensor class |
Intrepid_CubatureTensorDef.hpp | Definition file for the Intrepid::CubatureTensor class |
Intrepid_CubatureTensorPyr.hpp | Header file for the Intrepid::CubatureTensorPyr class |
Intrepid_CubatureTensorPyrDef.hpp | Definition file for the Intrepid::CubatureTensorPyr class |
Intrepid_CubatureTensorSorted.hpp | Header file for the Intrepid::CubatureTensorSorted class |
Intrepid_CubatureTensorSortedDef.hpp | Definition file for the Intrepid::CubatureTensorSorted class |
Intrepid_DefaultCubatureFactory.hpp | Header file for the abstract base class Intrepid::DefaultCubatureFactory |
Intrepid_DefaultCubatureFactoryDef.hpp | Definition file for the class Intrepid::DefaultCubatureFactory |
TensorProductSpaceTools | |
Intrepid_TensorProductSpaceTools.hpp | Header file for the Intrepid::TensorProductSpaceTools class |
Intrepid_TensorProductSpaceToolsDef.hpp | Definition file for the Intrepid::TensorProductSpaceTools class |
Shared | |
Intrepid_ArrayTools.hpp | Header file for utility class to provide array tools, such as tensor contractions, etc |
Intrepid_ArrayToolsDefCloneScale.hpp | Definition file for clone / scale operations of the array tools interface |
Intrepid_ArrayToolsDefContractions.hpp | Definition file for contraction (integration) operations of the array tools class |
Intrepid_ArrayToolsDefDot.hpp | Definition file for dot-multiply operations of the array tools interface |
Intrepid_ArrayToolsDefScalar.hpp | Definition file for scalar multiply operations of the array tools interface |
Intrepid_ArrayToolsDefTensor.hpp | Definition file for tensor multiply operations of the array tools interface |
Intrepid_ArrayToolsDefTensorTEMP.hpp | |
Intrepid_BurkardtRules.hpp | Header file for integration rules provided by John Burkardt. <> |
Intrepid_BurkardtRulesDef.hpp | Definition file for integration rules provided by John Burkardt. <> |
Intrepid_FieldContainer.hpp | Header file for utility class to provide multidimensional containers |
Intrepid_FieldContainerDef.hpp | Definition file for utility class to provide multidimensional containers |
Intrepid_PointTools.hpp | Header file for utility class to provide point tools, such as barycentric coordinates, equispaced lattices, and warp-blend point distrubtions |
Intrepid_PointToolsDef.hpp | Definition file for utilities for barycentric coordinates and lattices |
Intrepid_Polylib.hpp | Header file for a set of functions providing orthogonal polynomial polynomial calculus and interpolation |
Intrepid_PolylibDef.hpp | Definition file for a set of functions providing orthogonal polynomial polynomial calculus and interpolation |
Intrepid_Rank.hpp | |
Intrepid_RealSpaceTools.hpp | Header file for classes providing basic linear algebra functionality in 1D, 2D and 3D |
Intrepid_RealSpaceToolsDef.hpp | Definition file for utility classes providing basic linear algebra functionality |
Intrepid_Types.hpp | Contains definitions of custom data types in Intrepid |
Intrepid_Utils.cpp | Implementation file for Intrepid_Utils.hpp |
Intrepid_Utils.hpp | Intrepid utilities |
test | |
Cell | |
test_01.cpp | Test of the CellTools class |
test_02.cpp | Test of the CellTools class |
test_03.cpp | Test of the CellTools class |
Discretization | |
Basis | |
HCURL_HEX_I1_FEM | |
test_01.cpp | |
HCURL_HEX_In_FEM | |
test_01.cpp | |
test_02.cpp | |
HCURL_QUAD_I1_FEM | |
test_01.cpp | |
HCURL_QUAD_In_FEM | |
test_01.cpp | |
HCURL_TET_I1_FEM | |
test_01.cpp | |
HCURL_TET_In_FEM | |
test_01.cpp | Unit test of Nedelec class for tetrahedra |
test_02.cpp | |
test_03.cpp | |
HCURL_TRI_I1_FEM | |
test_01.cpp | |
HCURL_TRI_In_FEM | |
test_01.cpp | Unit test of Nedelec class for triangles |
HCURL_WEDGE_I1_FEM | |
test_01.cpp | |
HDIV_HEX_I1_FEM | |
test_01.cpp | |
HDIV_HEX_In_FEM | |
test_01.cpp | |
test_02.cpp | |
HDIV_QUAD_I1_FEM | |
test_01.cpp | |
HDIV_QUAD_In_FEM | |
test_01.cpp | |
test_02.cpp | |
HDIV_TET_I1_FEM | |
test_01.cpp | |
HDIV_TET_In_FEM | |
test_01.cpp | Unit test of Raviart-Thomas class for tetrahedra |
test_02.cpp | |
HDIV_TRI_I1_FEM | |
test_01.cpp | |
HDIV_TRI_In_FEM | |
test_01.cpp | Unit test of Raviart-Thomas class for triangles |
test_02.cpp | |
HDIV_WEDGE_I1_FEM | |
test_01.cpp | |
HGRAD_HEX_C1_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_HEX_C2_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_HEX_Cn_FEM | |
testdata | |
maked.py | |
test_01.cpp | |
test_02.cpp | |
HGRAD_HEX_I2_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_LINE_C1_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_LINE_Cn_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_LINE_Cn_FEM_JACOBI | |
test_01.cpp | |
test_02.cpp | |
HGRAD_LINE_Hermite_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_PYR_C1_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_PYR_I2_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_QUAD_C1_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_QUAD_C2_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_QUAD_Cn_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_TET_C1_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_TET_C2_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_TET_Cn_FEM | |
test_01.cpp | Unit test of Lagrange basis class |
test_02.cpp | |
HGRAD_TET_Cn_FEM_ORTH | |
test_01.cpp | Unit test of orthogonal tetrahedral polynomial basis class |
test_02.cpp | |
HGRAD_TET_COMP12_FEM | |
test_01.cpp | |
HGRAD_TRI_C1_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_TRI_C2_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_TRI_Cn_FEM | |
test_01.cpp | Unit test of Lagrange basis class |
test_02.cpp | |
HGRAD_TRI_Cn_FEM_ORTH | |
test_01.cpp | Unit test of Dubiner basis class |
test_02.cpp | |
HGRAD_WEDGE_C1_FEM | |
test_01.cpp | |
test_02.cpp | |
HGRAD_WEDGE_C2_FEM | |
test_01.cpp | |
HGRAD_WEDGE_I2_FEM | |
test_01.cpp | |
test_02.cpp | |
OrthogonalBases | |
test_01.cpp | Unit test of orthogonal bases. Outdated and unused |
test_02.cpp | Unit test of OrthogonalBases class |
FunctionSpaceTools | |
test_01.cpp | |
test_02.cpp | |
test_03.cpp | |
test_04.cpp | |
test_05.cpp | |
test_06.cpp | |
Integration | |
test_01.cpp | Unit test (CubatureDirect,CubatureTensor): correctness of volume computations for reference cells |
test_02.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_03.cpp | Unit test (CubatureDirect,CubatureTensor,DefaultCubatureFactory): correctness of integration of monomials for 2D reference cells |
test_04.cpp | Unit test (CubatureDirect,CubatureTensor,DefaultCubatureFactory): correctness of integration of monomials for 3D reference cells |
test_05.cpp | Unit test (CubatureDirect,CubatureTensor,DefaultCubatureFactory): correctness of integration of monomials for 3D reference cells |
test_06.cpp | Unit test (CubatureDirect,CubatureTensor,DefaultCubatureFactory): correctness of integration of monomials for 3D reference cells |
test_07.cpp | Unit test (CubatureSparse): correctness of integration of monomials for 2D reference cells |
test_08.cpp | Unit test (CubatureSparse): correctness of integration of monomials for 3D reference cells |
test_09.cpp | Unit test (CubatureGenSparse): correctness of integration of monomials for 3D reference cells |
test_10.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_11.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_12.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_13.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_14.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_15.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_16.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_17.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_18.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_19.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_20.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_21.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_22.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_23.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_24.cpp | Unit test (CubatureDirect): correctness of integration of monomials for 1D reference cells |
test_25.cpp | Unit test (CubatureControlVolume, CubatureControlVolumeSide, CubatureContorlVolumeBoundary): correctness of values |
TensorProductSpaceTools | |
test_01.cpp | |
test_02.cpp | |
Shared | |
ArrayTools | |
test_01.cpp | |
test_02.cpp | |
test_03.cpp | |
test_04.cpp | |
test_05.cpp | |
FieldContainer | |
test_01.cpp | |
test_02.cpp | |
test_03.cpp | |
IntrepidBurkardtRules | |
test_01.cpp | |
IntrepidPolylib | |
test_01.cpp | |
PointTools | |
test_01.cpp | |
RealSpaceTools | |
test_01.cpp | |