Hermes2D
2.0
|
Namespace containing definitions specific for Hermes2D. More...
Namespaces | |
namespace | Mixins |
Namespace for mixin classes. These classes always serve one particular purpose that multiple classes of the Hermes2D library could use - setting of spaces, output of linear algebraic structures, ... | |
namespace | RefinementSelectors |
Namespace which encapsulates all refinement selectors. | |
namespace | Views |
Namespace containing Views classes, Linearizer classes, and support for these. | |
Classes | |
class | Global |
Class for global functions. More... | |
class | Adapt |
Evaluation of an error between a (coarse) solution and a reference solution and adaptivity. More... | |
class | InterfaceEstimatorScalingFunction |
Functor representing the interface estimator scaling function. More... | |
class | ScaleByElementDiameter |
Pre-defined function used for scaling interface error estimates (see the KellyTypeAdapt constructor). More... | |
class | KellyTypeAdapt |
A framework for explicit aposteriori error estimators. More... | |
class | BasicKellyAdapt |
Simple Kelly-estimator based adaptivity for elliptic problems. More... | |
class | Space |
Represents a finite element space over a domain. More... | |
class | Solution |
Represents the solution of a PDE. More... | |
class | Api2D |
API Class containing settings for the whole Hermes2D. More... | |
class | AsmList |
class | ExactSolutionScalar |
class | ExactSolutionVector |
class | EssentialBCs |
class | EssentialBoundaryCondition |
class | DefaultEssentialBCConst |
Class representing constant essential boundary condition. More... | |
class | DefaultEssentialBCNonConst |
class | DefaultEssentialBCNonConstHcurl |
class | CalculationContinuityException |
Own exception class to catch all potential exceptions that might occur in saving / loading entities using the subsequent classes. More... | |
class | IOCalculationContinuityException |
A derived exception for I/O. More... | |
class | CalculationContinuity |
class | NeighborNode |
class | DiscreteProblem |
class | DiscreteProblemLinear |
class | OGProjection |
Class for (global) orthogonal projecting. If the projection is not necessary (if a solution belongs to the space), then its solution vector is used. More... | |
class | Func |
class | DiscontinuousFunc |
This class represents a function with jump discontinuity on an interface of two elements. More... | |
class | Geom |
class | InterfaceGeom |
class | ExactSolution |
Represents an exact solution of a PDE. More... | |
class | ConstantSolution |
class | ZeroSolution |
class | ConstantSolutionVector |
class | ZeroSolutionVector |
class | Filter |
class | SimpleFilter |
class | ComplexFilter |
class | DXDYFilter |
class | DXFilter |
Calculates the magnitude of a vector function. More... | |
class | MagFilter |
Calculates the magnitude of a vector function. More... | |
class | TopValFilter |
class | BottomValFilter |
class | ValFilter |
class | DiffFilter |
class | SumFilter |
class | SquareFilter |
class | AbsFilter |
class | RealFilter |
class | ImagFilter |
class | ComplexAbsFilter |
class | AngleFilter |
class | VonMisesFilter |
Calculates the Von Mises stress. More... | |
class | LinearFilter |
class | Function |
Represents an arbitrary function defined on an element. More... | |
class | MeshFunction |
Represents a function defined on a mesh. More... | |
struct | Trf |
2D transformation. More... | |
class | Transformable |
class | WeakForm |
Represents the weak formulation of a PDE problem. More... | |
class | Graph |
class | SimpleGraph |
class | MatlabGraph |
class | GnuplotGraph |
class | PNGGraph |
class | MatrixFormVolHCurl |
class | MatrixFormVolL2 |
class | LinearSolver |
struct | Nurbs |
Represents one NURBS curve. More... | |
class | CurvMap |
class | ElementToRefine |
A refinement record. More... | |
class | HashTable |
Stores and searches node tables. More... | |
struct | Node |
Stores one node of a mesh. More... | |
class | Element |
Stores one element of a mesh. More... | |
class | Mesh |
Represents a finite element mesh. Typical usage: Hermes::Hermes2D::Mesh mesh; Hermes::Hermes2D::MeshReaderH2DXML mloader; try { mloader.load("mesh.xml", &mesh); } catch(Exceptions::MeshLoadFailureException& e) { e.print_msg(); return -1; }. More... | |
class | MeshData |
Class to stored 2d mesh parameters. The MeshData class organizes all the necessary data structures required to store information in the input mesh file. All variables are stored internally as a mapping between strings and a list of strings. Symbolic expressions are not supported for variables. The variables are stored in a vector of strings. This is true for single-valued variables, lists and list of lists. The contents of the variables are thus accessed differently depending on their contents. More... | |
class | MeshReader |
class | MeshReaderExodusII |
class | MeshReaderH1DXML |
class | MeshReaderH2D |
class | MeshReaderH2DXML |
class | RefMap |
Represents the reference mapping. More... | |
struct | SurfPos |
Determines the position on an element surface (edge in 2D and Face in 3D). More... | |
struct | UniData |
struct | Rect |
class | Traverse |
class | NeighborSearch |
This class characterizes a neighborhood of a given edge in terms of adjacent elements and provides methods for getting limit values of discontinuous functions from both sides of the edge. More... | |
class | NewtonSolver |
class | PicardSolver |
class | LocalProjection |
class | Quad1D |
class | Quad2D |
class | Quad1DStd |
1D quadrature points on the standard reference domain (-1,1) More... | |
class | Quad2DStd |
2D quadrature points on the standard reference domains (-1,1)^2 More... | |
class | PrecalcShapeset |
Caches precalculated shape function values. More... | |
class | Shapeset |
Defines a set of shape functions. More... | |
class | H1ShapesetOrtho |
class | H1ShapesetJacobi |
class | HcurlShapesetLegendre |
class | HcurlShapesetGradLeg |
class | HdivShapesetLegendre |
class | L2ShapesetLegendre |
class | L2Space |
class | H1Space |
class | HcurlSpace |
class | HdivSpace |
class | CubicSpline |
class | RungeKutta |
class | Form |
Abstract, base class for any form - i.e. integral in the weak formulation of (a system of) PDE By default, the form is initialized with the following natural attributes: More... | |
class | MatrixFormVol |
Abstract, base class for matrix Volumetric form - i.e. MatrixForm, where the integration is with respect to 2D-Lebesgue measure (elements). More... | |
class | VectorFormVol |
Abstract, base class for vector Volumetric form - i.e. VectorForm, where the integration is with respect to 2D-Lebesgue measure (elements). More... | |
class | MatrixFormSurf |
Abstract, base class for matrix Surface form - i.e. MatrixForm, where the integration is with respect to 1D-Lebesgue measure (element domain-boundary edges). More... | |
class | VectorFormSurf |
Abstract, base class for vector Surface form - i.e. VectorForm, where the integration is with respect to 1D-Lebesgue measure (element domain-boundary edges). More... | |
class | MatrixFormDG |
Abstract, base class for matrix DG form - i.e. MatrixForm, where the integration is with respect to 1D-Lebesgue measure (element inner-domain edges). More... | |
class | VectorFormDG |
Abstract, base class for vector DG form - i.e. VectorForm, where the integration is with respect to 1D-Lebesgue measure (element inner-domain edges). More... | |
class | MatrixForm |
Abstract, base class for matrix form - i.e. a single integral in the bilinear form on the left hand side of the variational formulation of a (system of) PDE. By default, the matrix form is initialized with the following natural attribute: More... | |
class | VectorForm |
Abstract, base class for vector form - i.e. a single integral in the linear form on the right hand side of the variational formulation of a (system of) PDE. More... | |
class | Quad2DCheb |
struct | mono_lu_init |
struct | Vertex |
struct | VCompare |
Typedefs | |
typedef H1ShapesetJacobi | H1Shapeset |
This is the default shapeset typedef. More... | |
typedef HcurlShapesetGradLeg | HcurlShapeset |
This is the default Hcurl shapeset typedef. | |
typedef HdivShapesetLegendre | HdivShapeset |
This is the default Hdiv shapeset typedef. | |
typedef L2ShapesetLegendre | L2Shapeset |
This is the default shapeset typedef. | |
Enumerations | |
enum | Hermes2DApiParam { numThreads, xmlSchemasDirPath, precalculatedFormsDirPath } |
Enumeration of potential keys in the Api2D::parameters storage. | |
enum | { H2D_FN_VAL_0 = 0x0001, H2D_FN_VAL_1 = 0x0040, H2D_FN_DX_0 = 0x0002, H2D_FN_DX_1 = 0x0080, H2D_FN_DY_0 = 0x0004, H2D_FN_DY_1 = 0x0100, H2D_FN_DXX_0 = 0x0008, H2D_FN_DXX_1 = 0x0200, H2D_FN_DYY_0 = 0x0010, H2D_FN_DYY_1 = 0x0400, H2D_FN_DXY_0 = 0x0020, H2D_FN_DXY_1 = 0x0800 } |
Precalculation masks. | |
enum | SolutionType { HERMES_UNDEF = -1, HERMES_SLN = 0, HERMES_EXACT = 1 } |
enum | ProjNormType { HERMES_L2_NORM, HERMES_H1_NORM, HERMES_H1_SEMINORM, HERMES_HCURL_NORM, HERMES_HDIV_NORM, HERMES_UNSET_NORM } |
enum | ElementMode2D { HERMES_MODE_TRIANGLE = 0, HERMES_MODE_QUAD = 1 } |
enum | { HERMES_TYPE_VERTEX = 0, HERMES_TYPE_EDGE = 1 } |
enum | GIP2DIndices { H2D_GIP2D_X = 0, H2D_GIP2D_Y = 1, H2D_GIP2D_W = 2 } |
Indices of values in the value returned by Quad2D::get_points(). More... | |
enum | FunctionExpansionIndex { H2D_FEI_VALUE = 0, H2D_FEI_DX = 1, H2D_FEI_DY = 2, H2D_FEI_DXX = 3, H2D_FEI_DYY = 4, H2D_FEI_DXY = 5 } |
Index of a function expansion. Used to selected a value in Shapeset::get_value(). More... | |
enum | SpaceType { HERMES_H1_SPACE = 0, HERMES_HCURL_SPACE = 1, HERMES_HDIV_SPACE = 2, HERMES_L2_SPACE = 3, HERMES_INVALID_SPACE = -9999 } |
enum | GeomType { HERMES_PLANAR = 0, HERMES_AXISYM_X = 1, HERMES_AXISYM_Y = 2 } |
Geometrical type of weak forms. | |
enum | SymFlag { HERMES_ANTISYM = -1, HERMES_NONSYM = 0, HERMES_SYM = 1 } |
Bilinear form symmetry flag, see WeakForm::add_matrix_form. | |
Functions | |
HERMES_API Geom< Hermes::Ord > * | init_geom_ord () |
Init element geometry for calculating the integration order. | |
HERMES_API Geom< double > * | init_geom_vol (RefMap *rm, const int order) |
Init element geometry for volumetric integrals. | |
HERMES_API Geom< double > * | init_geom_surf (RefMap *rm, int isurf, int marker, const int order, double3 *&tan) |
Init element geometry for surface integrals. | |
HERMES_API Func< Hermes::Ord > * | init_fn_ord (const int order) |
Init the function for calculation the integration order. | |
HERMES_API Func< double > * | init_fn (PrecalcShapeset *fu, RefMap *rm, const int order) |
Init the shape function for the evaluation of the volumetric/surface integral (transformation of values). | |
template<typename Scalar > | |
HERMES_API Func< Scalar > * | init_fn (MeshFunction< Scalar > *fu, const int order) |
Init the mesh-function for the evaluation of the volumetric/surface integral. | |
template<typename Scalar > | |
HERMES_API Func< Scalar > * | init_fn (Solution< Scalar > *fu, const int order) |
Init the solution for the evaluation of the volumetric/surface integral. | |
template<typename Real > | |
Real | int_v (int n, double *wt, Func< Real > *v) |
template<typename Real > | |
Real | int_x_v (int n, double *wt, Func< Real > *v, Geom< Real > *e) |
template<typename Real > | |
Real | int_y_v (int n, double *wt, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_u_v (int n, double *wt, Func< Real > *u, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_u_ext_v (int n, double *wt, Func< Scalar > *u_ext, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_x_u_v (int n, double *wt, Func< Real > *u, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_x_u_ext_v (int n, double *wt, Func< Scalar > *u_ext, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_y_u_v (int n, double *wt, Func< Real > *u, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_y_u_ext_v (int n, double *wt, Func< Scalar > *u_ext, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_F_v (int n, double *wt, Real(*F)(Real x, Real y), Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_grad_u_grad_v (int n, double *wt, Func< Real > *u, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_grad_u_ext_grad_v (int n, double *wt, Func< Scalar > *u_ext, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_x_grad_u_grad_v (int n, double *wt, Func< Real > *u, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_x_grad_u_ext_grad_v (int n, double *wt, Func< Scalar > *u_ext, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_y_grad_u_grad_v (int n, double *wt, Func< Real > *u, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_y_grad_u_ext_grad_v (int n, double *wt, Func< Scalar > *u_ext, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_dudx_v (int n, double *wt, Func< Real > *u, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_dudy_v (int n, double *wt, Func< Real > *u, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_u_dvdx (int n, double *wt, Func< Real > *u, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_u_dvdx_over_x (int n, double *wt, Func< Real > *u, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_u_ext_dvdx_over_x (int n, double *wt, Func< Scalar > *u_ext, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_u_dvdy (int n, double *wt, Func< Real > *u, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_u_dvdy_over_y (int n, double *wt, Func< Real > *u, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_u_ext_dvdy_over_y (int n, double *wt, Func< Scalar > *u_ext, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_dudx_dvdx (int n, double *wt, Func< Real > *u, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_dudy_dvdy (int n, double *wt, Func< Real > *u, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_dudx_dvdy (int n, double *wt, Func< Real > *u, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_dudy_dvdx (int n, double *wt, Func< Real > *u, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_w_nabla_u_v (int n, double *wt, Func< Real > *w1, Func< Real > *w2, Func< Real > *u, Func< Real > *v) |
template<typename Scalar > | |
double | int_h1_error (Function< Scalar > *fu, Function< Scalar > *fv, RefMap *ru, RefMap *rv) |
template<typename Scalar > | |
double | int_h1_semi_error (Function< Scalar > *fu, Function< Scalar > *fv, RefMap *ru, RefMap *rv) |
template<typename Scalar > | |
double | int_l2_error (Function< Scalar > *fu, Function< Scalar > *fv, RefMap *ru, RefMap *rv) |
template<typename Scalar > | |
double | int_dx_error (Function< Scalar > *fu, Function< Scalar > *fv, RefMap *ru, RefMap *rv) |
template<typename Scalar > | |
double | int_dy_error (Function< Scalar > *fu, Function< Scalar > *fv, RefMap *ru, RefMap *rv) |
template<typename Scalar > | |
double | int_h1_norm (Function< Scalar > *fu, RefMap *ru) |
template<typename Scalar > | |
double | int_h1_seminorm (Function< Scalar > *fu, RefMap *ru) |
template<typename Scalar > | |
double | int_l2_norm (Function< Scalar > *fu, RefMap *ru) |
template<typename Real , typename Scalar > | |
Scalar | int_e_f (int n, double *wt, Func< Real > *u, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_curl_e_curl_f (int n, double *wt, Func< Real > *u, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_v0 (int n, double *wt, Func< Scalar > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_v1 (int n, double *wt, Func< Real > *v) |
template<typename Real , typename Scalar > | |
Scalar | int_F_e_f (int n, double *wt, double(*F)(int marker, Real x, Real y), Func< Real > *u, Func< Real > *v, Geom< Real > *e) |
template<typename Real , typename Scalar > | |
Scalar | int_e_tau_f_tau (int n, double *wt, Func< Real > *u, Func< Real > *v, Geom< Real > *e) |
template<typename T > | |
T | int_g_h (Function< T > *fg, Function< T > *fh, RefMap *rg, RefMap *rh) |
HERMES_API void | set_order_limit_table (int *tri_table, int *quad_table, int n) |
can be called to set a custom order limiting table | |
HERMES_API void | reset_warn_order () |
Resets warn order flag. | |
HERMES_API void | warn_order () |
Warns about integration order iff ward order flags it not set. Sets warn order flag. More... | |
HERMES_API void | update_limit_table (ElementMode2D mode) |
HERMES_API void | limit_order (int &o, ElementMode2D mode) |
HERMES_API void | limit_order_nowarn (int &o, ElementMode2D mode) |
template<typename Scalar > | |
Func< Scalar > * | init_fn (MeshFunction< Scalar > *fu, const int order) |
Init the mesh-function for the evaluation of the volumetric/surface integral. | |
template<typename Scalar > | |
Func< Scalar > * | init_fn (Solution< Scalar > *fu, const int order) |
Init the solution for the evaluation of the volumetric/surface integral. | |
template Func< double > * | init_fn (MeshFunction< double > *fu, const int order) |
template Func< std::complex < double > > * | init_fn (MeshFunction< std::complex< double > > *fu, const int order) |
template HERMES_API Func < double > * | init_fn (Solution< double > *fu, const int order) |
template HERMES_API Func < std::complex< double > > * | init_fn (Solution< std::complex< double > > *fu, const int order) |
CurvMap * | create_son_curv_map (Element *e, int son) |
int | rtb_criterion (Element *e) |
template<typename Scalar > | |
void | calculate_anderson_coeffs (Scalar **previous_vectors, Scalar *anderson_coeffs, int num_last_vectors_used, int ndof) |
Variables | |
HERMES_API Hermes::Hermes2D::Api2D | Hermes2DApi |
Global instance used inside Hermes which is also accessible to users. | |
const int | H2D_FN_VAL = H2D_FN_VAL_0 | H2D_FN_VAL_1 |
Both components are usually requested together... | |
const int | H2D_FN_DX = H2D_FN_DX_0 | H2D_FN_DX_1 |
const int | H2D_FN_DY = H2D_FN_DY_0 | H2D_FN_DY_1 |
const int | H2D_FN_DXX = H2D_FN_DXX_0 | H2D_FN_DXX_1 |
const int | H2D_FN_DYY = H2D_FN_DYY_0 | H2D_FN_DYY_1 |
const int | H2D_FN_DXY = H2D_FN_DXY_0 | H2D_FN_DXY_1 |
const int | H2D_FN_DEFAULT = H2D_FN_VAL | H2D_FN_DX | H2D_FN_DY |
default precalculation mask | |
const int | H2D_FN_ALL = H2D_FN_DEFAULT | H2D_FN_DXX | H2D_FN_DYY | H2D_FN_DXY |
precalculate everything | |
const int | H2D_FN_COMPONENT_0 = H2D_FN_VAL_0 | H2D_FN_DX_0 | H2D_FN_DY_0 | H2D_FN_DXX_0 | H2D_FN_DYY_0 | H2D_FN_DXY_0 |
const int | H2D_FN_COMPONENT_1 = H2D_FN_VAL_1 | H2D_FN_DX_1 | H2D_FN_DY_1 | H2D_FN_DXX_1 | H2D_FN_DYY_1 | H2D_FN_DXY_1 |
HERMES_API Trf | tri_trf [H2D_TRF_NUM] |
A table of triangle sub-subdomain transforms. Only first ::H2D_TRF_TRI_NUM transformations are valid, the rest are identity transformation. More... | |
HERMES_API Trf | quad_trf [H2D_TRF_NUM] |
A table of quad sub-subdomain transforms. Only first ::H2D_TRF_QUAD_NUM transformations are valid, the rest are identity transformation. More... | |
const int | H2D_ORDER_BITS = 5 |
How many bits the encoded_order number takes. | |
const int | H2D_ORDER_MASK = (1 << H2D_ORDER_BITS) - 1 |
unsigned | g_mesh_seq = 0 |
const int | TOP_LEVEL_REF = 123456 |
HERMES_API int | g_safe_max_order |
limit_order is used in integrals | |
HERMES_API int | g_max_order |
const int | g_max_quad = 24 |
const int | g_max_tri = 20 |
HERMES_API Quad1DStd | g_quad_1d_std |
HERMES_API Quad2DStd | g_quad_2d_std |
template HERMES_API class | Adapt< double > |
template HERMES_API class | KellyTypeAdapt< double > |
template HERMES_API class | BasicKellyAdapt< double > |
template HERMES_API class | AsmList< double > |
template HERMES_API class | EssentialBoundaryCondition< double > |
template HERMES_API class | DefaultEssentialBCConst< double > |
template HERMES_API class | DefaultEssentialBCNonConst< double > |
template HERMES_API class | EssentialBCs< double > |
template class HERMES_API | CalculationContinuity< double > |
template class HERMES_API | DiscreteProblem< double > |
template class HERMES_API | DiscreteProblemLinear< double > |
template class HERMES_API | Func< double > |
template class HERMES_API | DiscontinuousFunc< double > |
template class HERMES_API | Geom< double > |
template class HERMES_API | InterfaceGeom< double > |
template HERMES_API class | ExactSolutionScalar< double > |
template HERMES_API class | ExactSolutionVector< double > |
template HERMES_API class | ConstantSolution< double > |
template HERMES_API class | ConstantSolutionVector< double > |
template HERMES_API class | ZeroSolution< double > |
template HERMES_API class | ZeroSolutionVector< double > |
template class HERMES_API | Filter< double > |
template class HERMES_API | SimpleFilter< double > |
template class HERMES_API | DXDYFilter< double > |
template class HERMES_API | DXFilter< double > |
template class HERMES_API | MagFilter< double > |
template class HERMES_API | DiffFilter< double > |
template class HERMES_API | SumFilter< double > |
template class HERMES_API | SquareFilter< double > |
template class HERMES_API | Function< double > |
template class HERMES_API | MeshFunction< double > |
template class HERMES_API | Solution< double > |
template class HERMES_API | Global< double > |
template class HERMES_API | LinearSolver< double > |
template class HERMES_API | NeighborSearch< double > |
template class HERMES_API | NewtonSolver< double > |
template class HERMES_API | PicardSolver< double > |
template class HERMES_API | LocalProjection< double > |
template class HERMES_API | OGProjection< double > |
template class HERMES_API | RungeKutta< double > |
PrecalcShapeset | ref_map_pss |
unsigned | g_space_seq = 0 |
template class HERMES_API | Space< double > |
template HERMES_API class | H1Space< double > |
template class HERMES_API | HcurlSpace< double > |
template HERMES_API class | HdivSpace< double > |
template HERMES_API class | L2Space< double > |
template class HERMES_API | WeakForm< double > |
template class HERMES_API | Form< double > |
template class HERMES_API | MatrixForm< double > |
template class HERMES_API | MatrixFormVol< double > |
template class HERMES_API | MatrixFormSurf< double > |
template class HERMES_API | MatrixFormDG< double > |
template class HERMES_API | VectorForm< double > |
template class HERMES_API | VectorFormVol< double > |
template class HERMES_API | VectorFormSurf< double > |
template class HERMES_API | VectorFormDG< double > |
Namespace containing definitions specific for Hermes2D.
Index of a function expansion. Used to selected a value in Shapeset::get_value().
Enumerator | |
---|---|
H2D_FEI_VALUE |
Index of a function value f. |
H2D_FEI_DX |
Index of df/dx. |
H2D_FEI_DY |
Index of df/dy. |
H2D_FEI_DXX |
Index of df/dxdx. |
H2D_FEI_DYY |
Index of df/dydy. |
H2D_FEI_DXY |
Index of df/dxdy. |
Definition at line 25 of file shapeset.h.
HERMES_API void Hermes::Hermes2D::warn_order | ( | ) |
Warns about integration order iff ward order flags it not set. Sets warn order flag.
Definition at line 65 of file limit_order.cpp.
Trf Hermes::Hermes2D::quad_trf |
A table of quad sub-subdomain transforms. Only first ::H2D_TRF_QUAD_NUM transformations are valid, the rest are identity transformation.
Definition at line 37 of file transformable.cpp.
Referenced by Hermes::Hermes2D::RefinementSelectors::ProjBasedSelector< Scalar >::calc_projection_errors(), and Hermes::Hermes2D::Transformable::push_transform().
Trf Hermes::Hermes2D::tri_trf |
A table of triangle sub-subdomain transforms. Only first ::H2D_TRF_TRI_NUM transformations are valid, the rest are identity transformation.
Definition at line 24 of file transformable.cpp.
Referenced by Hermes::Hermes2D::RefinementSelectors::ProjBasedSelector< Scalar >::calc_projection_errors(), and Hermes::Hermes2D::Transformable::push_transform().