Galeri Development
Loading...
Searching...
No Matches
Public Member Functions | List of all members
Galeri::FiniteElements::AbstractQuadrature Class Referenceabstract

Interfaces for quadrature over elements. More...

#include <Galeri_AbstractQuadrature.h>

Inheritance diagram for Galeri::FiniteElements::AbstractQuadrature:
Inheritance graph
[legend]

Public Member Functions

virtual ~AbstractQuadrature ()
 Destructor.
 
virtual int NumQuadrNodes () const =0
 Returns the number of quadrature node per element.
 
virtual int NumPhiFunctions () const =0
 Returns the number of basis function on the reference element.
 
virtual int NumPsiFunctions () const =0
 Returns the number of test function on the reference element.
 
virtual void ComputeJacobian (const int QuadrNode, const double *x, const double *y, const double *z) const =0
 Computes the Jacobian at the specified quadrature node.
 
virtual void ComputeQuadrNodes (const int QuadrNode, const double *x, const double *y, const double *z, double &xq, double &yq, double &zq) const =0
 Maps the quadrature nodes from the reference element to the actual one.
 
virtual void ComputeDerivatives (const int QuadrNode) const =0
 Computes the derivatives at the specified quadrature node.
 
virtual double QuadrWeight (const int QuadrNode) const =0
 Computes the weight at the specified quadrature node.
 
virtual double DetJacobian (const int QuadrNode) const =0
 Computes the determinant of the Jacobian matrix at the quadrature node.
 
virtual double Phi (const int i) const =0
 Returns the value of the i-th basis function on the reference element.
 
virtual double PhiX (const int i) const =0
 Returns the value of the x-derivative i-th basis function on the reference element.
 
virtual double PhiY (const int i) const =0
 Returns the value of the y-derivative i-th basis function on the reference element.
 
virtual double PhiZ (const int i) const =0
 Returns the value of the z-derivative i-th basis function on the reference element.
 
virtual double Psi (const int i) const =0
 Returns the value of the i-th test function on the reference element.
 
virtual double PsiX (const int i) const =0
 Returns the value of the z-derivative i-th test function on the reference element.
 
virtual double PsiY (const int i) const =0
 Returns the value of the y-derivative i-th test function on the reference element.
 
virtual double PsiZ (const int i) const =0
 Returns the value of the z-derivative i-th test function on the reference element.
 

Detailed Description

Interfaces for quadrature over elements.

AbstractQuadrature is a pure virtual class that defines a set of abstract interfaces to basis and test functions (and their derivatives), and also furnishes all the tools required to numerically integrate over an element.

Author
Marzio Sala, SNL 9214.
Date
Last updated on Apr-05.

Member Function Documentation

◆ ComputeDerivatives()

virtual void Galeri::FiniteElements::AbstractQuadrature::ComputeDerivatives ( const int  QuadrNode) const
pure virtual

◆ ComputeJacobian()

virtual void Galeri::FiniteElements::AbstractQuadrature::ComputeJacobian ( const int  QuadrNode,
const double *  x,
const double *  y,
const double *  z 
) const
pure virtual

◆ ComputeQuadrNodes()

virtual void Galeri::FiniteElements::AbstractQuadrature::ComputeQuadrNodes ( const int  QuadrNode,
const double *  x,
const double *  y,
const double *  z,
double &  xq,
double &  yq,
double &  zq 
) const
pure virtual

◆ DetJacobian()

virtual double Galeri::FiniteElements::AbstractQuadrature::DetJacobian ( const int  QuadrNode) const
pure virtual

◆ NumPhiFunctions()

virtual int Galeri::FiniteElements::AbstractQuadrature::NumPhiFunctions ( ) const
pure virtual

◆ NumPsiFunctions()

virtual int Galeri::FiniteElements::AbstractQuadrature::NumPsiFunctions ( ) const
pure virtual

◆ NumQuadrNodes()

virtual int Galeri::FiniteElements::AbstractQuadrature::NumQuadrNodes ( ) const
pure virtual

◆ Phi()

virtual double Galeri::FiniteElements::AbstractQuadrature::Phi ( const int  i) const
pure virtual

◆ PhiX()

virtual double Galeri::FiniteElements::AbstractQuadrature::PhiX ( const int  i) const
pure virtual

Returns the value of the x-derivative i-th basis function on the reference element.

Implemented in Galeri::FiniteElements::HexQuadrature, Galeri::FiniteElements::QuadQuadrature, Galeri::FiniteElements::TetQuadrature, and Galeri::FiniteElements::TriangleQuadrature.

◆ PhiY()

virtual double Galeri::FiniteElements::AbstractQuadrature::PhiY ( const int  i) const
pure virtual

Returns the value of the y-derivative i-th basis function on the reference element.

Implemented in Galeri::FiniteElements::HexQuadrature, Galeri::FiniteElements::QuadQuadrature, Galeri::FiniteElements::TetQuadrature, and Galeri::FiniteElements::TriangleQuadrature.

◆ PhiZ()

virtual double Galeri::FiniteElements::AbstractQuadrature::PhiZ ( const int  i) const
pure virtual

Returns the value of the z-derivative i-th basis function on the reference element.

Implemented in Galeri::FiniteElements::HexQuadrature, Galeri::FiniteElements::QuadQuadrature, Galeri::FiniteElements::TetQuadrature, and Galeri::FiniteElements::TriangleQuadrature.

◆ Psi()

virtual double Galeri::FiniteElements::AbstractQuadrature::Psi ( const int  i) const
pure virtual

◆ PsiX()

virtual double Galeri::FiniteElements::AbstractQuadrature::PsiX ( const int  i) const
pure virtual

Returns the value of the z-derivative i-th test function on the reference element.

Implemented in Galeri::FiniteElements::HexQuadrature, Galeri::FiniteElements::QuadQuadrature, Galeri::FiniteElements::TetQuadrature, and Galeri::FiniteElements::TriangleQuadrature.

◆ PsiY()

virtual double Galeri::FiniteElements::AbstractQuadrature::PsiY ( const int  i) const
pure virtual

Returns the value of the y-derivative i-th test function on the reference element.

Implemented in Galeri::FiniteElements::HexQuadrature, Galeri::FiniteElements::QuadQuadrature, Galeri::FiniteElements::TetQuadrature, and Galeri::FiniteElements::TriangleQuadrature.

◆ PsiZ()

virtual double Galeri::FiniteElements::AbstractQuadrature::PsiZ ( const int  i) const
pure virtual

Returns the value of the z-derivative i-th test function on the reference element.

Implemented in Galeri::FiniteElements::HexQuadrature, Galeri::FiniteElements::QuadQuadrature, Galeri::FiniteElements::TetQuadrature, and Galeri::FiniteElements::TriangleQuadrature.

◆ QuadrWeight()

virtual double Galeri::FiniteElements::AbstractQuadrature::QuadrWeight ( const int  QuadrNode) const
pure virtual

The documentation for this class was generated from the following file: