Quadrature formula on triangles. More...
#include <Galeri_TriangleQuadrature.h>
Public Member Functions | |
TriangleQuadrature (const int NumQuadrNodes) | |
Constructor. More... | |
~TriangleQuadrature () | |
Deastructor. | |
void | ComputeJacobian (const int QuadrNode, const double *x_triangle, const double *y_triangle, const double *z_triangle) const |
Computes the Jacobian at the specified quadrature node. | |
void | ComputeQuadrNodes (const int ii, const double *x, const double *y, const double *z, double &xq, double &yq, double &zq) const |
Maps the quadrature nodes from the reference element to the actual one. | |
void | ComputeDerivatives (const int QuadrNode) const |
Computes the derivatives at the specified quadrature node. | |
double | QuadrWeight (const int QuadrNode) const |
Computes the weight at the specified quadrature node. | |
double | DetJacobian (const int QuadrNode) const |
Computes the determinant of the Jacobian matrix at the quadrature node. | |
double | Phi (const int i) const |
Returns the value of the i-th basis function on the reference element. | |
double | PhiX (const int i) const |
Returns the value of the x-derivative i-th basis function on the reference element. | |
double | PhiY (const int i) const |
Returns the value of the y-derivative i-th basis function on the reference element. | |
double | PhiZ (const int i) const |
Returns the value of the z-derivative i-th basis function on the reference element. | |
double | Psi (const int i) const |
Returns the value of the i-th test function on the reference element. | |
double | PsiX (const int i) const |
Returns the value of the z-derivative i-th test function on the reference element. | |
double | PsiY (const int i) const |
Returns the value of the y-derivative i-th test function on the reference element. | |
double | PsiZ (const int i) const |
Returns the value of the z-derivative i-th test function on the reference element. | |
int | NumQuadrNodes () const |
Returns the number of quadrature node per element. | |
int | NumPhiFunctions () const |
Returns the number of basis function on the reference element. | |
int | NumPsiFunctions () const |
Returns the number of test function on the reference element. | |
Public Member Functions inherited from Galeri::FiniteElements::AbstractQuadrature | |
virtual | ~AbstractQuadrature () |
Destructor. | |
Quadrature formula on triangles.
|
inline |
Constructor.
NumQuadrNodes | - (In) Number of quadrature nodes per element. Valid choices are: 1, 3, 4, 7. |
References NumQuadrNodes().