Galeri  Development
 All Classes Files Functions Variables Pages
Public Member Functions | List of all members
Galeri::FiniteElements::GalerkinVariational< T > Class Template Reference

Defines a pure Galerkin variational form of a scalar PDE. More...

#include <Galeri_GalerkinVariational.h>

Inheritance diagram for Galeri::FiniteElements::GalerkinVariational< T >:
Inheritance graph
[legend]
Collaboration diagram for Galeri::FiniteElements::GalerkinVariational< T >:
Collaboration graph
[legend]

Public Member Functions

 GalerkinVariational (const int NumQuadratureNodes, double(*diff)(const double &, const double &, const double &), double(*source)(const double &, const double &, const double &), double(*force)(const double &, const double &, const double &), double(*bc)(const double &, const double &, const double &, const int &), int(*bc_type)(const int &))
 Constructor.
 
 ~GalerkinVariational ()
 Destructor.
 
double diff (const double x, const double y, const double z) const
 Evaluates the diffusion coefficient at point (x, y, z).
 
double source (const double x, const double y, const double z) const
 Evaluates the source term at point (x, y, z).
 
double force (const double x, const double y, const double z) const
 Evaluates the force term at point (x, y, z).
 
virtual int IntegrateOverElement (const AbstractVariational &Variational, const double *x, const double *y, const double *z, const double *data, double *ElementMatrix, double *ElementRHS) const
 Integrates the variational form and the right-hand side.
 
virtual int ElementNorm (const double *LocalSol, const double *x, const double *y, const double *z, double *Norm) const
 Computes the norm of the numerical solution over an element.
 
virtual int ElementNorm (int(*ExactSolution)(double, double, double, double *), const double *x, const double *y, const double *z, double *Norm) const
 Computes the norm of the exact solution over an element.
 
virtual int ElementNorm (const double *LocalSol, int(*ExactSolution)(double, double, double, double *), const double *x, const double *y, const double *z, double *Norm) const
 Computes the norm of the error over an element.
 
double LHS (const double Phi, const double Psi, const double PhiX, const double PsiX, const double PhiY, const double PsiY, const double PhiZ, const double PsiZ, const double x, const double y, const double z) const
 Evaluates the left-hand side at point (x, y, z).
 
double RHS (const double Psi, const double PsiX, const double PsiY, const double PsiZ, const double x, const double y, const double z) const
 Evaluates the right-hand side at point (x, y, z).
 
int BC (const int PatchID) const
 Returns the boundary condition type of the specified patch.
 
double BC (const double x, const double y, const double z, const int PatchID) const
 Returns the value of the boundary condition at point (x, y, z).
 
- Public Member Functions inherited from Galeri::FiniteElements::AbstractVariational
virtual ~AbstractVariational ()
 Destructor.
 

Detailed Description

template<class T>
class Galeri::FiniteElements::GalerkinVariational< T >

Defines a pure Galerkin variational form of a scalar PDE.

This class defines a pure Galerkin variational form of a second order, symmetric scalar PDE, discretized using Lagrange finite elements. The class is templated with an AbstractQuadrature class, which will be used to specify the quadrature formula, and the values of test and basis functions at the quadrature node. The constructor requires function pointers, that specify the values of the coefficients.

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

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