Public Types | Public Member Functions | Static Public Attributes | Protected Member Functions | Protected Attributes | Static Protected Attributes | Private Attributes | List of all members
oomph::FiniteElement Class Referenceabstract

A general Finite Element class. More...

#include <elements.h>

+ Inheritance diagram for oomph::FiniteElement:

Public Types

typedef void(* SteadyExactSolutionFctPt) (const Vector< double > &, Vector< double > &)
 Function pointer for function that computes vector-valued steady "exact solution" $ {\bf f}({\bf x}) $ as $ \mbox{\tt fct}({\bf x}, {\bf f}) $. More...
 
typedef void(* UnsteadyExactSolutionFctPt) (const double &, const Vector< double > &, Vector< double > &)
 Function pointer for function that computes Vector-valued time-dependent function $ {\bf f}(t,{\bf x}) $ as $ \mbox{\tt fct}(t, {\bf x}, {\bf f}) $. More...
 

Public Member Functions

void set_dimension (const unsigned &dim)
 Set the dimension of the element and initially set the dimension of the nodes to be the same as the dimension of the element. More...
 
void set_nodal_dimension (const unsigned &nodal_dim)
 Set the dimension of the nodes in the element. This will typically only be required when constructing FaceElements or in beam and shell type elements where a lower dimensional surface is embedded in a higher dimensional space. More...
 
void set_nnodal_position_type (const unsigned &nposition_type)
 Set the number of types required to interpolate the coordinate. More...
 
void set_n_node (const unsigned &n)
 Set the number of nodes in the element to n, by resizing the storage for pointers to the Node objects. More...
 
int nodal_local_eqn (const unsigned &n, const unsigned &i) const
 Return the local equation number corresponding to the i-th value at the n-th local node. More...
 
double dJ_eulerian_at_knot (const unsigned &ipt, Shape &psi, DenseMatrix< double > &djacobian_dX) const
 Compute the geometric shape functions (psi) at integration point ipt. Return the determinant of the jacobian of the mapping (detJ). Additionally calculate the derivatives of "detJ" w.r.t. the nodal coordinates. More...
 
 FiniteElement ()
 Constructor. More...
 
virtual ~FiniteElement ()
 The destructor cleans up the static memory allocated for shape function storage. Internal and external data get wiped by the GeneralisedElement destructor; nodes get killed in mesh destructor. More...
 
 FiniteElement (const FiniteElement &)=delete
 Broken copy constructor. More...
 
virtual bool local_coord_is_valid (const Vector< double > &s)
 Broken assignment operator. More...
 
virtual void move_local_coord_back_into_element (Vector< double > &s) const
 Adjust local coordinates so that they're located inside the element. More...
 
void get_centre_of_gravity_and_max_radius_in_terms_of_zeta (Vector< double > &cog, double &max_radius) const
 Compute centre of gravity of all nodes and radius of node that is furthest from it. Used to assess approximately if a point is likely to be contained with an element in locate_zeta-like operations. More...
 
virtual void local_coordinate_of_node (const unsigned &j, Vector< double > &s) const
 Get local coordinates of node j in the element; vector sets its own size (broken virtual) More...
 
virtual void local_fraction_of_node (const unsigned &j, Vector< double > &s_fraction)
 Get the local fraction of the node j in the element A dumb, but correct default implementation is provided. More...
 
virtual double local_one_d_fraction_of_node (const unsigned &n1d, const unsigned &i)
 Get the local fraction of any node in the n-th position in a one dimensional expansion along the i-th local coordinate. More...
 
virtual void set_macro_elem_pt (MacroElement *macro_elem_pt)
 Set pointer to macro element – can be overloaded in derived elements to perform additional tasks. More...
 
MacroElementmacro_elem_pt ()
 Access function to pointer to macro element. More...
 
void get_x (const Vector< double > &s, Vector< double > &x) const
 Global coordinates as function of local coordinates. Either via FE representation or via macro-element (if Macro_elem_pt!=0) More...
 
void get_x (const unsigned &t, const Vector< double > &s, Vector< double > &x)
 Global coordinates as function of local coordinates at previous time "level" t (t=0: present; t>0: previous). Either via FE representation of QElement or via macro-element (if Macro_elem_pt!=0). More...
 
virtual void get_x_from_macro_element (const Vector< double > &s, Vector< double > &x) const
 Global coordinates as function of local coordinates using macro element representation. (Broken virtual — this must be overloaded in specific geometric element classes) More...
 
virtual void get_x_from_macro_element (const unsigned &t, const Vector< double > &s, Vector< double > &x)
 Global coordinates as function of local coordinates at previous time "level" t (t=0: present; t>0: previous). using macro element representation (Broken virtual – overload in specific geometric element class if you want to use this functionality.) More...
 
virtual void set_integration_scheme (Integral *const &integral_pt)
 Set the spatial integration scheme. More...
 
Integral *const & integral_pt () const
 Return the pointer to the integration scheme (const version) More...
 
virtual void shape (const Vector< double > &s, Shape &psi) const =0
 Calculate the geometric shape functions at local coordinate s. This function must be overloaded for each specific geometric element. More...
 
virtual void shape_at_knot (const unsigned &ipt, Shape &psi) const
 Return the geometric shape function at the ipt-th integration point. More...
 
virtual void dshape_local (const Vector< double > &s, Shape &psi, DShape &dpsids) const
 Function to compute the geometric shape functions and derivatives w.r.t. local coordinates at local coordinate s. This function must be overloaded for each specific geometric element. (Broken virtual function — specifies the interface) More...
 
virtual void dshape_local_at_knot (const unsigned &ipt, Shape &psi, DShape &dpsids) const
 Return the geometric shape function and its derivative w.r.t. the local coordinates at the ipt-th integration point. More...
 
virtual void d2shape_local (const Vector< double > &s, Shape &psi, DShape &dpsids, DShape &d2psids) const
 Function to compute the geometric shape functions and also first and second derivatives w.r.t. local coordinates at local coordinate s. This function must be overloaded for each specific geometric element (if required). (Broken virtual function — specifies the interface). Numbering: 1D: d2psids(i,0) = $ d^2 \psi_j / ds^2 $ 2D: d2psids(i,0) = $ \partial^2 \psi_j / \partial s_0^2 $ d2psids(i,1) = $ \partial^2 \psi_j / \partial s_1^2 $ d2psids(i,2) = $ \partial^2 \psi_j / \partial s_0 \partial s_1 $ 3D: d2psids(i,0) = $ \partial^2 \psi_j / \partial s_0^2 $ d2psids(i,1) = $ \partial^2 \psi_j / \partial s_1^2 $ d2psids(i,2) = $ \partial^2 \psi_j / \partial s_2^2 $ d2psids(i,3) = $ \partial^2 \psi_j / \partial s_0 \partial s_1 $ d2psids(i,4) = $ \partial^2 \psi_j / \partial s_0 \partial s_2 $ d2psids(i,5) = $ \partial^2 \psi_j / \partial s_1 \partial s_2 $. More...
 
virtual void d2shape_local_at_knot (const unsigned &ipt, Shape &psi, DShape &dpsids, DShape &d2psids) const
 Return the geometric shape function and its first and second derivatives w.r.t. the local coordinates at the ipt-th integration point. Numbering: 1D: d2psids(i,0) = $ d^2 \psi_j / ds^2 $ 2D: d2psids(i,0) = $ \partial^2 \psi_j / \partial s_0^2 $ d2psids(i,1) = $ \partial^2 \psi_j / \partial s_1^2 $ d2psids(i,2) = $ \partial^2 \psi_j / \partial s_0 \partial s_1 $ 3D: d2psids(i,0) = $ \partial^2 \psi_j / \partial s_0^2 $ d2psids(i,1) = $ \partial^2 \psi_j / \partial s_1^2 $ d2psids(i,2) = $ \partial^2 \psi_j / \partial s_2^2 $ d2psids(i,3) = $ \partial^2 \psi_j / \partial s_0 \partial s_1 $ d2psids(i,4) = $ \partial^2 \psi_j / \partial s_0 \partial s_2 $ d2psids(i,5) = $ \partial^2 \psi_j / \partial s_1 \partial s_2 $. More...
 
virtual double J_eulerian (const Vector< double > &s) const
 Return the Jacobian of mapping from local to global coordinates at local position s. More...
 
virtual double J_eulerian_at_knot (const unsigned &ipt) const
 Return the Jacobian of the mapping from local to global coordinates at the ipt-th integration point. More...
 
void check_J_eulerian_at_knots (bool &passed) const
 Check that Jacobian of mapping between local and Eulerian coordinates at all integration points is positive. More...
 
void check_jacobian (const double &jacobian) const
 Helper function used to check for singular or negative Jacobians in the transform from local to global or Lagrangian coordinates. More...
 
double dshape_eulerian (const Vector< double > &s, Shape &psi, DShape &dpsidx) const
 Compute the geometric shape functions and also first derivatives w.r.t. global coordinates at local coordinate s; Returns Jacobian of mapping from global to local coordinates. More...
 
virtual double dshape_eulerian_at_knot (const unsigned &ipt, Shape &psi, DShape &dpsidx) const
 Return the geometric shape functions and also first derivatives w.r.t. global coordinates at the ipt-th integration point. More...
 
virtual double dshape_eulerian_at_knot (const unsigned &ipt, Shape &psi, DShape &dpsi, DenseMatrix< double > &djacobian_dX, RankFourTensor< double > &d_dpsidx_dX) const
 Compute the geometric shape functions (psi) and first derivatives w.r.t. global coordinates (dpsidx) at the ipt-th integration point. Return the determinant of the jacobian of the mapping (detJ). Additionally calculate the derivatives of both "detJ" and "dpsidx" w.r.t. the nodal coordinates. More...
 
double d2shape_eulerian (const Vector< double > &s, Shape &psi, DShape &dpsidx, DShape &d2psidx) const
 Compute the geometric shape functions and also first and second derivatives w.r.t. global coordinates at local coordinate s; Returns Jacobian of mapping from global to local coordinates. Numbering: 1D: d2psidx(i,0) = $ d^2 \psi_j / d x^2 $ 2D: d2psidx(i,0) = $ \partial^2 \psi_j / \partial x_0^2 $ d2psidx(i,1) = $ \partial^2 \psi_j / \partial x_1^2 $ d2psidx(i,2) = $ \partial^2 \psi_j / \partial x_0 \partial x_1 $ 3D: d2psidx(i,0) = $ \partial^2 \psi_j / \partial x_0^2 $ d2psidx(i,1) = $ \partial^2 \psi_j / \partial x_1^2 $ d2psidx(i,2) = $ \partial^2 \psi_j / \partial x_2^2 $ d2psidx(i,3) = $ \partial^2 \psi_j / \partial x_0 \partial x_1 $ d2psidx(i,4) = $ \partial^2 \psi_j / \partial x_0 \partial x_2 $ d2psidx(i,5) = $ \partial^2 \psi_j / \partial x_1 \partial x_2 $. More...
 
virtual double d2shape_eulerian_at_knot (const unsigned &ipt, Shape &psi, DShape &dpsidx, DShape &d2psidx) const
 Return the geometric shape functions and also first and second derivatives w.r.t. global coordinates at ipt-th integration point. Numbering: 1D: d2psidx(i,0) = $ d^2 \psi_j / d s^2 $ 2D: d2psidx(i,0) = $ \partial^2 \psi_j / \partial x_0^2 $ d2psidx(i,1) = $ \partial^2 \psi_j / \partial x_1^2 $ d2psidx(i,2) = $ \partial^2 \psi_j / \partial x_0 \partial x_1 $ 3D: d2psidx(i,0) = $ \partial^2 \psi_j / \partial x_0^2 $ d2psidx(i,1) = $ \partial^2 \psi_j / \partial x_1^2 $ d2psidx(i,2) = $ \partial^2 \psi_j / \partial x_2^2 $ d2psidx(i,3) = $ \partial^2 \psi_j / \partial x_0 \partial x_1 $ d2psidx(i,4) = $ \partial^2 \psi_j / \partial x_0 \partial x_2 $ d2psidx(i,5) = $ \partial^2 \psi_j / \partial x_1 \partial x_2 $. More...
 
virtual void assign_nodal_local_eqn_numbers (const bool &store_local_dof_pt)
 Assign the local equation numbers for Data stored at the nodes Virtual so that it can be overloaded by RefineableFiniteElements. If the boolean is true then the pointers to the degrees of freedom associated with each equation number are stored in Dof_pt. More...
 
virtual void describe_local_dofs (std::ostream &out, const std::string &current_string) const
 Function to describe the local dofs of the element[s]. The ostream specifies the output stream to which the description is written; the string stores the currently assembled output that is ultimately written to the output stream by Data::describe_dofs(...); it is typically built up incrementally as we descend through the call hierarchy of this function when called from Problem::describe_dofs(...) More...
 
virtual void describe_nodal_local_dofs (std::ostream &out, const std::string &current_string) const
 Function to describe the local dofs of the element[s]. The ostream specifies the output stream to which the description is written; the string stores the currently assembled output that is ultimately written to the output stream by Data::describe_dofs(...); it is typically built up incrementally as we descend through the call hierarchy of this function when called from Problem::describe_dofs(...) More...
 
virtual void assign_all_generic_local_eqn_numbers (const bool &store_local_dof_pt)
 Overloaded version of the calculation of the local equation numbers. If the boolean argument is true then pointers to the degrees of freedom associated with each equation number are stored locally in the array Dof_pt. More...
 
Node *& node_pt (const unsigned &n)
 Return a pointer to the local node n. More...
 
Node *const & node_pt (const unsigned &n) const
 Return a pointer to the local node n (const version) More...
 
unsigned nnode () const
 Return the number of nodes. More...
 
virtual unsigned nnode_1d () const
 Return the number of nodes along one edge of the element Default is to return zero — must be overloaded by geometric elements. More...
 
double raw_nodal_position (const unsigned &n, const unsigned &i) const
 Return the i-th coordinate at local node n. Do not use the hanging node representation. NOTE: Moved to cc file because of a possible compiler bug in gcc (yes, really!). The move to the cc file avoids inlining which appears to cause problems (only) when compiled with gcc and -O3; offensive "illegal read" is in optimised-out section of code and data that is allegedly illegal is readily readable (by other means) just before this function is called so I can't really see how we could possibly be responsible for this... More...
 
double raw_nodal_position (const unsigned &t, const unsigned &n, const unsigned &i) const
 Return the i-th coordinate at local node n, at time level t (t=0: present; t>0: previous time level). Do not use the hanging node representation. More...
 
double raw_dnodal_position_dt (const unsigned &n, const unsigned &i) const
 Return the i-th component of nodal velocity: dx/dt at local node n. Do not use the hanging node representation. More...
 
double raw_dnodal_position_dt (const unsigned &n, const unsigned &j, const unsigned &i) const
 Return the i-th component of j-th derivative of nodal position: d^jx/dt^j at node n. Do not use the hanging node representation. More...
 
double raw_nodal_position_gen (const unsigned &n, const unsigned &k, const unsigned &i) const
 Return the value of the k-th type of the i-th positional variable at the local node n. Do not use the hanging node representation. More...
 
double raw_nodal_position_gen (const unsigned &t, const unsigned &n, const unsigned &k, const unsigned &i) const
 Return the generalised nodal position (type k, i-th variable) at previous timesteps at local node n. Do not use the hanging node representation. More...
 
double raw_dnodal_position_gen_dt (const unsigned &n, const unsigned &k, const unsigned &i) const
 i-th component of time derivative (velocity) of the generalised position, dx(k,i)/dt at local node n. ‘Type’: k; Coordinate direction: i. Do not use the hanging node representation. More...
 
double raw_dnodal_position_gen_dt (const unsigned &j, const unsigned &n, const unsigned &k, const unsigned &i) const
 i-th component of j-th time derivative of the generalised position, dx(k,i)/dt at local node n. ‘Type’: k; Coordinate direction: i. Do not use the hanging node representation. More...
 
double nodal_position (const unsigned &n, const unsigned &i) const
 Return the i-th coordinate at local node n. If the node is hanging, the appropriate interpolation is handled by the position function in the Node class. More...
 
double nodal_position (const unsigned &t, const unsigned &n, const unsigned &i) const
 Return the i-th coordinate at local node n, at time level t (t=0: present; t>0: previous time level) Returns suitably interpolated version for hanging nodes. More...
 
double dnodal_position_dt (const unsigned &n, const unsigned &i) const
 Return the i-th component of nodal velocity: dx/dt at local node n. More...
 
double dnodal_position_dt (const unsigned &n, const unsigned &j, const unsigned &i) const
 Return the i-th component of j-th derivative of nodal position: d^jx/dt^j at node n. More...
 
double nodal_position_gen (const unsigned &n, const unsigned &k, const unsigned &i) const
 Return the value of the k-th type of the i-th positional variable at the local node n. More...
 
double nodal_position_gen (const unsigned &t, const unsigned &n, const unsigned &k, const unsigned &i) const
 Return the generalised nodal position (type k, i-th variable) at previous timesteps at local node n. More...
 
double dnodal_position_gen_dt (const unsigned &n, const unsigned &k, const unsigned &i) const
 i-th component of time derivative (velocity) of the generalised position, dx(k,i)/dt at local node n. ‘Type’: k; Coordinate direction: i. More...
 
double dnodal_position_gen_dt (const unsigned &j, const unsigned &n, const unsigned &k, const unsigned &i) const
 i-th component of j-th time derivative of the generalised position, dx(k,i)/dt at local node n. ‘Type’: k; Coordinate direction: i. More...
 
virtual void get_dresidual_dnodal_coordinates (RankThreeTensor< double > &dresidual_dnodal_coordinates)
 Compute derivatives of elemental residual vector with respect to nodal coordinates. Default implementation by FD can be overwritten for specific elements. dresidual_dnodal_coordinates(l,i,j) = d res(l) / dX_{ij}. More...
 
virtual void disable_ALE ()
 This is an empty function that establishes a uniform interface for all (derived) elements that involve time-derivatives. Such elements are/should be implemented in ALE form to allow mesh motions. The additional expense associated with the computation of the mesh velocities is, of course, superfluous if the elements are used in problems in which the mesh is stationary. This function should therefore be overloaded in all derived elements that are formulated in ALE form to suppress the computation of the mesh velocities. The user disables the ALE functionality at his/her own risk! If the mesh does move after all, then the results will be wrong. Here we simply issue a warning message stating that the empty function has been called. More...
 
virtual void enable_ALE ()
 (Re-)enable ALE, i.e. take possible mesh motion into account when evaluating the time-derivative. This function is empty and simply establishes a common interface for all derived elements that are formulated in ALE form. More...
 
virtual unsigned required_nvalue (const unsigned &n) const
 Number of values that must be stored at local node n by the element. The default is 0, until over-ridden by a particular element. For example, a Poisson equation requires only one value to be stored at each node; 2D Navier–Stokes equations require two values (velocity components) to be stored at each Node (provided that the pressure interpolation is discontinuous). More...
 
unsigned nnodal_position_type () const
 Return the number of coordinate types that the element requires to interpolate the geometry between the nodes. For Lagrange elements it is 1. More...
 
bool has_hanging_nodes () const
 Return boolean to indicate if any of the element's nodes are geometrically hanging. More...
 
unsigned nodal_dimension () const
 Return the required Eulerian dimension of the nodes in this element. More...
 
virtual unsigned nvertex_node () const
 Return the number of vertex nodes in this element. Broken virtual function in "pure" finite elements. More...
 
virtual Nodevertex_node_pt (const unsigned &j) const
 Pointer to the j-th vertex node in the element. Broken virtual function in "pure" finite elements. More...
 
virtual Nodeconstruct_node (const unsigned &n)
 Construct the local node n and return a pointer to the newly created node object. More...
 
virtual Nodeconstruct_node (const unsigned &n, TimeStepper *const &time_stepper_pt)
 Construct the local node n, including storage for history values required by timestepper, and return a pointer to the newly created node object. More...
 
virtual Nodeconstruct_boundary_node (const unsigned &n)
 Construct the local node n as a boundary node; that is a node that MAY be placed on a mesh boundary and return a pointer to the newly created node object. More...
 
virtual Nodeconstruct_boundary_node (const unsigned &n, TimeStepper *const &time_stepper_pt)
 Construct the local node n, including storage for history values required by timestepper, as a boundary node; that is a node that MAY be placed on a mesh boundary and return a pointer to the newly created node object. More...
 
int get_node_number (Node *const &node_pt) const
 Return the number of the node *node_pt if this node is in the element, else return -1;. More...
 
virtual Nodeget_node_at_local_coordinate (const Vector< double > &s) const
 If there is a node at this local coordinate, return the pointer to the node. More...
 
double raw_nodal_value (const unsigned &n, const unsigned &i) const
 Return the i-th value stored at local node n but do NOT take hanging nodes into account. More...
 
double raw_nodal_value (const unsigned &t, const unsigned &n, const unsigned &i) const
 Return the i-th value stored at local node n, at time level t (t=0: present; t>0 previous timesteps), but do NOT take hanging nodes into account. More...
 
double nodal_value (const unsigned &n, const unsigned &i) const
 Return the i-th value stored at local node n. Produces suitably interpolated values for hanging nodes. More...
 
double nodal_value (const unsigned &t, const unsigned &n, const unsigned &i) const
 Return the i-th value stored at local node n, at time level t (t=0: present; t>0 previous timesteps). Produces suitably interpolated values for hanging nodes. More...
 
unsigned dim () const
 Return the spatial dimension of the element, i.e. the number of local coordinates required to parametrise its geometry. More...
 
virtual ElementGeometry::ElementGeometry element_geometry () const
 Return the geometry type of the element (either Q or T usually). More...
 
virtual double interpolated_x (const Vector< double > &s, const unsigned &i) const
 Return FE interpolated coordinate x[i] at local coordinate s. More...
 
virtual double interpolated_x (const unsigned &t, const Vector< double > &s, const unsigned &i) const
 Return FE interpolated coordinate x[i] at local coordinate s at previous timestep t (t=0: present; t>0: previous timestep) More...
 
virtual void interpolated_x (const Vector< double > &s, Vector< double > &x) const
 Return FE interpolated position x[] at local coordinate s as Vector. More...
 
virtual void interpolated_x (const unsigned &t, const Vector< double > &s, Vector< double > &x) const
 Return FE interpolated position x[] at local coordinate s at previous timestep t as Vector (t=0: present; t>0: previous timestep) More...
 
virtual double interpolated_dxdt (const Vector< double > &s, const unsigned &i, const unsigned &t)
 Return t-th time-derivative of the i-th FE-interpolated Eulerian coordinate at local coordinate s. More...
 
virtual void interpolated_dxdt (const Vector< double > &s, const unsigned &t, Vector< double > &dxdt)
 Compte t-th time-derivative of the FE-interpolated Eulerian coordinate vector at local coordinate s. More...
 
unsigned ngeom_data () const
 A standard FiniteElement is fixed, so there are no geometric data when viewed in its GeomObject incarnation. More...
 
Datageom_data_pt (const unsigned &j)
 A standard FiniteElement is fixed, so there are no geometric data when viewed in its GeomObject incarnation. More...
 
void position (const Vector< double > &zeta, Vector< double > &r) const
 Return the parametrised position of the FiniteElement in its incarnation as a GeomObject, r(zeta). The position is given by the Eulerian coordinate and the intrinsic coordinate (zeta) is the local coordinate of the element (s). More...
 
void position (const unsigned &t, const Vector< double > &zeta, Vector< double > &r) const
 Return the parametrised position of the FiniteElement in its GeomObject incarnation: r(zeta). The position is given by the Eulerian coordinate and the intrinsic coordinate (zeta) is the local coordinate of the element (s) This version of the function returns the position as a function of time t=0: current time; t>0: previous timestep. Works for t=0 but needs to be overloaded if genuine time-dependence is required. More...
 
void dposition_dt (const Vector< double > &zeta, const unsigned &t, Vector< double > &drdt)
 Return the t-th time derivative of the parametrised position of the FiniteElement in its GeomObject incarnation: $ \frac{d^{t} dr(zeta)}{d t^{t}} $. Call the t-th time derivative of the FE-interpolated Eulerian coordinate. More...
 
virtual double zeta_nodal (const unsigned &n, const unsigned &k, const unsigned &i) const
 Specify the values of the "global" intrinsic coordinate, zeta, of a compound geometric object (a mesh of elements) when the element is viewied as a sub-geometric object. The default assumption is that the element will be treated as a sub-geometric object in a bulk Mesh of other elements (geometric objects). The "global" coordinate of the compound geometric object is simply the Eulerian coordinate, x. The second default assumption is that the coordinate zeta will be stored at the nodes and interpolated using the shape functions of the element. This function returns the value of zeta stored at local node n, where k is the type of coordinate and i is the coordinate direction. The function is virtual so that it can be overloaded by different types of element: FaceElements and SolidFiniteElements. More...
 
void interpolated_zeta (const Vector< double > &s, Vector< double > &zeta) const
 Calculate the interpolated value of zeta, the intrinsic coordinate of the element when viewed as a compound geometric object within a Mesh as a function of the local coordinate of the element, s. The default assumption is the zeta is interpolated using the shape functions of the element with the values given by zeta_nodal(). A MacroElement representation of the intrinsic coordinate parametrised by the local coordinate s is used if available. Choosing the MacroElement representation of zeta (Eulerian x by default) allows a correspondence to be established between elements on different Meshes covering the same curvilinear domain in cases where one element is much coarser than the other. More...
 
void locate_zeta (const Vector< double > &zeta, GeomObject *&geom_object_pt, Vector< double > &s, const bool &use_coordinate_as_initial_guess=false)
 For a given value of zeta, the "global" intrinsic coordinate of a mesh of FiniteElements represented as a compound geometric object, find the local coordinate in this element that corresponds to the requested value of zeta. If zeta cannot be located in this element, geom_object_pt is set to NULL. If zeta is located in this element, we return its "this" pointer. By default don't use any value passed in to the local coordinate s as the initial guess in the Newton method. More...
 
virtual void node_update ()
 Update the positions of all nodes in the element using each node update function. The default implementation may be overloaded so that more efficient versions can be written. More...
 
virtual void identify_field_data_for_interactions (std::set< std::pair< Data *, unsigned >> &paired_field_data)
 The purpose of this function is to identify all possible Data that can affect the fields interpolated by the FiniteElement. The information will typically be used in interaction problems in which the FiniteElement provides a forcing term for an ElementWithExternalElement. The Data must be provided as paired_load data containing. More...
 
virtual void identify_geometric_data (std::set< Data * > &geometric_data_pt)
 The purpose of this function is to identify all Data objects that affect the elements' geometry. This function is implemented as an empty virtual function since it can only be implemented in conjunction with a node-update strategy. A specific implementation is provided in the ElementWithMovingNodes class. More...
 
virtual double s_min () const
 Min value of local coordinate. More...
 
virtual double s_max () const
 Max. value of local coordinate. More...
 
double size () const
 Calculate the size of the element (length, area, volume,...) in Eulerian computational coordinates. Use suitably overloaded compute_physical_size() function to compute the actual size (taking into account factors such as 2pi or radii the integrand) – such function can only be implemented on an equation-by-equation basis. More...
 
virtual double compute_physical_size () const
 Broken virtual function to compute the actual size (taking into account factors such as 2pi or radii the integrand) – such function can only be implemented on an equation-by-equation basis. More...
 
virtual void point_output_data (const Vector< double > &s, Vector< double > &data)
 Virtual function to write the double precision numbers that appear in a single line of output into the data vector. Empty virtual, can be overloaded for specific elements; used e.g. by LineVisualiser. More...
 
void point_output (std::ostream &outfile, const Vector< double > &s)
 Output solution (as defined by point_output_data()) at local cordinates s. More...
 
virtual unsigned nplot_points_paraview (const unsigned &nplot) const
 Return the number of actual plot points for paraview plot with parameter nplot. Broken virtual; can be overloaded in specific elements. More...
 
virtual unsigned nsub_elements_paraview (const unsigned &nplot) const
 Return the number of local sub-elements for paraview plot with parameter nplot. Broken virtual; can be overloaded in specific elements. More...
 
void output_paraview (std::ofstream &file_out, const unsigned &nplot) const
 Paraview output – this outputs the coordinates at the plot points (for parameter nplot) to specified output file. More...
 
virtual void write_paraview_output_offset_information (std::ofstream &file_out, const unsigned &nplot, unsigned &counter) const
 Fill in the offset information for paraview plot. Broken virtual. Needs to be implemented for each new geometric element type; see http://www.vtk.org/VTK/img/file-formats.pdf. More...
 
virtual void write_paraview_type (std::ofstream &file_out, const unsigned &nplot) const
 Return the paraview element type. Broken virtual. Needs to be implemented for each new geometric element type; see http://www.vtk.org/VTK/img/file-formats.pdf. More...
 
virtual void write_paraview_offsets (std::ofstream &file_out, const unsigned &nplot, unsigned &offset_sum) const
 Return the offsets for the paraview sub-elements. Broken virtual. Needs to be implemented for each new geometric element type; see http://www.vtk.org/VTK/img/file-formats.pdf. More...
 
virtual unsigned nscalar_paraview () const
 Number of scalars/fields output by this element. Broken virtual. Needs to be implemented for each new specific element type. More...
 
virtual void scalar_value_paraview (std::ofstream &file_out, const unsigned &i, const unsigned &nplot) const
 Write values of the i-th scalar field at the plot points. Broken virtual. Needs to be implemented for each new specific element type. More...
 
virtual void scalar_value_fct_paraview (std::ofstream &file_out, const unsigned &i, const unsigned &nplot, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt) const
 Write values of the i-th scalar field at the plot points. Broken virtual. Needs to be implemented for each new specific element type. More...
 
virtual void scalar_value_fct_paraview (std::ofstream &file_out, const unsigned &i, const unsigned &nplot, const double &time, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt) const
 Write values of the i-th scalar field at the plot points. Broken virtual. Needs to be implemented for each new specific element type. More...
 
virtual std::string scalar_name_paraview (const unsigned &i) const
 Name of the i-th scalar field. Default implementation returns V1 for the first one, V2 for the second etc. Can (should!) be overloaded with more meaningful names in specific elements. More...
 
virtual void output (std::ostream &outfile)
 Output the element data — typically the values at the nodes in a format suitable for post-processing. More...
 
virtual void output (std::ostream &outfile, const unsigned &n_plot)
 Output the element data — pass (some measure of) the number of plot points per element. More...
 
virtual void output (const unsigned &t, std::ostream &outfile, const unsigned &n_plot) const
 Output the element data at time step t. This is const because it is newly added and so can be done easily. Really all the output(...) functions should be const! More...
 
virtual void output (FILE *file_pt)
 Output the element data — typically the values at the nodes in a format suitable for post-processing. (C style output) More...
 
virtual void output (FILE *file_pt, const unsigned &n_plot)
 Output the element data — pass (some measure of) the number of plot points per element (C style output) More...
 
virtual void output_fct (std::ostream &outfile, const unsigned &n_plot, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt)
 Output an exact solution over the element. More...
 
virtual void output_fct (std::ostream &outfile, const unsigned &n_plot, const double &time, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt)
 Output a time-dependent exact solution over the element. More...
 
virtual void output_fct (std::ostream &outfile, const unsigned &n_plot, const double &time, const SolutionFunctorBase &exact_soln) const
 Output a time-dependent exact solution over the element. More...
 
virtual void get_s_plot (const unsigned &i, const unsigned &nplot, Vector< double > &s, const bool &shifted_to_interior=false) const
 Get cector of local coordinates of plot point i (when plotting nplot points in each "coordinate direction"). Generally these plot points will be uniformly spaced across the element. The optional final boolean flag (default: false) allows them to be shifted inwards to avoid duplication of plot point points between elements – useful when they are used in locate_zeta, say. More...
 
virtual std::string tecplot_zone_string (const unsigned &nplot) const
 Return string for tecplot zone header (when plotting nplot points in each "coordinate direction") More...
 
virtual void write_tecplot_zone_footer (std::ostream &outfile, const unsigned &nplot) const
 Add tecplot zone "footer" to output stream (when plotting nplot points in each "coordinate direction"). Empty by default – can be used, e.g., to add FE connectivity lists to elements that need it. More...
 
virtual void write_tecplot_zone_footer (FILE *file_pt, const unsigned &nplot) const
 Add tecplot zone "footer" to C-style output. (when plotting nplot points in each "coordinate direction"). Empty by default – can be used, e.g., to add FE connectivity lists to elements that need it. More...
 
virtual unsigned nplot_points (const unsigned &nplot) const
 Return total number of plot points (when plotting nplot points in each "coordinate direction") More...
 
virtual void compute_error (FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, double &error, double &norm)
 Calculate the norm of the error and that of the exact solution. More...
 
virtual void compute_error (FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, double &error, double &norm)
 Calculate the norm of the error and that of the exact solution. More...
 
virtual void compute_error (FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, Vector< double > &error, Vector< double > &norm)
 Given the exact solution $ {\bf f}({\bf x}) $ this function calculates the norm of the error and that of the exact solution. Version with vectors of norms and errors so that different variables' norms and errors can be returned individually. More...
 
virtual void compute_error (FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, Vector< double > &error, Vector< double > &norm)
 Given the exact solution $ {\bf f}({\bf x}) $ this function calculates the norm of the error and that of the exact solution. Version with vectors of norms and errors so that different variables' norms and errors can be returned individually. More...
 
virtual void compute_error (std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, double &error, double &norm)
 Plot the error when compared against a given exact solution $ {\bf f}({\bf x}) $. Also calculates the norm of the error and that of the exact solution. More...
 
virtual void compute_error (std::ostream &outfile, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, double &error, double &norm)
 Plot the error when compared against a given time-dependent exact solution $ {\bf f}(t,{\bf x}) $. Also calculates the norm of the error and that of the exact solution. More...
 
virtual void compute_error (std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, Vector< double > &error, Vector< double > &norm)
 Plot the error when compared against a given exact solution $ {\bf f}({\bf x}) $. Also calculates the norm of the error and that of the exact solution. The version with vectors of norms and errors so that different variables' norms and errors can be returned individually. More...
 
virtual void compute_error (std::ostream &outfile, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, Vector< double > &error, Vector< double > &norm)
 Plot the error when compared against a given time-dependent exact solution $ {\bf f}(t,{\bf x}) $. Also calculates the norm of the error and that of the exact solution. The version with vectors of norms and errors so that different variables' norms and errors can be returned individually. More...
 
virtual void compute_abs_error (std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, double &error)
 Plot the error when compared against a given exact solution $ {\bf f}({\bf x}) $. Also calculates the maximum absolute error. More...
 
void integrate_fct (FiniteElement::SteadyExactSolutionFctPt integrand_fct_pt, Vector< double > &integral)
 Evaluate integral of a Vector-valued function $ {\bf f}({\bf x}) $ over the element. More...
 
void integrate_fct (FiniteElement::UnsteadyExactSolutionFctPt integrand_fct_pt, const double &time, Vector< double > &integral)
 Evaluate integral of a Vector-valued, time-dependent function $ {\bf f}(t,{\bf x}) $ over the element. More...
 
virtual void build_face_element (const int &face_index, FaceElement *face_element_pt)
 Function for building a lower dimensional FaceElement on the specified face of the FiniteElement. The arguments are the index of the face, an integer whose value depends on the particular element type, and a pointer to the FaceElement. More...
 
virtual unsigned self_test ()
 Self-test: Check inversion of element & do self-test for GeneralisedElement. Return 0 if OK. More...
 
virtual unsigned get_bulk_node_number (const int &face_index, const unsigned &i) const
 Get the number of the ith node on face face_index (in the bulk node vector). More...
 
virtual int face_outer_unit_normal_sign (const int &face_index) const
 Get the sign of the outer unit normal on the face given by face_index. More...
 
virtual unsigned nnode_on_face () const
 
void face_node_number_error_check (const unsigned &i) const
 Range check for face node numbers. More...
 
virtual CoordinateMappingFctPt face_to_bulk_coordinate_fct_pt (const int &face_index) const
 Get a pointer to the function mapping face coordinates to bulk coordinates. More...
 
virtual BulkCoordinateDerivativesFctPt bulk_coordinate_derivatives_fct_pt (const int &face_index) const
 Get a pointer to the derivative of the mapping from face to bulk coordinates. More...
 
- Public Member Functions inherited from oomph::GeneralisedElement
GeneralisedElement() GeneralisedElement (const GeneralisedElement &)=delete
 Constructor: Initialise all pointers and all values to zero. More...
 
void operator= (const GeneralisedElement &)=delete
 Broken assignment operator. More...
 
Data *& internal_data_pt (const unsigned &i)
 Return a pointer to i-th internal data object. More...
 
Data *const & internal_data_pt (const unsigned &i) const
 Return a pointer to i-th internal data object (const version) More...
 
Data *& external_data_pt (const unsigned &i)
 Return a pointer to i-th external data object. More...
 
Data *const & external_data_pt (const unsigned &i) const
 Return a pointer to i-th external data object (const version) More...
 
unsigned long eqn_number (const unsigned &ieqn_local) const
 Return the global equation number corresponding to the ieqn_local-th local equation number. More...
 
int local_eqn_number (const unsigned long &ieqn_global) const
 Return the local equation number corresponding to the ieqn_global-th global equation number. Returns minus one (-1) if there is no local degree of freedom corresponding to the chosen global equation number. More...
 
unsigned add_external_data (Data *const &data_pt, const bool &fd=true)
 Add a (pointer to an) external data object to the element and return its index (i.e. the index required to obtain it from the access function external_data_pt(...). The optional boolean flag indicates whether the data should be included in the general finite-difference loop when calculating the jacobian. The default value is true, i.e. the data will be included in the finite-differencing. More...
 
bool external_data_fd (const unsigned &i) const
 Return the status of the boolean flag indicating whether the external data is included in the finite difference loop. More...
 
void exclude_external_data_fd (const unsigned &i)
 Set the boolean flag to exclude the external datum from the the finite difference loop when computing the jacobian matrix. More...
 
void include_external_data_fd (const unsigned &i)
 Set the boolean flag to include the external datum in the the finite difference loop when computing the jacobian matrix. More...
 
void flush_external_data ()
 Flush all external data. More...
 
void flush_external_data (Data *const &data_pt)
 Flush the object addressed by data_pt from the external data array. More...
 
unsigned ninternal_data () const
 Return the number of internal data objects. More...
 
unsigned nexternal_data () const
 Return the number of external data objects. More...
 
unsigned ndof () const
 Return the number of equations/dofs in the element. More...
 
void dof_vector (const unsigned &t, Vector< double > &dof)
 Return the vector of dof values at time level t. More...
 
void dof_pt_vector (Vector< double * > &dof_pt)
 Return the vector of pointers to dof values. More...
 
void set_internal_data_time_stepper (const unsigned &i, TimeStepper *const &time_stepper_pt, const bool &preserve_existing_data)
 Set the timestepper associated with the i-th internal data object. More...
 
void assign_internal_eqn_numbers (unsigned long &global_number, Vector< double * > &Dof_pt)
 Assign the global equation numbers to the internal Data. The arguments are the current highest global equation number (which will be incremented) and a Vector of pointers to the global variables (to which any unpinned values in the internal Data are added). More...
 
void describe_dofs (std::ostream &out, const std::string &current_string) const
 Function to describe the dofs of the element. The ostream specifies the output stream to which the description is written; the string stores the currently assembled output that is ultimately written to the output stream by Data::describe_dofs(...); it is typically built up incrementally as we descend through the call hierarchy of this function when called from Problem::describe_dofs(...) More...
 
void add_internal_value_pt_to_map (std::map< unsigned, double * > &map_of_value_pt)
 Add pointers to the internal data values to map indexed by the global equation number. More...
 
void add_internal_data_values_to_vector (Vector< double > &vector_of_values)
 Add all internal data and time history values to the vector in the internal storage order. More...
 
void read_internal_data_values_from_vector (const Vector< double > &vector_of_values, unsigned &index)
 Read all internal data and time history values from the vector starting from index. On return the index will be set to the value at the end of the data that has been read in. More...
 
void add_internal_eqn_numbers_to_vector (Vector< long > &vector_of_eqn_numbers)
 Add all equation numbers associated with internal data to the vector in the internal storage order. More...
 
void read_internal_eqn_numbers_from_vector (const Vector< long > &vector_of_eqn_numbers, unsigned &index)
 Read all equation numbers associated with internal data from the vector starting from index. On return the index will be set to the value at the end of the data that has been read in. More...
 
virtual void assign_local_eqn_numbers (const bool &store_local_dof_pt)
 Setup the arrays of local equation numbers for the element. If the optional boolean argument is true, then pointers to the associated degrees of freedom are stored locally in the array Dof_pt. More...
 
virtual void complete_setup_of_dependencies ()
 Complete the setup of any additional dependencies that the element may have. Empty virtual function that may be overloaded for specific derived elements. Used, e.g., for elements with algebraic node update functions to determine the "geometric Data", i.e. the Data that affects the element's shape. This function is called (for all elements) at the very beginning of the equation numbering procedure to ensure that all dependencies are accounted for. More...
 
virtual void get_residuals (Vector< double > &residuals)
 Calculate the vector of residuals of the equations in the element. By default initialise the vector to zero and then call the fill_in_contribution_to_residuals() function. Note that this entire function can be overloaded if desired. More...
 
virtual void get_jacobian (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 Calculate the elemental Jacobian matrix "d equation / d variable". More...
 
virtual void get_mass_matrix (Vector< double > &residuals, DenseMatrix< double > &mass_matrix)
 Calculate the residuals and the elemental "mass" matrix, the matrix that multiplies the time derivative terms in a problem. More...
 
virtual void get_jacobian_and_mass_matrix (Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix)
 Calculate the residuals and jacobian and elemental "mass" matrix, the matrix that multiplies the time derivative terms. More...
 
virtual void get_dresiduals_dparameter (double *const &parameter_pt, Vector< double > &dres_dparam)
 Calculate the derivatives of the residuals with respect to a parameter. More...
 
virtual void get_djacobian_dparameter (double *const &parameter_pt, Vector< double > &dres_dparam, DenseMatrix< double > &djac_dparam)
 Calculate the derivatives of the elemental Jacobian matrix and residuals with respect to a parameter. More...
 
virtual void get_djacobian_and_dmass_matrix_dparameter (double *const &parameter_pt, Vector< double > &dres_dparam, DenseMatrix< double > &djac_dparam, DenseMatrix< double > &dmass_matrix_dparam)
 Calculate the derivatives of the elemental Jacobian matrix mass matrix and residuals with respect to a parameter. More...
 
virtual void get_hessian_vector_products (Vector< double > const &Y, DenseMatrix< double > const &C, DenseMatrix< double > &product)
 Calculate the product of the Hessian (derivative of Jacobian with respect to all variables) an eigenvector, Y, and other specified vectors, C (d(J_{ij})/d u_{k}) Y_{j} C_{k}. More...
 
virtual void get_inner_products (Vector< std::pair< unsigned, unsigned >> const &history_index, Vector< double > &inner_product)
 Return the vector of inner product of the given pairs of history values. More...
 
virtual void get_inner_product_vectors (Vector< unsigned > const &history_index, Vector< Vector< double >> &inner_product_vector)
 Compute the vectors that when taken as a dot product with other history values give the inner product over the element. More...
 
virtual void compute_norm (Vector< double > &norm)
 Compute norm of solution – broken virtual can be overloaded by element writer to implement whatever norm is desired for the specific element. More...
 
virtual void compute_norm (double &norm)
 Compute norm of solution – broken virtual can be overloaded by element writer to implement whatever norm is desired for the specific element. More...
 
void set_halo (const unsigned &non_halo_proc_ID)
 Label the element as halo and specify processor that holds non-halo counterpart. More...
 
void set_nonhalo ()
 Label the element as not being a halo. More...
 
bool is_halo () const
 Is this element a halo? More...
 
int non_halo_proc_ID ()
 ID of processor ID that holds non-halo counterpart of halo element; negative if not a halo. More...
 
void set_must_be_kept_as_halo ()
 Insist that this element be kept as a halo element during a distribute? More...
 
void unset_must_be_kept_as_halo ()
 Do not insist that this element be kept as a halo element during distribution. More...
 
bool must_be_kept_as_halo () const
 Test whether the element must be kept as a halo element. More...
 
virtual unsigned ndof_types () const
 The number of types of degrees of freedom in this element are sub-divided into. More...
 
virtual void get_dof_numbers_for_unknowns (std::list< std::pair< unsigned long, unsigned >> &dof_lookup_list) const
 Create a list of pairs for the unknowns that this element is "in charge of" – ignore any unknowns associated with external Data. The first entry in each pair must contain the global equation number of the unknown, while the second one contains the number of the DOF type that this unknown is associated with. (The function can obviously only be called if the equation numbering scheme has been set up.) More...
 
- Public Member Functions inherited from oomph::GeomObject
 GeomObject ()
 Default constructor. More...
 
 GeomObject (const unsigned &ndim)
 Constructor: Pass dimension of geometric object (# of Eulerian coords = # of Lagrangian coords; no time history available/needed) More...
 
 GeomObject (const unsigned &nlagrangian, const unsigned &ndim)
 Constructor: pass # of Eulerian and Lagrangian coordinates. No time history available/needed. More...
 
 GeomObject (const unsigned &nlagrangian, const unsigned &ndim, TimeStepper *time_stepper_pt)
 Constructor: pass # of Eulerian and Lagrangian coordinates and pointer to time-stepper which is used to handle the position at previous timesteps and allows the evaluation of veloc/acceleration etc. in cases where the GeomData varies with time. More...
 
 GeomObject (const GeomObject &dummy)=delete
 Broken copy constructor. More...
 
void operator= (const GeomObject &)=delete
 Broken assignment operator. More...
 
virtual ~GeomObject ()
 (Empty) destructor More...
 
unsigned nlagrangian () const
 Access function to # of Lagrangian coordinates. More...
 
unsigned ndim () const
 Access function to # of Eulerian coordinates. More...
 
void set_nlagrangian_and_ndim (const unsigned &n_lagrangian, const unsigned &n_dim)
 Set # of Lagrangian and Eulerian coordinates. More...
 
TimeStepper *& time_stepper_pt ()
 Access function for pointer to time stepper: Null if object is not time-dependent. More...
 
TimeSteppertime_stepper_pt () const
 Access function for pointer to time stepper: Null if object is not time-dependent. Const version. More...
 
virtual void position (const double &t, const Vector< double > &zeta, Vector< double > &r) const
 Parametrised position on object: r(zeta). Evaluated at the continuous time value, t. More...
 
virtual void dposition (const Vector< double > &zeta, DenseMatrix< double > &drdzeta) const
 Derivative of position Vector w.r.t. to coordinates: $ \frac{dR_i}{d \zeta_\alpha}$ = drdzeta(alpha,i). Evaluated at current time. More...
 
virtual void d2position (const Vector< double > &zeta, RankThreeTensor< double > &ddrdzeta) const
 2nd derivative of position Vector w.r.t. to coordinates: $ \frac{d^2R_i}{d \zeta_\alpha d \zeta_\beta}$ = ddrdzeta(alpha,beta,i). Evaluated at current time. More...
 
virtual void d2position (const Vector< double > &zeta, Vector< double > &r, DenseMatrix< double > &drdzeta, RankThreeTensor< double > &ddrdzeta) const
 Posn Vector and its 1st & 2nd derivatives w.r.t. to coordinates: $ \frac{dR_i}{d \zeta_\alpha}$ = drdzeta(alpha,i). $ \frac{d^2R_i}{d \zeta_\alpha d \zeta_\beta}$ = ddrdzeta(alpha,beta,i). Evaluated at current time. More...
 

Static Public Attributes

static double Tolerance_for_singular_jacobian = 1.0e-16
 Tolerance below which the jacobian is considered singular. More...
 
static bool Accept_negative_jacobian = false
 Boolean that if set to true allows a negative jacobian in the transform between global and local coordinates (negative surface area = left-handed coordinate system). More...
 
static bool Suppress_output_while_checking_for_inverted_elements
 Static boolean to suppress output while checking for inverted elements. More...
 
- Static Public Attributes inherited from oomph::GeneralisedElement
static bool Suppress_warning_about_repeated_internal_data
 Static boolean to suppress warnings about repeated internal data. Defaults to false. More...
 
static bool Suppress_warning_about_repeated_external_data = true
 Static boolean to suppress warnings about repeated external data. Defaults to true. More...
 
static double Default_fd_jacobian_step = 1.0e-8
 Double used for the default finite difference step in elemental jacobian calculations. More...
 

Protected Member Functions

virtual void assemble_local_to_eulerian_jacobian (const DShape &dpsids, DenseMatrix< double > &jacobian) const
 Assemble the jacobian matrix for the mapping from local to Eulerian coordinates, given the derivatives of the shape function w.r.t the local coordinates. More...
 
virtual void assemble_local_to_eulerian_jacobian2 (const DShape &d2psids, DenseMatrix< double > &jacobian2) const
 Assemble the the "jacobian" matrix of second derivatives of the mapping from local to Eulerian coordinates, given the second derivatives of the shape functions w.r.t. local coordinates. More...
 
virtual void assemble_eulerian_base_vectors (const DShape &dpsids, DenseMatrix< double > &interpolated_G) const
 Assemble the covariant Eulerian base vectors, assuming that the derivatives of the shape functions with respect to the local coordinates have already been constructed. More...
 
template<unsigned DIM>
double invert_jacobian (const DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 Take the matrix passed as jacobian and return its inverse in inverse_jacobian. This function is templated by the dimension of the element because matrix inversion cannot be written efficiently in a generic manner. More...
 
virtual double invert_jacobian_mapping (const DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 A template-free interface that takes the matrix passed as jacobian and return its inverse in inverse_jacobian. By default the function will use the dimension of the element to call the correct invert_jacobian(..) function. This should be overloaded for efficiency (removal of a switch statement) in specific elements. More...
 
virtual double local_to_eulerian_mapping (const DShape &dpsids, DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 Calculate the mapping from local to Eulerian coordinates, given the derivatives of the shape functions w.r.t. local coordinates. Returns the determinant of the jacobian, the jacobian and inverse jacobian. More...
 
double local_to_eulerian_mapping (const DShape &dpsids, DenseMatrix< double > &inverse_jacobian) const
 Calculate the mapping from local to Eulerian coordinates, given the derivatives of the shape functions w.r.t. local coordinates, Return only the determinant of the jacobian and the inverse of the mapping (ds/dx). More...
 
virtual double local_to_eulerian_mapping_diagonal (const DShape &dpsids, DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 Calculate the mapping from local to Eulerian coordinates given the derivatives of the shape functions w.r.t the local coordinates. assuming that the coordinates are aligned in the direction of the local coordinates, i.e. there are no cross terms and the jacobian is diagonal. This function returns the determinant of the jacobian, the jacobian and the inverse jacobian. More...
 
virtual void dJ_eulerian_dnodal_coordinates (const DenseMatrix< double > &jacobian, const DShape &dpsids, DenseMatrix< double > &djacobian_dX) const
 A template-free interface that calculates the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij. To do this it requires the jacobian matrix and the derivatives of the shape functions w.r.t. the local coordinates. By default the function will use the dimension of the element to call the correct dJ_eulerian_dnodal_coordinates_templated_helper(..) function. This should be overloaded for efficiency (removal of a switch statement) in specific elements. More...
 
template<unsigned DIM>
void dJ_eulerian_dnodal_coordinates_templated_helper (const DenseMatrix< double > &jacobian, const DShape &dpsids, DenseMatrix< double > &djacobian_dX) const
 Calculate the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij using the jacobian matrix and the derivatives of the shape functions w.r.t. the local coordinates. This function is templated by the dimension of the element. More...
 
virtual void d_dshape_eulerian_dnodal_coordinates (const double &det_jacobian, const DenseMatrix< double > &jacobian, const DenseMatrix< double > &djacobian_dX, const DenseMatrix< double > &inverse_jacobian, const DShape &dpsids, RankFourTensor< double > &d_dpsidx_dX) const
 A template-free interface that calculates the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions $ \psi_j $ w.r.t. the global eulerian coordinates $ x_i $. I.e. this function calculates. More...
 
template<unsigned DIM>
void d_dshape_eulerian_dnodal_coordinates_templated_helper (const double &det_jacobian, const DenseMatrix< double > &jacobian, const DenseMatrix< double > &djacobian_dX, const DenseMatrix< double > &inverse_jacobian, const DShape &dpsids, RankFourTensor< double > &d_dpsidx_dX) const
 Calculate the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions w.r.t. the global eulerian coordinates $ x_i $, using the determinant of the jacobian mapping, its derivative w.r.t. the nodal coordinates $ X_{pq} $, the inverse jacobian and the derivatives of the shape functions w.r.t. the local coordinates. The result is returned as a tensor of rank four. Numbering: d_dpsidx_dX(p,q,j,i) = $ \frac{\partial}{\partial X_{pq}} \left( \frac{\partial \psi_j}{\partial x_i} \right) $ This function is templated by the dimension of the element. More...
 
virtual void transform_derivatives (const DenseMatrix< double > &inverse_jacobian, DShape &dbasis) const
 Convert derivative w.r.t.local coordinates to derivatives w.r.t the coordinates used to assemble the inverse_jacobian passed in the mapping. On entry, dbasis must contain the basis function derivatives w.r.t. the local coordinates; it will contain the derivatives w.r.t. the new coordinates on exit. This is virtual so that it may be overloaded if desired for efficiency reasons. More...
 
void transform_derivatives_diagonal (const DenseMatrix< double > &inverse_jacobian, DShape &dbasis) const
 Convert derivative w.r.t local coordinates to derivatives w.r.t the coordinates used to assemble the inverse jacobian passed in the mapping, assuming that the coordinates are aligned in the direction of the local coordinates. On entry dbasis must contain the derivatives of the basis functions w.r.t. the local coordinates; it will contain the derivatives w.r.t. the new coordinates. are converted into the new using the mapping inverse_jacobian. More...
 
virtual void transform_second_derivatives (const DenseMatrix< double > &jacobian, const DenseMatrix< double > &inverse_jacobian, const DenseMatrix< double > &jacobian2, DShape &dbasis, DShape &d2basis) const
 Convert derivatives and second derivatives w.r.t. local coordiantes to derivatives and second derivatives w.r.t. the coordinates used to assemble the jacobian, inverse jacobian and jacobian2 passed to the function. By default this function will call transform_second_derivatives_template<>(...) using the dimension of the element as the template parameter. It is virtual so that it can be overloaded by a specific element to save using a switch statement. Optionally, the element writer may wish to use the transform_second_derivatives_diagonal<>(...) function On entry dbasis and d2basis must contain the derivatives w.r.t. the local coordinates; on exit they will be the derivatives w.r.t. the transformed coordinates. More...
 
template<unsigned DIM>
void transform_second_derivatives_template (const DenseMatrix< double > &jacobian, const DenseMatrix< double > &inverse_jacobian, const DenseMatrix< double > &jacobian2, DShape &dbasis, DShape &d2basis) const
 Convert derivatives and second derivatives w.r.t. local coordinates to derivatives and second derivatives w.r.t. the coordinates used to asssmble the jacobian, inverse jacobian and jacobian2 passed in the mapping. This is templated by dimension because the method of calculation varies significantly with the dimension. On entry dbasis and d2basis must contain the derivatives w.r.t. the local coordinates; on exit they will be the derivatives w.r.t. the transformed coordinates. More...
 
template<unsigned DIM>
void transform_second_derivatives_diagonal (const DenseMatrix< double > &jacobian, const DenseMatrix< double > &inverse_jacobian, const DenseMatrix< double > &jacobian2, DShape &dbasis, DShape &d2basis) const
 Convert derivatives and second derivatives w.r.t. local coordinates to derivatives and second derivatives w.r.t. the coordinates used to asssmble the jacobian, inverse jacobian and jacobian2 passed in the mapping. This version of the function assumes that the local coordinates are aligned with the global coordinates, i.e. the jacobians are diagonal On entry dbasis and d2basis must contain the derivatives w.r.t. the local coordinates; on exit they will be the derivatives w.r.t. the transformed coordinates. More...
 
virtual void fill_in_jacobian_from_nodal_by_fd (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 Calculate the contributions to the jacobian from the nodal degrees of freedom using finite differences. This version of the function assumes that the residuals vector has already been calculated. More...
 
void fill_in_jacobian_from_nodal_by_fd (DenseMatrix< double > &jacobian)
 Calculate the contributions to the jacobian from the nodal degrees of freedom using finite differences. This version computes the residuals vector before calculating the jacobian terms. More...
 
virtual void update_before_nodal_fd ()
 Function that is called before the finite differencing of any nodal data. This may be overloaded to update any dependent data before finite differencing takes place. More...
 
virtual void reset_after_nodal_fd ()
 Function that is call after the finite differencing of the nodal data. This may be overloaded to reset any dependent variables that may have changed during the finite differencing. More...
 
virtual void update_in_nodal_fd (const unsigned &i)
 Function called within the finite difference loop for nodal data after a change in the i-th nodal value. More...
 
virtual void reset_in_nodal_fd (const unsigned &i)
 Function called within the finite difference loop for nodal data after the i-th nodal values is reset. The default behaviour is to call the update function. More...
 
void fill_in_contribution_to_jacobian (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 Add the elemental contribution to the jacobian matrix. and the residuals vector. Note that this function will NOT initialise the residuals vector or the jacobian matrix. It must be called after the residuals vector and jacobian matrix have been initialised to zero. The default is to use finite differences to calculate the jacobian. More...
 
template<>
double invert_jacobian (const DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 Zero-d specialisation of function to calculate inverse of jacobian mapping. More...
 
template<>
double invert_jacobian (const DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 One-d specialisation of function to calculate inverse of jacobian mapping. More...
 
template<>
double invert_jacobian (const DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 Two-d specialisation of function to calculate inverse of jacobian mapping. More...
 
template<>
double invert_jacobian (const DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 Three-d specialisation of function to calculate inverse of jacobian mapping. More...
 
template<>
void dJ_eulerian_dnodal_coordinates_templated_helper (const DenseMatrix< double > &jacobian, const DShape &dpsids, DenseMatrix< double > &djacobian_dX) const
 Zero-d specialisation of function to calculate the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij. More...
 
template<>
void dJ_eulerian_dnodal_coordinates_templated_helper (const DenseMatrix< double > &jacobian, const DShape &dpsids, DenseMatrix< double > &djacobian_dX) const
 One-d specialisation of function to calculate the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij. More...
 
template<>
void dJ_eulerian_dnodal_coordinates_templated_helper (const DenseMatrix< double > &jacobian, const DShape &dpsids, DenseMatrix< double > &djacobian_dX) const
 Two-d specialisation of function to calculate the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij. More...
 
template<>
void dJ_eulerian_dnodal_coordinates_templated_helper (const DenseMatrix< double > &jacobian, const DShape &dpsids, DenseMatrix< double > &djacobian_dX) const
 Three-d specialisation of function to calculate the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij. More...
 
template<>
void d_dshape_eulerian_dnodal_coordinates_templated_helper (const double &det_jacobian, const DenseMatrix< double > &jacobian, const DenseMatrix< double > &djacobian_dX, const DenseMatrix< double > &inverse_jacobian, const DShape &dpsids, RankFourTensor< double > &d_dpsidx_dX) const
 Zero-d specialisation of function to calculate the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions w.r.t. the global eulerian coordinates $ x_i $. More...
 
template<>
void d_dshape_eulerian_dnodal_coordinates_templated_helper (const double &det_jacobian, const DenseMatrix< double > &jacobian, const DenseMatrix< double > &djacobian_dX, const DenseMatrix< double > &inverse_jacobian, const DShape &dpsids, RankFourTensor< double > &d_dpsidx_dX) const
 One-d specialisation of function to calculate the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions w.r.t. the global eulerian coordinates $ x_i $. More...
 
template<>
void d_dshape_eulerian_dnodal_coordinates_templated_helper (const double &det_jacobian, const DenseMatrix< double > &jacobian, const DenseMatrix< double > &djacobian_dX, const DenseMatrix< double > &inverse_jacobian, const DShape &dpsids, RankFourTensor< double > &d_dpsidx_dX) const
 Two-d specialisation of function to calculate the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions w.r.t. the global eulerian coordinates $ x_i $. More...
 
template<>
void d_dshape_eulerian_dnodal_coordinates_templated_helper (const double &det_jacobian, const DenseMatrix< double > &jacobian, const DenseMatrix< double > &djacobian_dX, const DenseMatrix< double > &inverse_jacobian, const DShape &dpsids, RankFourTensor< double > &d_dpsidx_dX) const
 Three-d specialisation of function to calculate the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions w.r.t. the global eulerian coordinates $ x_i $. More...
 
template<>
void transform_second_derivatives_template (const DenseMatrix< double > &jacobian, const DenseMatrix< double > &inverse_jacobian, const DenseMatrix< double > &jacobian2, DShape &dbasis, DShape &d2basis) const
 Convert derivatives and second derivatives w.r.t local coordinates to derivatives w.r.t. the coordinates used to assemble the jacobian, inverse_jacobian and jacobian 2 passed. This must be specialised for each dimension, otherwise it gets very ugly Specialisation to one dimension. More...
 
template<>
void transform_second_derivatives_template (const DenseMatrix< double > &jacobian, const DenseMatrix< double > &inverse_jacobian, const DenseMatrix< double > &jacobian2, DShape &dbasis, DShape &d2basis) const
 Convert derivatives and second derivatives w.r.t local coordinates to derivatives w.r.t. the coordinates used to assemble the jacobian, inverse_jacobian and jacobian 2 passed. This must be specialised for each dimension, otherwise it gets very ugly. Specialisation to two spatial dimensions. More...
 
template<>
void transform_second_derivatives_diagonal (const DenseMatrix< double > &jacobian, const DenseMatrix< double > &inverse_jacobian, const DenseMatrix< double > &jacobian2, DShape &dbasis, DShape &d2basis) const
 Convert derivatives and second derivatives w.r.t local coordinates to derivatives w.r.t. the coordinates used to assemble the jacobian, inverse_jacobian and jacobian 2 passed. This must be specialised for each dimension, otherwise it gets very ugly Specialisation to one dimension. More...
 
template<>
void transform_second_derivatives_diagonal (const DenseMatrix< double > &jacobian, const DenseMatrix< double > &inverse_jacobian, const DenseMatrix< double > &jacobian2, DShape &dbasis, DShape &d2basis) const
 Convert second derivatives w.r.t. local coordinates to second derivatives w.r.t. the coordinates passed in the tensor coordinate. Specialised to two spatial dimension. More...
 
- Protected Member Functions inherited from oomph::GeneralisedElement
unsigned add_internal_data (Data *const &data_pt, const bool &fd=true)
 Add a (pointer to an) internal data object to the element and return the index required to obtain it from the access function internal_data_pt(). The boolean indicates whether the datum should be included in the general finite-difference loop when calculating the jacobian. The default value is true, i.e. the data will be included in the finite differencing. More...
 
bool internal_data_fd (const unsigned &i) const
 Return the status of the boolean flag indicating whether the internal data is included in the finite difference loop. More...
 
void exclude_internal_data_fd (const unsigned &i)
 Set the boolean flag to exclude the internal datum from the finite difference loop when computing the jacobian matrix. More...
 
void include_internal_data_fd (const unsigned &i)
 Set the boolean flag to include the internal datum in the finite difference loop when computing the jacobian matrix. More...
 
void clear_global_eqn_numbers ()
 Clear the storage for the global equation numbers and pointers to dofs (if stored) More...
 
void add_global_eqn_numbers (std::deque< unsigned long > const &global_eqn_numbers, std::deque< double * > const &global_dof_pt)
 Add the contents of the queue global_eqn_numbers to the local storage for the local-to-global translation scheme. It is essential that the entries in the queue are added IN ORDER i.e. from the front. More...
 
virtual void assign_internal_and_external_local_eqn_numbers (const bool &store_local_dof_pt)
 Assign the local equation numbers for the internal and external Data This must be called after the global equation numbers have all been assigned. It is virtual so that it can be overloaded by ElementWithExternalElements so that any external data from the external elements in included in the numbering scheme. If the boolean argument is true then pointers to the dofs will be stored in Dof_pt. More...
 
virtual void assign_additional_local_eqn_numbers ()
 Setup any additional look-up schemes for local equation numbers. Examples of use include using local storage to refer to explicit degrees of freedom. The additional memory cost of such storage may or may not be offset by fast local access. More...
 
int internal_local_eqn (const unsigned &i, const unsigned &j) const
 Return the local equation number corresponding to the j-th value stored at the i-th internal data. More...
 
int external_local_eqn (const unsigned &i, const unsigned &j)
 Return the local equation number corresponding to the j-th value stored at the i-th external data. More...
 
virtual void fill_in_contribution_to_residuals (Vector< double > &residuals)
 Add the elemental contribution to the residuals vector. Note that this function will NOT initialise the residuals vector. It must be called after the residuals vector has been initialised to zero. More...
 
void fill_in_jacobian_from_internal_by_fd (Vector< double > &residuals, DenseMatrix< double > &jacobian, const bool &fd_all_data=false)
 Calculate the contributions to the jacobian from the internal degrees of freedom using finite differences. This version of the function assumes that the residuals vector has already been calculated. If the boolean argument is true, the finite differencing will be performed for all internal data, irrespective of the information in Data_fd. The default value (false) uses the information in Data_fd to selectively difference only certain data. More...
 
void fill_in_jacobian_from_internal_by_fd (DenseMatrix< double > &jacobian, const bool &fd_all_data=false)
 Calculate the contributions to the jacobian from the internal degrees of freedom using finite differences. This version computes the residuals vector before calculating the jacobian terms. If the boolean argument is true, the finite differencing will be performed for all internal data, irrespective of the information in Data_fd. The default value (false) uses the information in Data_fd to selectively difference only certain data. More...
 
void fill_in_jacobian_from_external_by_fd (Vector< double > &residuals, DenseMatrix< double > &jacobian, const bool &fd_all_data=false)
 Calculate the contributions to the jacobian from the external degrees of freedom using finite differences. This version of the function assumes that the residuals vector has already been calculated. If the boolean argument is true, the finite differencing will be performed for all external data, irrespective of the information in Data_fd. The default value (false) uses the information in Data_fd to selectively difference only certain data. More...
 
void fill_in_jacobian_from_external_by_fd (DenseMatrix< double > &jacobian, const bool &fd_all_data=false)
 Calculate the contributions to the jacobian from the external degrees of freedom using finite differences. This version computes the residuals vector before calculating the jacobian terms. If the boolean argument is true, the finite differencing will be performed for all internal data, irrespective of the information in Data_fd. The default value (false) uses the information in Data_fd to selectively difference only certain data. More...
 
virtual void update_before_internal_fd ()
 Function that is called before the finite differencing of any internal data. This may be overloaded to update any dependent data before finite differencing takes place. More...
 
virtual void reset_after_internal_fd ()
 Function that is call after the finite differencing of the internal data. This may be overloaded to reset any dependent variables that may have changed during the finite differencing. More...
 
virtual void update_in_internal_fd (const unsigned &i)
 Function called within the finite difference loop for internal data after a change in any values in the i-th internal data object. More...
 
virtual void reset_in_internal_fd (const unsigned &i)
 Function called within the finite difference loop for internal data after the values in the i-th external data object are reset. The default behaviour is to call the update function. More...
 
virtual void update_before_external_fd ()
 Function that is called before the finite differencing of any external data. This may be overloaded to update any dependent data before finite differencing takes place. More...
 
virtual void reset_after_external_fd ()
 Function that is call after the finite differencing of the external data. This may be overloaded to reset any dependent variables that may have changed during the finite differencing. More...
 
virtual void update_in_external_fd (const unsigned &i)
 Function called within the finite difference loop for external data after a change in any values in the i-th external data object. More...
 
virtual void reset_in_external_fd (const unsigned &i)
 Function called within the finite difference loop for external data after the values in the i-th external data object are reset. The default behaviour is to call the update function. More...
 
virtual void fill_in_contribution_to_mass_matrix (Vector< double > &residuals, DenseMatrix< double > &mass_matrix)
 Add the elemental contribution to the mass matrix matrix. and the residuals vector. Note that this function should NOT initialise the residuals vector or the mass matrix. It must be called after the residuals vector and jacobian matrix have been initialised to zero. The default is deliberately broken. More...
 
virtual void fill_in_contribution_to_jacobian_and_mass_matrix (Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix)
 Add the elemental contribution to the jacobian matrix, mass matrix and the residuals vector. Note that this function should NOT initialise any entries. It must be called after the residuals vector and matrices have been initialised to zero. More...
 
virtual void fill_in_contribution_to_dresiduals_dparameter (double *const &parameter_pt, Vector< double > &dres_dparam)
 Add the elemental contribution to the derivatives of the residuals with respect to a parameter. This function should NOT initialise any entries and must be called after the entries have been initialised to zero The default implementation is to use finite differences to calculate the derivatives. More...
 
virtual void fill_in_contribution_to_djacobian_dparameter (double *const &parameter_pt, Vector< double > &dres_dparam, DenseMatrix< double > &djac_dparam)
 Add the elemental contribution to the derivatives of the elemental Jacobian matrix and residuals with respect to a parameter. This function should NOT initialise any entries and must be called after the entries have been initialised to zero The default implementation is to use finite differences to calculate the derivatives. More...
 
virtual void fill_in_contribution_to_djacobian_and_dmass_matrix_dparameter (double *const &parameter_pt, Vector< double > &dres_dparam, DenseMatrix< double > &djac_dparam, DenseMatrix< double > &dmass_matrix_dparam)
 Add the elemental contribution to the derivative of the jacobian matrix, mass matrix and the residuals vector with respect to the passed parameter. Note that this function should NOT initialise any entries. It must be called after the residuals vector and matrices have been initialised to zero. More...
 
virtual void fill_in_contribution_to_hessian_vector_products (Vector< double > const &Y, DenseMatrix< double > const &C, DenseMatrix< double > &product)
 Fill in contribution to the product of the Hessian (derivative of Jacobian with respect to all variables) an eigenvector, Y, and other specified vectors, C (d(J_{ij})/d u_{k}) Y_{j} C_{k}. More...
 
virtual void fill_in_contribution_to_inner_products (Vector< std::pair< unsigned, unsigned >> const &history_index, Vector< double > &inner_product)
 Fill in the contribution to the inner products between given pairs of history values. More...
 
virtual void fill_in_contribution_to_inner_product_vectors (Vector< unsigned > const &history_index, Vector< Vector< double >> &inner_product_vector)
 Fill in the contributions to the vectors that when taken as dot product with other history values give the inner product over the element. More...
 

Protected Attributes

MacroElementMacro_elem_pt
 Pointer to the element's macro element (NULL by default) More...
 
- Protected Attributes inherited from oomph::GeneralisedElement
int Non_halo_proc_ID
 Non-halo processor ID for Data; -1 if it's not a halo. More...
 
bool Must_be_kept_as_halo
 Does this element need to be kept as a halo element during a distribute? More...
 
- Protected Attributes inherited from oomph::GeomObject
unsigned NLagrangian
 Number of Lagrangian (intrinsic) coordinates. More...
 
unsigned Ndim
 Number of Eulerian coordinates. More...
 
TimeStepperGeom_object_time_stepper_pt
 Timestepper (used to handle access to geometry at previous timesteps) More...
 

Static Protected Attributes

static const unsigned Default_Initial_Nvalue = 0
 Default return value for required_nvalue(n) which gives the number of "data" values required by the element at node n; for example, solving a Poisson equation would required only one "data" value at each node. The defaults is set to zero, because a general element is problem-less. More...
 
static const double Node_location_tolerance = 1.0e-14
 Default value for the tolerance to be used when locating nodes via local coordinates. More...
 
static const unsigned N2deriv [] = {0, 1, 3, 6}
 Static array that holds the number of second derivatives as a function of the dimension of the element. More...
 
- Static Protected Attributes inherited from oomph::GeneralisedElement
static DenseMatrix< double > Dummy_matrix
 Empty dense matrix used as a dummy argument to combined residual and jacobian functions in the case when only the residuals are being assembled. More...
 
static std::deque< double * > Dof_pt_deque
 Static storage for deque used to add_global_equation_numbers when pointers to the dofs in each element are not required. More...
 

Private Attributes

IntegralIntegral_pt
 Pointer to the spatial integration scheme. More...
 
Node ** Node_pt
 Storage for pointers to the nodes in the element. More...
 
int ** Nodal_local_eqn
 Storage for the local equation numbers associated with the values stored at the nodes. More...
 
unsigned Nnode
 Number of nodes in the element. More...
 
unsigned Elemental_dimension
 The spatial dimension of the element, i.e. the number of local coordinates used to parametrize it. More...
 
unsigned Nodal_dimension
 The spatial dimension of the nodes in the element. We assume that nodes have the same spatial dimension, because we cannot think of any "real" problems for which that would not be the case. More...
 
unsigned Nnodal_position_type
 The number of coordinate types required to interpolate the element's geometry between the nodes. For Lagrange elements it is 1 (the default). It must be over-ridden by using the set_nposition_type() function in the constructors of elements that use generalised coordinate, e.g. for 1D Hermite elements Nnodal_position_types =2. More...
 

Detailed Description

A general Finite Element class.

The main components of a FiniteElement are:

We also provide interfaces for functions that compute the element's Jacobian matrix and/or the Vector of residuals (inherited from GeneralisedElement) plus various output routines.

Definition at line 1312 of file elements.h.

Member Typedef Documentation

◆ SteadyExactSolutionFctPt

typedef void(* oomph::FiniteElement::SteadyExactSolutionFctPt) (const Vector< double > &, Vector< double > &)

Function pointer for function that computes vector-valued steady "exact solution" $ {\bf f}({\bf x}) $ as $ \mbox{\tt fct}({\bf x}, {\bf f}) $.

Definition at line 1759 of file elements.h.

◆ UnsteadyExactSolutionFctPt

typedef void(* oomph::FiniteElement::UnsteadyExactSolutionFctPt) (const double &, const Vector< double > &, Vector< double > &)

Function pointer for function that computes Vector-valued time-dependent function $ {\bf f}(t,{\bf x}) $ as $ \mbox{\tt fct}(t, {\bf x}, {\bf f}) $.

Definition at line 1765 of file elements.h.

Constructor & Destructor Documentation

◆ FiniteElement() [1/2]

oomph::FiniteElement::FiniteElement ( )
inline

Constructor.

Definition at line 1782 of file elements.h.

◆ ~FiniteElement()

oomph::FiniteElement::~FiniteElement ( )
virtual

The destructor cleans up the static memory allocated for shape function storage. Internal and external data get wiped by the GeneralisedElement destructor; nodes get killed in mesh destructor.

The destructor cleans up the memory allocated for storage of pointers to nodes. Internal and external data get wiped by the GeneralisedElement destructor; nodes get killed in mesh destructor.

Definition at line 3173 of file elements.cc.

References Nodal_local_eqn, and Node_pt.

◆ FiniteElement() [2/2]

oomph::FiniteElement::FiniteElement ( const FiniteElement )
delete

Broken copy constructor.

Member Function Documentation

◆ assemble_eulerian_base_vectors()

void oomph::FiniteElement::assemble_eulerian_base_vectors ( const DShape dpsids,
DenseMatrix< double > &  interpolated_G 
) const
protectedvirtual

Assemble the covariant Eulerian base vectors, assuming that the derivatives of the shape functions with respect to the local coordinates have already been constructed.

Assemble the covariant Eulerian base vectors and return them in the matrix interpolated_G. The derivatives of the shape functions with respect to the local coordinate should already have been calculated before calling this function.

Reimplemented in oomph::RefineableElement.

Definition at line 2009 of file elements.cc.

References dim(), i, nnodal_position_type(), nnode(), nodal_dimension(), and raw_nodal_position_gen().

Referenced by J_eulerian(), and J_eulerian_at_knot().

◆ assemble_local_to_eulerian_jacobian()

void oomph::FiniteElement::assemble_local_to_eulerian_jacobian ( const DShape dpsids,
DenseMatrix< double > &  jacobian 
) const
protectedvirtual

Assemble the jacobian matrix for the mapping from local to Eulerian coordinates, given the derivatives of the shape function w.r.t the local coordinates.

Internal function that is used to assemble the jacobian of the mapping from local coordinates (s) to the eulerian coordinates (x), given the derivatives of the shape functions. The entire jacobian matrix is constructed and this function will only work if there are the same number of local coordinates as global coordinates (i.e. for "bulk" elements).

Reimplemented in oomph::RefineableElement.

Definition at line 1905 of file elements.cc.

References dim(), Elemental_dimension, i, nnodal_position_type(), nnode(), Nodal_dimension, and raw_nodal_position_gen().

Referenced by local_to_eulerian_mapping().

◆ assemble_local_to_eulerian_jacobian2()

void oomph::FiniteElement::assemble_local_to_eulerian_jacobian2 ( const DShape d2psids,
DenseMatrix< double > &  jacobian2 
) const
protectedvirtual

Assemble the the "jacobian" matrix of second derivatives of the mapping from local to Eulerian coordinates, given the second derivatives of the shape functions w.r.t. local coordinates.

Internal function that is used to assemble the jacobian of second derivatives of the mapping from local coordinates (s) to the eulerian coordinates (x), given the second derivatives of the shape functions.

Reimplemented in oomph::RefineableElement.

Definition at line 1963 of file elements.cc.

References dim(), i, N2deriv, nnodal_position_type(), nnode(), and raw_nodal_position_gen().

Referenced by d2shape_eulerian(), and d2shape_eulerian_at_knot().

◆ assign_all_generic_local_eqn_numbers()

virtual void oomph::FiniteElement::assign_all_generic_local_eqn_numbers ( const bool &  store_local_dof_pt)
inlinevirtual

◆ assign_nodal_local_eqn_numbers()

void oomph::FiniteElement::assign_nodal_local_eqn_numbers ( const bool &  store_local_dof_pt)
virtual

Assign the local equation numbers for Data stored at the nodes Virtual so that it can be overloaded by RefineableFiniteElements. If the boolean is true then the pointers to the degrees of freedom associated with each equation number are stored in Dof_pt.

This function loops over the nodal data of the element, adds the GLOBAL equation numbers to the local-to-global look-up scheme and fills in the Nodal_local_eqn look-up scheme for the local equation numbers If the boolean argument is true then pointers to the dofs will be stored in Dof_pt.

Reimplemented in oomph::RefineableElement.

Definition at line 3544 of file elements.cc.

References oomph::GeneralisedElement::add_global_eqn_numbers(), oomph::GeneralisedElement::Dof_pt_deque, oomph::Data::eqn_number(), oomph::GeneralisedElement::eqn_number(), i, oomph::Data::Is_pinned, oomph::Data::Is_unclassified, oomph::GeneralisedElement::local_eqn_number(), oomph::GeneralisedElement::ndof(), nnode(), Nodal_local_eqn, Node_pt, node_pt(), oomph::Data::nvalue(), and oomph::Data::value_pt().

Referenced by assign_all_generic_local_eqn_numbers(), and oomph::RefineableElement::assign_nodal_local_eqn_numbers().

◆ build_face_element()

void oomph::FiniteElement::build_face_element ( const int &  face_index,
FaceElement face_element_pt 
)
virtual

Function for building a lower dimensional FaceElement on the specified face of the FiniteElement. The arguments are the index of the face, an integer whose value depends on the particular element type, and a pointer to the FaceElement.

Reimplemented in oomph::SolidTElement< 3, NNODE_1D >, oomph::SolidTElement< 2, NNODE_1D >, oomph::SolidTElement< 1, NNODE_1D >, oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::SolidQElement< 3, NNODE_1D >, oomph::SolidQElement< 2, NNODE_1D >, oomph::SolidQElement< 1, NNODE_1D >, oomph::SolidQHermiteElement< DIM >, oomph::SolidQHermiteElement< 1 >, oomph::SolidQHermiteElement< 2 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, and oomph::QHermiteElement< DIM - 1 >.

Definition at line 5132 of file elements.cc.

References oomph::FaceElement::bulk_coordinate_derivatives_fct_pt(), bulk_coordinate_derivatives_fct_pt(), oomph::FaceElement::bulk_element_pt(), oomph::FaceElement::bulk_node_number(), oomph::FaceElement::bulk_node_number_resize(), oomph::FaceElement::face_index(), face_outer_unit_normal_sign(), oomph::FaceElement::face_to_bulk_coordinate_fct_pt(), face_to_bulk_coordinate_fct_pt(), get_bulk_node_number(), i, oomph::FaceElement::nbulk_value(), oomph::FaceElement::nbulk_value_resize(), nnode_on_face(), nodal_dimension(), node_pt(), oomph::GeneralisedElement::Non_halo_proc_ID, oomph::FaceElement::normal_sign(), required_nvalue(), oomph::GeneralisedElement::set_halo(), and set_nodal_dimension().

Referenced by oomph::AdvectionDiffusionFluxElement< ELEMENT >::AdvectionDiffusionFluxElement(), oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >::AxisymmetricLinearElasticityTractionElement(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::AxisymmetricNavierStokesTractionElement(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::AxisymmetricPoroelasticityTractionElement(), oomph::AxisymmetricSolidTractionElement< ELEMENT >::AxisymmetricSolidTractionElement(), oomph::BiharmonicFluxElement< DIM >::BiharmonicFluxElement(), oomph::ClampedHermiteShellBoundaryConditionElement::ClampedHermiteShellBoundaryConditionElement(), oomph::ClampedSlidingHermiteBeamBoundaryConditionElement::ClampedSlidingHermiteBeamBoundaryConditionElement(), oomph::DarcyFaceElement< ELEMENT >::DarcyFaceElement(), oomph::DGEulerFaceElement< ELEMENT >::DGEulerFaceElement(), oomph::DGEulerFaceReflectionElement< ELEMENT >::DGEulerFaceReflectionElement(), oomph::DGScalarAdvectionFaceElement< ELEMENT >::DGScalarAdvectionFaceElement(), oomph::DummyFaceElement< ELEMENT >::DummyFaceElement(), oomph::ElasticAxisymmetricVolumeConstraintBoundingElement< ELEMENT >::ElasticAxisymmetricVolumeConstraintBoundingElement(), oomph::ElasticLineVolumeConstraintBoundingElement< ELEMENT >::ElasticLineVolumeConstraintBoundingElement(), oomph::ElasticSurfaceVolumeConstraintBoundingElement< ELEMENT >::ElasticSurfaceVolumeConstraintBoundingElement(), oomph::ElasticUpdateFluidInterfaceElement< EQUATION_CLASS, DERIVATIVE_CLASS, ELEMENT >::ElasticUpdateFluidInterfaceElement(), oomph::FaceElementAsGeomObject< ELEMENT >::FaceElementAsGeomObject(), oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >::FourierDecomposedHelmholtzBCElementBase(), oomph::FourierDecomposedHelmholtzFluxElement< ELEMENT >::FourierDecomposedHelmholtzFluxElement(), oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement(), oomph::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement(), oomph::FpPressureAdvDiffRobinBCElement< ELEMENT >::FpPressureAdvDiffRobinBCElement(), oomph::FpPressureAdvDiffRobinBCMixedOrderSpaceTimeElement< ELEMENT >::FpPressureAdvDiffRobinBCMixedOrderSpaceTimeElement(), oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >::FpPressureAdvDiffRobinBCSpaceTimeElement(), oomph::FSIAxisymmetricLinearElasticityTractionElement< ELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::FSIAxisymmetricLinearElasticityTractionElement(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::FSIImposeDisplacementByLagrangeMultiplierElement(), oomph::HelmholtzBCElementBase< ELEMENT >::HelmholtzBCElementBase(), oomph::HelmholtzFluxElement< ELEMENT >::HelmholtzFluxElement(), oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::HelmholtzFluxFromNormalDisplacementBCElement(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::ImposeDisplacementByLagrangeMultiplierElement(), oomph::ImposeImpenetrabilityElement< ELEMENT >::ImposeImpenetrabilityElement(), oomph::ImposeParallelOutflowElement< ELEMENT >::ImposeParallelOutflowElement(), oomph::LinearElasticityTractionElement< ELEMENT >::LinearElasticityTractionElement(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::LinearisedAxisymPoroelasticBJS_FSIElement(), oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >::LinearisedFSIAxisymmetricNStNoSlipBCElementElement(), oomph::LinearWaveFluxElement< ELEMENT >::LinearWaveFluxElement(), oomph::SpineUpdateFluidInterfaceElement< EQUATION_CLASS, DERIVATIVE_CLASS, ELEMENT >::make_bounding_element(), oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::NavierStokesImpedanceTractionElement(), oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >::NavierStokesMixedOrderSpaceTimeTractionElement(), oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >::NavierStokesSpaceTimeTractionElement(), oomph::NavierStokesSurfaceDragTorqueElement< ELEMENT >::NavierStokesSurfaceDragTorqueElement(), oomph::NavierStokesSurfacePowerElement< ELEMENT >::NavierStokesSurfacePowerElement(), oomph::NavierStokesTractionElement< ELEMENT >::NavierStokesTractionElement(), oomph::PMLFourierDecomposedHelmholtzFluxElement< ELEMENT >::PMLFourierDecomposedHelmholtzFluxElement(), oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >::PMLFourierDecomposedHelmholtzPowerMonitorElement(), oomph::PMLHelmholtzFluxElement< ELEMENT >::PMLHelmholtzFluxElement(), oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::PMLHelmholtzFluxFromNormalDisplacementBCElement(), oomph::PMLHelmholtzPowerElement< ELEMENT >::PMLHelmholtzPowerElement(), oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >::PMLTimeHarmonicLinearElasticityTractionElement(), oomph::PoissonFluxElement< ELEMENT >::PoissonFluxElement(), oomph::PolarNavierStokesTractionElement< ELEMENT >::PolarNavierStokesTractionElement(), oomph::PolarStressIntegralElement< ELEMENT >::PolarStressIntegralElement(), oomph::PoroelasticityFaceElement< ELEMENT >::PoroelasticityFaceElement(), oomph::SolidTractionElement< ELEMENT >::SolidTractionElement(), oomph::SphericalAdvectionDiffusionFluxElement< ELEMENT >::SphericalAdvectionDiffusionFluxElement(), oomph::SpineAxisymmetricVolumeConstraintBoundingElement< ELEMENT >::SpineAxisymmetricVolumeConstraintBoundingElement(), oomph::SpineLineVolumeConstraintBoundingElement< ELEMENT >::SpineLineVolumeConstraintBoundingElement(), oomph::SpineSurfaceVolumeConstraintBoundingElement< ELEMENT >::SpineSurfaceVolumeConstraintBoundingElement(), oomph::SpineUpdateFluidInterfaceElement< EQUATION_CLASS, DERIVATIVE_CLASS, ELEMENT >::SpineUpdateFluidInterfaceElement(), oomph::SteadyAxisymAdvectionDiffusionFluxElement< ELEMENT >::SteadyAxisymAdvectionDiffusionFluxElement(), oomph::TimeHarmonicFourierDecomposedLinearElasticityTractionElement< ELEMENT >::TimeHarmonicFourierDecomposedLinearElasticityTractionElement(), oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >::TimeHarmonicLinearElasticityTractionElement(), oomph::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement(), oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement(), oomph::UnsteadyHeatFluxElement< ELEMENT >::UnsteadyHeatFluxElement(), and oomph::YoungLaplaceContactAngleElement< ELEMENT >::YoungLaplaceContactAngleElement().

◆ bulk_coordinate_derivatives_fct_pt()

virtual BulkCoordinateDerivativesFctPt oomph::FiniteElement::bulk_coordinate_derivatives_fct_pt ( const int &  face_index) const
inlinevirtual

Get a pointer to the derivative of the mapping from face to bulk coordinates.

Reimplemented in oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, and oomph::QElement< 1, NNODE_1D >.

Definition at line 3419 of file elements.h.

References oomph::Global_string_for_annotation::string().

Referenced by build_face_element().

◆ check_J_eulerian_at_knots()

void oomph::FiniteElement::check_J_eulerian_at_knots ( bool &  passed) const

Check that Jacobian of mapping between local and Eulerian coordinates at all integration points is positive.

Definition at line 4237 of file elements.cc.

References Accept_negative_jacobian, dim(), dshape_eulerian_at_knot(), integral_pt(), nnodal_position_type(), nnode(), and oomph::Integral::nweight().

Referenced by oomph::TetMeshBase::snap_nodes_onto_geometric_objects(), and oomph::WomersleyMesh< WOMERSLEY_ELEMENT >::WomersleyMesh().

◆ check_jacobian()

void oomph::FiniteElement::check_jacobian ( const double &  jacobian) const

Helper function used to check for singular or negative Jacobians in the transform from local to global or Lagrangian coordinates.

Internal function used to check for singular or negative values of the determinant of the Jacobian of the mapping between local and global or lagrangian coordinates. Negative jacobians are allowed if the Accept_negative_jacobian flag is set to true.

Definition at line 1750 of file elements.cc.

References Accept_negative_jacobian, i, Macro_elem_pt, oomph::Node::ndim(), nnode(), node_pt(), Suppress_output_while_checking_for_inverted_elements, Tolerance_for_singular_jacobian, and oomph::Node::x().

Referenced by oomph::Mesh::check_inverted_elements(), invert_jacobian(), local_to_eulerian_mapping_diagonal(), oomph::RefineableElement::local_to_eulerian_mapping_diagonal(), oomph::SolidFiniteElement::local_to_lagrangian_mapping_diagonal(), and oomph::RefineableSolidElement::local_to_lagrangian_mapping_diagonal().

◆ compute_abs_error()

virtual void oomph::FiniteElement::compute_abs_error ( std::ostream &  outfile,
FiniteElement::SteadyExactSolutionFctPt  exact_soln_pt,
double &  error 
)
inlinevirtual

Plot the error when compared against a given exact solution $ {\bf f}({\bf x}) $. Also calculates the maximum absolute error.

Definition at line 3330 of file elements.h.

References oomph::Global_string_for_annotation::string().

◆ compute_error() [1/8]

virtual void oomph::FiniteElement::compute_error ( FiniteElement::SteadyExactSolutionFctPt  exact_soln_pt,
double &  error,
double &  norm 
)
inlinevirtual

◆ compute_error() [2/8]

virtual void oomph::FiniteElement::compute_error ( FiniteElement::SteadyExactSolutionFctPt  exact_soln_pt,
Vector< double > &  error,
Vector< double > &  norm 
)
inlinevirtual

Given the exact solution $ {\bf f}({\bf x}) $ this function calculates the norm of the error and that of the exact solution. Version with vectors of norms and errors so that different variables' norms and errors can be returned individually.

Definition at line 3225 of file elements.h.

References oomph::Global_string_for_annotation::string().

◆ compute_error() [3/8]

virtual void oomph::FiniteElement::compute_error ( FiniteElement::UnsteadyExactSolutionFctPt  exact_soln_pt,
const double &  time,
double &  error,
double &  norm 
)
inlinevirtual

◆ compute_error() [4/8]

virtual void oomph::FiniteElement::compute_error ( FiniteElement::UnsteadyExactSolutionFctPt  exact_soln_pt,
const double &  time,
Vector< double > &  error,
Vector< double > &  norm 
)
inlinevirtual

Given the exact solution $ {\bf f}({\bf x}) $ this function calculates the norm of the error and that of the exact solution. Version with vectors of norms and errors so that different variables' norms and errors can be returned individually.

Definition at line 3239 of file elements.h.

References oomph::Global_string_for_annotation::string().

◆ compute_error() [5/8]

virtual void oomph::FiniteElement::compute_error ( std::ostream &  outfile,
FiniteElement::SteadyExactSolutionFctPt  exact_soln_pt,
double &  error,
double &  norm 
)
inlinevirtual

Plot the error when compared against a given exact solution $ {\bf f}({\bf x}) $. Also calculates the norm of the error and that of the exact solution.

Reimplemented in oomph::YoungLaplaceEquations, oomph::WomersleyEquations< DIM >, oomph::UnsteadyHeatEquations< DIM >, oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations, oomph::SteadyAxisymAdvectionDiffusionEquations, oomph::SphericalNavierStokesEquations, oomph::SphericalAdvectionDiffusionEquations, oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::PolarNavierStokesEquations, oomph::PoissonEquations< DIM >, oomph::PMLTimeHarmonicLinearElasticityEquations< DIM >, oomph::PMLHelmholtzEquations< DIM >, oomph::PMLFourierDecomposedHelmholtzEquations, oomph::NavierStokesEquations< DIM >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, oomph::LinearWaveEquations< DIM >, oomph::LinearElasticityEquations< DIM >, oomph::HelmholtzEquations< DIM >, oomph::GeneralisedNewtonianNavierStokesEquations< DIM >, oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations, oomph::FourierDecomposedHelmholtzEquations, oomph::FoepplvonKarmanEquations, oomph::DisplacementBasedFoepplvonKarmanEquations, oomph::BiharmonicFluidBoundaryElement, oomph::BiharmonicFluxElement< DIM >, oomph::BiharmonicElement< DIM >, oomph::BiharmonicEquations< DIM >, oomph::AxisymmetricNavierStokesEquations, oomph::AxisymmetricLinearElasticityEquations, oomph::AxisymFoepplvonKarmanEquations, oomph::AxisymFoepplvonKarmanEquations, oomph::GeneralisedAxisymAdvectionDiffusionEquations, oomph::AxisymAdvectionDiffusionEquations, oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >, oomph::GeneralisedAdvectionDiffusionEquations< DIM >, and oomph::AdvectionDiffusionEquations< DIM >.

Definition at line 3256 of file elements.h.

References oomph::Global_string_for_annotation::string().

◆ compute_error() [6/8]

virtual void oomph::FiniteElement::compute_error ( std::ostream &  outfile,
FiniteElement::SteadyExactSolutionFctPt  exact_soln_pt,
Vector< double > &  error,
Vector< double > &  norm 
)
inlinevirtual

Plot the error when compared against a given exact solution $ {\bf f}({\bf x}) $. Also calculates the norm of the error and that of the exact solution. The version with vectors of norms and errors so that different variables' norms and errors can be returned individually.

Reimplemented in oomph::PoroelasticityEquations< DIM >, oomph::PoroelasticityEquations< 2 >, oomph::DarcyEquations< DIM >, oomph::DarcyEquations< 2 >, and oomph::AxisymmetricPoroelasticityEquations.

Definition at line 3292 of file elements.h.

References oomph::Global_string_for_annotation::string().

◆ compute_error() [7/8]

virtual void oomph::FiniteElement::compute_error ( std::ostream &  outfile,
FiniteElement::UnsteadyExactSolutionFctPt  exact_soln_pt,
const double &  time,
double &  error,
double &  norm 
)
inlinevirtual

Plot the error when compared against a given time-dependent exact solution $ {\bf f}(t,{\bf x}) $. Also calculates the norm of the error and that of the exact solution.

Reimplemented in oomph::YoungLaplaceEquations, oomph::WomersleyEquations< DIM >, oomph::UnsteadyHeatEquations< DIM >, oomph::SphericalNavierStokesEquations, oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::PolarNavierStokesEquations, oomph::PoissonEquations< DIM >, oomph::PMLTimeHarmonicLinearElasticityEquations< DIM >, oomph::PMLHelmholtzEquations< DIM >, oomph::PMLFourierDecomposedHelmholtzEquations, oomph::NavierStokesEquations< DIM >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, oomph::LinearWaveEquations< DIM >, oomph::LinearElasticityEquations< DIM >, oomph::HelmholtzEquations< DIM >, oomph::GeneralisedNewtonianNavierStokesEquations< DIM >, oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations, oomph::FourierDecomposedHelmholtzEquations, oomph::FoepplvonKarmanEquations, oomph::DisplacementBasedFoepplvonKarmanEquations, oomph::BiharmonicElement< DIM >, oomph::BiharmonicEquations< DIM >, oomph::AxisymmetricNavierStokesEquations, oomph::AxisymmetricLinearElasticityEquations, oomph::AxisymFoepplvonKarmanEquations, oomph::AxisymFoepplvonKarmanEquations, oomph::GeneralisedAxisymAdvectionDiffusionEquations, oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >, oomph::GeneralisedAdvectionDiffusionEquations< DIM >, and oomph::AdvectionDiffusionEquations< DIM >.

Definition at line 3272 of file elements.h.

References oomph::Global_string_for_annotation::string().

◆ compute_error() [8/8]

virtual void oomph::FiniteElement::compute_error ( std::ostream &  outfile,
FiniteElement::UnsteadyExactSolutionFctPt  exact_soln_pt,
const double &  time,
Vector< double > &  error,
Vector< double > &  norm 
)
inlinevirtual

Plot the error when compared against a given time-dependent exact solution $ {\bf f}(t,{\bf x}) $. Also calculates the norm of the error and that of the exact solution. The version with vectors of norms and errors so that different variables' norms and errors can be returned individually.

Reimplemented in oomph::ScalarAdvectionEquations< DIM >, oomph::EulerEquations< DIM >, oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::PoroelasticityEquations< DIM >, oomph::PoroelasticityEquations< 2 >, and oomph::AxisymmetricPoroelasticityEquations.

Definition at line 3311 of file elements.h.

References oomph::Global_string_for_annotation::string().

◆ compute_physical_size()

virtual double oomph::FiniteElement::compute_physical_size ( ) const
inlinevirtual

Broken virtual function to compute the actual size (taking into account factors such as 2pi or radii the integrand) – such function can only be implemented on an equation-by-equation basis.

Reimplemented in oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations, oomph::AxisymmetricPVDEquationsWithPressure, oomph::AxisymmetricPVDEquations, and oomph::AxisymmetricNavierStokesEquations.

Definition at line 2825 of file elements.h.

◆ construct_boundary_node() [1/2]

virtual Node* oomph::FiniteElement::construct_boundary_node ( const unsigned &  n)
inlinevirtual

Construct the local node n as a boundary node; that is a node that MAY be placed on a mesh boundary and return a pointer to the newly created node object.

Reimplemented in oomph::SolidFiniteElement, oomph::ElementWithSpecificMovingNodes< ELEMENT, NODE_TYPE >, oomph::ElementWithSpecificMovingNodes< ELEMENT, SpineNode >, oomph::ElementWithSpecificMovingNodes< ELEMENT, AlgebraicNode >, and oomph::ElementWithSpecificMovingNodes< ELEMENT, MacroElementNodeUpdateNode >.

Definition at line 2538 of file elements.h.

References Nnodal_position_type, Nodal_dimension, node_pt(), and required_nvalue().

Referenced by oomph::GmshTetMesh< ELEMENT >::build_from_scaffold(), oomph::TetgenMesh< ELEMENT >::build_from_scaffold(), oomph::TriangleMesh< ELEMENT >::build_from_scaffold(), oomph::BrickFromTetMesh< ELEMENT >::build_mesh(), oomph::ChannelWithLeafletMesh< ELEMENT >::ChannelWithLeafletMesh(), oomph::DGElement::construct_boundary_nodes_and_faces(), oomph::Multi_domain_functions::construct_new_external_halo_node_helper(), oomph::Missing_masters_functions::construct_new_external_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::construct_new_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::construct_new_node_load_balance_helper(), oomph::Mesh::convert_to_boundary_node(), oomph::GeompackQuadScaffoldMesh::GeompackQuadScaffoldMesh(), oomph::QuarterCircleSectorMesh< ELEMENT >::QuarterCircleSectorMesh(), oomph::TetMeshBase::split_elements_in_corners(), oomph::TetgenScaffoldMesh::TetgenScaffoldMesh(), and oomph::TriangleScaffoldMesh::TriangleScaffoldMesh().

◆ construct_boundary_node() [2/2]

virtual Node* oomph::FiniteElement::construct_boundary_node ( const unsigned &  n,
TimeStepper *const &  time_stepper_pt 
)
inlinevirtual

Construct the local node n, including storage for history values required by timestepper, as a boundary node; that is a node that MAY be placed on a mesh boundary and return a pointer to the newly created node object.

Reimplemented in oomph::SolidFiniteElement, oomph::ElementWithSpecificMovingNodes< ELEMENT, NODE_TYPE >, oomph::ElementWithSpecificMovingNodes< ELEMENT, SpineNode >, oomph::ElementWithSpecificMovingNodes< ELEMENT, AlgebraicNode >, and oomph::ElementWithSpecificMovingNodes< ELEMENT, MacroElementNodeUpdateNode >.

Definition at line 2552 of file elements.h.

References Nnodal_position_type, Nodal_dimension, node_pt(), required_nvalue(), and oomph::GeomObject::time_stepper_pt().

◆ construct_node() [1/2]

virtual Node* oomph::FiniteElement::construct_node ( const unsigned &  n)
inlinevirtual

Construct the local node n and return a pointer to the newly created node object.

Reimplemented in oomph::SolidFiniteElement, oomph::ElementWithSpecificMovingNodes< ELEMENT, NODE_TYPE >, oomph::ElementWithSpecificMovingNodes< ELEMENT, SpineNode >, oomph::ElementWithSpecificMovingNodes< ELEMENT, AlgebraicNode >, and oomph::ElementWithSpecificMovingNodes< ELEMENT, MacroElementNodeUpdateNode >.

Definition at line 2509 of file elements.h.

References Nnodal_position_type, Nodal_dimension, node_pt(), and required_nvalue().

Referenced by oomph::GmshTetMesh< ELEMENT >::build_from_scaffold(), oomph::TetgenMesh< ELEMENT >::build_from_scaffold(), oomph::TriangleMesh< ELEMENT >::build_from_scaffold(), oomph::BrickFromTetMesh< ELEMENT >::build_mesh(), oomph::DGElement::construct_boundary_nodes_and_faces(), oomph::Multi_domain_functions::construct_new_external_halo_node_helper(), oomph::Missing_masters_functions::construct_new_external_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::construct_new_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::construct_new_node_load_balance_helper(), oomph::DGElement::construct_nodes_and_faces(), oomph::FullCircleMesh< ELEMENT >::FullCircleMesh(), oomph::GeompackQuadScaffoldMesh::GeompackQuadScaffoldMesh(), oomph::LinearElasticitySmoothMesh< LINEAR_ELASTICITY_ELEMENT >::operator()(), oomph::PoissonSmoothMesh< POISSON_ELEMENT >::operator()(), oomph::QuarterCircleSectorMesh< ELEMENT >::QuarterCircleSectorMesh(), oomph::QuarterTubeMesh< ELEMENT >::QuarterTubeMesh(), oomph::RectangleWithHoleMesh< ELEMENT >::RectangleWithHoleMesh(), oomph::SimpleRectangularTriMesh< ELEMENT >::SimpleRectangularTriMesh(), oomph::TetMeshBase::split_elements_in_corners(), oomph::TetgenScaffoldMesh::TetgenScaffoldMesh(), oomph::TriangleScaffoldMesh::TriangleScaffoldMesh(), oomph::TubeMesh< ELEMENT >::TubeMesh(), and oomph::WomersleyMesh< WOMERSLEY_ELEMENT >::WomersleyMesh().

◆ construct_node() [2/2]

virtual Node* oomph::FiniteElement::construct_node ( const unsigned &  n,
TimeStepper *const &  time_stepper_pt 
)
inlinevirtual

◆ d2shape_eulerian()

double oomph::FiniteElement::d2shape_eulerian ( const Vector< double > &  s,
Shape psi,
DShape dpsidx,
DShape d2psidx 
) const

Compute the geometric shape functions and also first and second derivatives w.r.t. global coordinates at local coordinate s; Returns Jacobian of mapping from global to local coordinates. Numbering: 1D: d2psidx(i,0) = $ d^2 \psi_j / d x^2 $ 2D: d2psidx(i,0) = $ \partial^2 \psi_j / \partial x_0^2 $ d2psidx(i,1) = $ \partial^2 \psi_j / \partial x_1^2 $ d2psidx(i,2) = $ \partial^2 \psi_j / \partial x_0 \partial x_1 $ 3D: d2psidx(i,0) = $ \partial^2 \psi_j / \partial x_0^2 $ d2psidx(i,1) = $ \partial^2 \psi_j / \partial x_1^2 $ d2psidx(i,2) = $ \partial^2 \psi_j / \partial x_2^2 $ d2psidx(i,3) = $ \partial^2 \psi_j / \partial x_0 \partial x_1 $ d2psidx(i,4) = $ \partial^2 \psi_j / \partial x_0 \partial x_2 $ d2psidx(i,5) = $ \partial^2 \psi_j / \partial x_1 \partial x_2 $.

Compute the geometric shape functions and also first and second derivatives w.r.t. global coordinates at local coordinate s; Also returns Jacobian of mapping from global to local coordinates. Numbering: 1D: d2psidx(i,0) = $ d^2 \psi_j / d x^2 $ 2D: d2psidx(i,0) = $ \partial^2 \psi_j / \partial x_0^2 $ d2psidx(i,1) = $ \partial^2 \psi_j / \partial x_1^2 $ d2psidx(i,2) = $ \partial^2 \psi_j / \partial x_0 \partial x_1 $ 3D: d2psidx(i,0) = $ \partial^2 \psi_j / \partial x_0^2 $ d2psidx(i,1) = $ \partial^2 \psi_j / \partial x_1^2 $ d2psidx(i,2) = $ \partial^2 \psi_j / \partial x_2^2 $ d2psidx(i,3) = $ \partial^2 \psi_j / \partial x_0 \partial x_1 $ d2psidx(i,4) = $ \partial^2 \psi_j / \partial x_0 \partial x_2 $ d2psidx(i,5) = $ \partial^2 \psi_j / \partial x_1 \partial x_2 $.

Definition at line 3448 of file elements.cc.

References assemble_local_to_eulerian_jacobian2(), d2shape_local(), dim(), local_to_eulerian_mapping(), N2deriv, s, and transform_second_derivatives().

◆ d2shape_eulerian_at_knot()

double oomph::FiniteElement::d2shape_eulerian_at_knot ( const unsigned &  ipt,
Shape psi,
DShape dpsidx,
DShape d2psidx 
) const
virtual

Return the geometric shape functions and also first and second derivatives w.r.t. global coordinates at ipt-th integration point. Numbering: 1D: d2psidx(i,0) = $ d^2 \psi_j / d s^2 $ 2D: d2psidx(i,0) = $ \partial^2 \psi_j / \partial x_0^2 $ d2psidx(i,1) = $ \partial^2 \psi_j / \partial x_1^2 $ d2psidx(i,2) = $ \partial^2 \psi_j / \partial x_0 \partial x_1 $ 3D: d2psidx(i,0) = $ \partial^2 \psi_j / \partial x_0^2 $ d2psidx(i,1) = $ \partial^2 \psi_j / \partial x_1^2 $ d2psidx(i,2) = $ \partial^2 \psi_j / \partial x_2^2 $ d2psidx(i,3) = $ \partial^2 \psi_j / \partial x_0 \partial x_1 $ d2psidx(i,4) = $ \partial^2 \psi_j / \partial x_0 \partial x_2 $ d2psidx(i,5) = $ \partial^2 \psi_j / \partial x_1 \partial x_2 $.

Compute the geometric shape functions and also first and second derivatives w.r.t. global coordinates at ipt-th integration point Returns Jacobian of mapping from global to local coordinates. This is the most general version, may be overloaded, if desired. Numbering: 1D: d2psidx(i,0) = $ d^2 \psi_j / d x^2 $ 2D: d2psidx(i,0) = $ \partial^2 \psi_j / \partial x_0^2 $ d2psidx(i,1) = $ \partial^2 \psi_j / \partial x_1^2 $ d2psidx(i,2) = $ \partial^2 \psi_j / \partial x_0 \partial x_1 $ 3D: d2psidx(i,0) = $ \partial^2 \psi_j / \partial x_0^2 $ d2psidx(i,1) = $ \partial^2 \psi_j / \partial x_1^2 $ d2psidx(i,2) = $ \partial^2 \psi_j / \partial x_2^2 $ d2psidx(i,3) = $ \partial^2 \psi_j / \partial x_0 \partial x_1 $ d2psidx(i,4) = $ \partial^2 \psi_j / \partial x_0 \partial x_2 $ d2psidx(i,5) = $ \partial^2 \psi_j / \partial x_1 \partial x_2 $.

Reimplemented in oomph::StorableShapeElementBase.

Definition at line 3502 of file elements.cc.

References assemble_local_to_eulerian_jacobian2(), d2shape_local_at_knot(), dim(), local_to_eulerian_mapping(), N2deriv, and transform_second_derivatives().

Referenced by oomph::StorableShapeElementBase::d2shape_eulerian_at_knot(), and oomph::StorableShapeElementBase::pre_compute_d2shape_eulerian_at_knots().

◆ d2shape_local()

virtual void oomph::FiniteElement::d2shape_local ( const Vector< double > &  s,
Shape psi,
DShape dpsids,
DShape d2psids 
) const
inlinevirtual

Function to compute the geometric shape functions and also first and second derivatives w.r.t. local coordinates at local coordinate s. This function must be overloaded for each specific geometric element (if required). (Broken virtual function — specifies the interface). Numbering: 1D: d2psids(i,0) = $ d^2 \psi_j / ds^2 $ 2D: d2psids(i,0) = $ \partial^2 \psi_j / \partial s_0^2 $ d2psids(i,1) = $ \partial^2 \psi_j / \partial s_1^2 $ d2psids(i,2) = $ \partial^2 \psi_j / \partial s_0 \partial s_1 $ 3D: d2psids(i,0) = $ \partial^2 \psi_j / \partial s_0^2 $ d2psids(i,1) = $ \partial^2 \psi_j / \partial s_1^2 $ d2psids(i,2) = $ \partial^2 \psi_j / \partial s_2^2 $ d2psids(i,3) = $ \partial^2 \psi_j / \partial s_0 \partial s_1 $ d2psids(i,4) = $ \partial^2 \psi_j / \partial s_0 \partial s_2 $ d2psids(i,5) = $ \partial^2 \psi_j / \partial s_1 \partial s_2 $.

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >, oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >, oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, and oomph::QHermiteElement< DIM - 1 >.

Definition at line 2016 of file elements.h.

Referenced by d2shape_eulerian(), oomph::SolidFiniteElement::d2shape_lagrangian(), and d2shape_local_at_knot().

◆ d2shape_local_at_knot()

void oomph::FiniteElement::d2shape_local_at_knot ( const unsigned &  ipt,
Shape psi,
DShape dpsids,
DShape d2psids 
) const
virtual

Return the geometric shape function and its first and second derivatives w.r.t. the local coordinates at the ipt-th integration point. Numbering: 1D: d2psids(i,0) = $ d^2 \psi_j / ds^2 $ 2D: d2psids(i,0) = $ \partial^2 \psi_j / \partial s_0^2 $ d2psids(i,1) = $ \partial^2 \psi_j / \partial s_1^2 $ d2psids(i,2) = $ \partial^2 \psi_j / \partial s_0 \partial s_1 $ 3D: d2psids(i,0) = $ \partial^2 \psi_j / \partial s_0^2 $ d2psids(i,1) = $ \partial^2 \psi_j / \partial s_1^2 $ d2psids(i,2) = $ \partial^2 \psi_j / \partial s_2^2 $ d2psids(i,3) = $ \partial^2 \psi_j / \partial s_0 \partial s_1 $ d2psids(i,4) = $ \partial^2 \psi_j / \partial s_0 \partial s_2 $ d2psids(i,5) = $ \partial^2 \psi_j / \partial s_1 \partial s_2 $.

Calculate the shape function and its first and second derivatives w.r.t. local coordinates at the ipt-th integration point. Numbering: 1D: d2psids(i,0) = $ d^2 \psi_j / d s^2 $ 2D: d2psids(i,0) = $ \partial^2 \psi_j / \partial s_0^2 $ d2psids(i,1) = $ \partial^2 \psi_j / \partial s_1^2 $ d2psids(i,2) = $ \partial^2 \psi_j / \partial s_0 \partial s_1 $ 3D: d2psids(i,0) = $ \partial^2 \psi_j / \partial s_0^2 $ d2psids(i,1) = $ \partial^2 \psi_j / \partial s_1^2 $ d2psids(i,2) = $ \partial^2 \psi_j / \partial s_2^2 $ d2psids(i,3) = $ \partial^2 \psi_j / \partial s_0 \partial s_1 $ d2psids(i,4) = $ \partial^2 \psi_j / \partial s_0 \partial s_2 $ d2psids(i,5) = $ \partial^2 \psi_j / \partial s_1 \partial s_2 $.

Reimplemented in oomph::StorableShapeElementBase.

Definition at line 3274 of file elements.cc.

References d2shape_local(), dim(), i, integral_pt(), oomph::Integral::knot(), and s.

Referenced by d2shape_eulerian_at_knot(), oomph::SolidFiniteElement::d2shape_lagrangian_at_knot(), oomph::StorableShapeElementBase::d2shape_local_at_knot(), and oomph::StorableShapeElementBase::pre_compute_d2shape_local_at_knots().

◆ d_dshape_eulerian_dnodal_coordinates()

void oomph::FiniteElement::d_dshape_eulerian_dnodal_coordinates ( const double &  det_jacobian,
const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  djacobian_dX,
const DenseMatrix< double > &  inverse_jacobian,
const DShape dpsids,
RankFourTensor< double > &  d_dpsidx_dX 
) const
protectedvirtual

A template-free interface that calculates the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions $ \psi_j $ w.r.t. the global eulerian coordinates $ x_i $. I.e. this function calculates.

Template-free interface calculating the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions $ \psi_j $ w.r.t. the global eulerian coordinates $ x_i $. I.e. this function calculates.

\[ \frac{\partial}{\partial X_{pq}} \left( \frac{\partial \psi_j}{\partial x_i} \right). \]

To do this it requires the determinant of the jacobian mapping, its derivative w.r.t. the nodal coordinates $ X_{pq} $, the inverse jacobian and the derivatives of the shape functions w.r.t. the local coordinates. The result is returned as a tensor of rank four. Numbering: d_dpsidx_dX(p,q,j,i) = $ \frac{\partial}{\partial X_{pq}} \left( \frac{\partial \psi_j}{\partial x_i} \right) $ By default the function will use the dimension of the element to call the correct d_dshape_eulerian_dnodal_coordinates_templated_helper(..) function. This should be overloaded for efficiency (removal of a switch statement) in specific elements.

\[ \frac{\partial}{\partial X_{pq}} \left( \frac{\partial \psi_j}{\partial x_i} \right). \]

To do this it requires the determinant of the jacobian mapping, its derivative w.r.t. the nodal coordinates $ X_{pq} $, the inverse jacobian and the derivatives of the shape functions w.r.t. the local coordinates. The result is returned as a tensor of rank four. Numbering: d_dpsidx_dX(p,q,j,i) = $ \frac{\partial}{\partial X_{pq}} \left( \frac{\partial \psi_j}{\partial x_i} \right) $ This function is slightly inefficient, given that it uses a switch statement. It can always be overloaded in specific geometric elements, for efficiency reasons.

Definition at line 2749 of file elements.cc.

References dim(), oomph::RankFourTensor< T >::nindex1(), oomph::RankFourTensor< T >::nindex2(), oomph::RankFourTensor< T >::nindex3(), oomph::RankFourTensor< T >::nindex4(), and nnode().

Referenced by dshape_eulerian_at_knot(), oomph::AxisymmetricNavierStokesEquations::interpolated_d_dudx_dX_axi_nst(), and oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_d_dudx_dX_axi_nst().

◆ d_dshape_eulerian_dnodal_coordinates_templated_helper() [1/5]

template<>
void oomph::FiniteElement::d_dshape_eulerian_dnodal_coordinates_templated_helper ( const double &  det_jacobian,
const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  djacobian_dX,
const DenseMatrix< double > &  inverse_jacobian,
const DShape dpsids,
RankFourTensor< double > &  d_dpsidx_dX 
) const
protected

Zero-d specialisation of function to calculate the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions w.r.t. the global eulerian coordinates $ x_i $.

Definition at line 2317 of file elements.cc.

References oomph::oomph_info.

◆ d_dshape_eulerian_dnodal_coordinates_templated_helper() [2/5]

template<>
void oomph::FiniteElement::d_dshape_eulerian_dnodal_coordinates_templated_helper ( const double &  det_jacobian,
const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  djacobian_dX,
const DenseMatrix< double > &  inverse_jacobian,
const DShape dpsids,
RankFourTensor< double > &  d_dpsidx_dX 
) const
protected

One-d specialisation of function to calculate the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions w.r.t. the global eulerian coordinates $ x_i $.

Definition at line 2340 of file elements.cc.

References nnode().

◆ d_dshape_eulerian_dnodal_coordinates_templated_helper() [3/5]

template<>
void oomph::FiniteElement::d_dshape_eulerian_dnodal_coordinates_templated_helper ( const double &  det_jacobian,
const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  djacobian_dX,
const DenseMatrix< double > &  inverse_jacobian,
const DShape dpsids,
RankFourTensor< double > &  d_dpsidx_dX 
) const
protected

Two-d specialisation of function to calculate the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions w.r.t. the global eulerian coordinates $ x_i $.

Definition at line 2372 of file elements.cc.

References nnode().

◆ d_dshape_eulerian_dnodal_coordinates_templated_helper() [4/5]

template<>
void oomph::FiniteElement::d_dshape_eulerian_dnodal_coordinates_templated_helper ( const double &  det_jacobian,
const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  djacobian_dX,
const DenseMatrix< double > &  inverse_jacobian,
const DShape dpsids,
RankFourTensor< double > &  d_dpsidx_dX 
) const
protected

Three-d specialisation of function to calculate the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions w.r.t. the global eulerian coordinates $ x_i $.

Definition at line 2429 of file elements.cc.

References i, and nnode().

◆ d_dshape_eulerian_dnodal_coordinates_templated_helper() [5/5]

template<unsigned DIM>
void oomph::FiniteElement::d_dshape_eulerian_dnodal_coordinates_templated_helper ( const double &  det_jacobian,
const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  djacobian_dX,
const DenseMatrix< double > &  inverse_jacobian,
const DShape dpsids,
RankFourTensor< double > &  d_dpsidx_dX 
) const
protected

Calculate the derivative w.r.t. the nodal coordinates $ X_{pq} $ of the derivative of the shape functions w.r.t. the global eulerian coordinates $ x_i $, using the determinant of the jacobian mapping, its derivative w.r.t. the nodal coordinates $ X_{pq} $, the inverse jacobian and the derivatives of the shape functions w.r.t. the local coordinates. The result is returned as a tensor of rank four. Numbering: d_dpsidx_dX(p,q,j,i) = $ \frac{\partial}{\partial X_{pq}} \left( \frac{\partial \psi_j}{\partial x_i} \right) $ This function is templated by the dimension of the element.

◆ describe_local_dofs()

void oomph::FiniteElement::describe_local_dofs ( std::ostream &  out,
const std::string &  current_string 
) const
virtual

Function to describe the local dofs of the element[s]. The ostream specifies the output stream to which the description is written; the string stores the currently assembled output that is ultimately written to the output stream by Data::describe_dofs(...); it is typically built up incrementally as we descend through the call hierarchy of this function when called from Problem::describe_dofs(...)

Function to describe the local dofs of the element. The ostream specifies the output stream to which the description is written; the string stores the currently assembled output that is ultimately written to the output stream by Data::describe_dofs(...); it is typically built up incrementally as we descend through the call hierarchy of this function when called from Problem::describe_dofs(...)

Reimplemented from oomph::GeneralisedElement.

Reimplemented in oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >, oomph::RefineableQSpectralPoissonElement< DIM, NNODE_1D >, oomph::SpectralElement, oomph::ProjectableElement< ELEMENT >, oomph::ProjectableElement< FVK_ELEMENT >, oomph::ProjectableElement< AXISYM_LINEAR_ELAST_ELEMENT >, oomph::ProjectableElement< UNSTEADY_HEAT_ELEMENT >, oomph::ProjectableElement< LINEAR_ELAST_ELEMENT >, oomph::ProjectableElement< CROUZEIX_RAVIART_ELEMENT >, oomph::ProjectableElement< HELMHOLTZ_ELEMENT >, oomph::ProjectableElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >, oomph::ProjectableElement< TAYLOR_HOOD_ELEMENT >, oomph::ProjectableElement< PVD_ELEMENT >, oomph::ProjectableElement< ADR_ELEMENT >, oomph::ProjectableElement< DARCY_ELEMENT >, oomph::ProjectableElement< POISSON_ELEMENT >, oomph::ProjectableElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >, oomph::ProjectableElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >, oomph::FSIWallElement, oomph::FaceElementAsGeomObject< ELEMENT >, oomph::SolidFiniteElement, oomph::ElementWithSpecificMovingNodes< ELEMENT, NODE_TYPE >, oomph::ElementWithSpecificMovingNodes< ELEMENT, SpineNode >, oomph::ElementWithSpecificMovingNodes< ELEMENT, AlgebraicNode >, oomph::ElementWithSpecificMovingNodes< ELEMENT, MacroElementNodeUpdateNode >, oomph::ElementWithMovingNodes, and oomph::ElementWithExternalElement.

Definition at line 1709 of file elements.cc.

References oomph::GeneralisedElement::describe_local_dofs(), and describe_nodal_local_dofs().

Referenced by oomph::ElementWithMovingNodes::describe_local_dofs(), oomph::SolidFiniteElement::describe_local_dofs(), oomph::FSIWallElement::describe_local_dofs(), oomph::SpectralElement::describe_local_dofs(), and oomph::RefineableQSpectralPoissonElement< DIM, NNODE_1D >::describe_local_dofs().

◆ describe_nodal_local_dofs()

void oomph::FiniteElement::describe_nodal_local_dofs ( std::ostream &  out,
const std::string &  current_string 
) const
virtual

Function to describe the local dofs of the element[s]. The ostream specifies the output stream to which the description is written; the string stores the currently assembled output that is ultimately written to the output stream by Data::describe_dofs(...); it is typically built up incrementally as we descend through the call hierarchy of this function when called from Problem::describe_dofs(...)

specifies the output stream to which the description is written; the string stores the currently assembled output that is ultimately written to the output stream by Data::describe_dofs(...); it is typically built up incrementally as we descend through the call hierarchy of this function when called from Problem::describe_dofs(...)

Definition at line 1727 of file elements.cc.

References oomph::Data::describe_dofs(), nnode(), node_pt(), and oomph::Global_string_for_annotation::string().

Referenced by describe_local_dofs(), and oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::describe_local_dofs().

◆ dim()

unsigned oomph::FiniteElement::dim ( ) const
inline

Return the spatial dimension of the element, i.e. the number of local coordinates required to parametrise its geometry.

Definition at line 2611 of file elements.h.

References Elemental_dimension.

Referenced by oomph::TreeBasedRefineableMeshBase::adapt_mesh(), oomph::DGFaceElement::add_flux_contributions(), oomph::ImposeImpenetrabilityElement< ELEMENT >::additional_ndof_types(), assemble_eulerian_base_vectors(), oomph::RefineableElement::assemble_eulerian_base_vectors(), assemble_local_to_eulerian_jacobian(), oomph::RefineableElement::assemble_local_to_eulerian_jacobian(), assemble_local_to_eulerian_jacobian2(), oomph::RefineableElement::assemble_local_to_eulerian_jacobian2(), oomph::SolidFiniteElement::assemble_local_to_lagrangian_jacobian(), oomph::RefineableSolidElement::assemble_local_to_lagrangian_jacobian(), oomph::SolidFiniteElement::assemble_local_to_lagrangian_jacobian2(), oomph::RefineableSolidElement::assemble_local_to_lagrangian_jacobian2(), oomph::Multi_domain_functions::aux_setup_multi_domain_interaction(), oomph::AxisymmetricLinearElasticityEquationsBase::body_force(), oomph::LinearElasticityEquationsBase< DIM >::body_force(), oomph::PMLTimeHarmonicLinearElasticityEquationsBase< DIM >::body_force(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquationsBase::body_force(), oomph::TimeHarmonicLinearElasticityEquationsBase< DIM >::body_force(), oomph::PVDEquationsBase< DIM >::body_force(), oomph::MeshAsGeomObject::build_it(), oomph::OneDMesh< ELEMENT >::check_1d(), oomph::Mesh::check_inverted_elements(), check_J_eulerian_at_knots(), oomph::FaceElement::check_J_eulerian_at_knots(), oomph::SolidFiniteElement::compute_norm(), oomph::AxisymmetricNavierStokesEquations::compute_physical_size(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::compute_physical_size(), oomph::Multi_domain_functions::construct_new_external_halo_master_node_helper(), oomph::Missing_masters_functions::construct_new_external_halo_master_node_helper(), oomph::FaceElement::continuous_tangent_and_outer_unit_normal(), oomph::Multi_domain_functions::create_external_halo_elements(), d2shape_eulerian(), d2shape_eulerian_at_knot(), oomph::SolidFiniteElement::d2shape_lagrangian(), oomph::SolidFiniteElement::d2shape_lagrangian_at_knot(), d2shape_local_at_knot(), d_dshape_eulerian_dnodal_coordinates(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::data_values_of_field(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::data_values_of_field(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::data_values_of_field(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::data_values_of_field(), oomph::DGEulerFaceElement< ELEMENT >::DGEulerFaceElement(), oomph::DGEulerFaceReflectionElement< ELEMENT >::DGEulerFaceReflectionElement(), dJ_eulerian_at_knot(), dJ_eulerian_dnodal_coordinates(), oomph::Z2ErrorEstimator::doc_flux(), oomph::FSI_functions::doc_fsi(), oomph::NavierStokesSurfacePowerElement< ELEMENT >::drag_force(), dshape_eulerian(), dshape_eulerian_at_knot(), oomph::SolidFiniteElement::dshape_lagrangian(), oomph::SolidFiniteElement::dshape_lagrangian_at_knot(), dshape_local_at_knot(), oomph::Mesh::elemental_dimension(), oomph::FaceElementAsGeomObject< ELEMENT >::FaceElementAsGeomObject(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::ImposeImpenetrabilityElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::ImposeParallelOutflowElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::SolidFiniteElement::fill_in_generic_jacobian_for_solid_ic(), oomph::FluidInterfaceElement::fill_in_generic_residual_contribution_interface(), oomph::PointFluidInterfaceBoundingElement::fill_in_generic_residual_contribution_interface_boundary(), oomph::LineFluidInterfaceBoundingElement::fill_in_generic_residual_contribution_interface_boundary(), oomph::SolidFiniteElement::fill_in_jacobian_for_newmark_accel(), oomph::RefineableNavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::NavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::AxisymmetricPoroelasticityEquations::fluid_body_force(), oomph::PoroelasticityEquations< DIM >::force_fluid(), oomph::PoroelasticityEquations< DIM >::force_solid(), oomph::FpPressureAdvDiffRobinBCElement< ELEMENT >::FpPressureAdvDiffRobinBCElement(), oomph::FpPressureAdvDiffRobinBCMixedOrderSpaceTimeElement< ELEMENT >::FpPressureAdvDiffRobinBCMixedOrderSpaceTimeElement(), oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >::FpPressureAdvDiffRobinBCSpaceTimeElement(), oomph::FpPressureAdvectionDiffusionProblem< ELEMENT >::FpPressureAdvectionDiffusionProblem(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::FSIImposeDisplacementByLagrangeMultiplierElement(), oomph::MGSolver< DIM >::full_setup(), oomph::HelmholtzMGPreconditioner< DIM >::full_setup(), oomph::RefineableNavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::get_body_force_nst(), oomph::ImposeImpenetrabilityElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::ImposeParallelOutflowElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::NavierStokesSurfaceDragTorqueElement< ELEMENT >::get_drag_and_torque(), oomph::Z2ErrorEstimator::get_element_errors(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::get_field(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::get_field(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::get_flux(), oomph::NavierStokesSurfacePowerElement< ELEMENT >::get_kinetic_energy_flux(), oomph::NavierStokesSchurComplementPreconditioner::get_pressure_advection_diffusion_matrix(), oomph::NavierStokesSurfacePowerElement< ELEMENT >::get_rate_of_traction_work(), oomph::NavierStokesSurfacePowerElement< ELEMENT >::get_rate_of_traction_work_components(), oomph::Missing_masters_functions::get_required_master_nodal_information_helper(), oomph::Multi_domain_functions::get_required_master_nodal_information_helper(), oomph::NavierStokesSurfacePowerElement< ELEMENT >::get_volume_flux(), oomph::QSolidElementBase::get_x_and_xi(), oomph::QElementBase::get_x_from_macro_element(), oomph::PMLHelmholtzPowerElement< ELEMENT >::global_flux_contribution(), oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::global_flux_contribution_from_helmholtz(), oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::global_flux_contribution_from_solid(), oomph::HelmholtzBCElementBase< ELEMENT >::global_power_contribution(), oomph::PMLHelmholtzPowerElement< ELEMENT >::global_power_contribution(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::ImposeDisplacementByLagrangeMultiplierElement(), oomph::ImposeParallelOutflowElement< ELEMENT >::ImposeParallelOutflowElement(), oomph::SurfactantTransportInterfaceElement::integrate_c(), integrate_fct(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::interpolated_du_dt_nst(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::interpolated_du_dt_ust_heat(), oomph::FaceElement::interpolated_dxdt(), oomph::SolidFiniteElement::interpolated_dxids(), oomph::AxisymFoepplvonKarmanEquations::interpolated_stress(), oomph::FoepplvonKarmanEquations::interpolated_stress(), oomph::FaceElement::interpolated_x(), oomph::SolidFaceElement::interpolated_xi(), interpolated_zeta(), invert_jacobian_mapping(), J_eulerian(), oomph::FaceElement::J_eulerian(), J_eulerian_at_knot(), oomph::FaceElement::J_eulerian_at_knot(), oomph::ProjectableAdvectionDiffusionReactionElement< ADR_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableAxisymLinearElasticityElement< AXISYM_LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableDisplacementBasedFoepplvonKarmanElement< FVK_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableFoepplvonKarmanElement< FVK_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::jacobian_and_shape_of_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::jacobian_and_shape_of_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectablePoissonElement< POISSON_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::jacobian_and_shape_of_field(), oomph::QHermiteElement< DIM >::local_coord_is_valid(), oomph::QElementBase::local_coord_is_valid(), oomph::TElementBase::local_coord_is_valid(), oomph::FaceElement::local_coordinate_in_bulk(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::local_equation(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::local_equation(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::local_equation(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::local_equation(), local_to_eulerian_mapping(), local_to_eulerian_mapping_diagonal(), oomph::RefineableElement::local_to_eulerian_mapping_diagonal(), oomph::SolidFiniteElement::local_to_lagrangian_mapping(), oomph::SolidFiniteElement::local_to_lagrangian_mapping_diagonal(), oomph::RefineableSolidElement::local_to_lagrangian_mapping_diagonal(), locate_zeta(), oomph::Multi_domain_functions::locate_zeta_for_local_coordinates(), oomph::Multi_domain_functions::locate_zeta_for_missing_coordinates(), oomph::QHermiteElement< DIM >::move_local_coord_back_into_element(), oomph::QElementBase::move_local_coord_back_into_element(), oomph::TElementBase::move_local_coord_back_into_element(), oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >::NavierStokesMixedOrderSpaceTimeTractionElement(), oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >::NavierStokesSpaceTimeTractionElement(), oomph::NavierStokesTractionElement< ELEMENT >::NavierStokesTractionElement(), oomph::ImposeParallelOutflowElement< ELEMENT >::ndof_types(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::ndof_types(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::ndof_types(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nfields_for_projection(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nfields_for_projection(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::nfields_for_projection(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nfields_for_projection(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nfields_for_projection(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::nfields_for_projection(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::nfields_for_projection(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::nfields_for_projection(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nhistory_values_for_projection(), oomph::QElementBase::nnode_on_face(), oomph::Mesh::node_update(), oomph::DGEulerFaceElement< ELEMENT >::numerical_flux(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nvalue_of_field(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nvalue_of_field(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nvalue_of_field(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nvalue_of_field(), oomph::FaceElement::outer_unit_normal(), oomph::DummyFaceElement< ELEMENT >::output(), oomph::FluidInterfaceElement::output(), oomph::SurfactantTransportInterfaceElement::output(), oomph::NavierStokesSurfaceDragTorqueElement< ELEMENT >::output(), oomph::FSISolidTractionElement< ELEMENT, DIM >::output(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::PoissonFluxElement< ELEMENT >::output(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::ElementWithExternalElement::output_external_elements(), oomph::FaceElement::output_zeta(), oomph::TreeBasedRefineableMeshBase::p_adapt_mesh(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::point_output_data(), oomph::NavierStokesEquations< DIM >::point_output_data(), oomph::PoissonEquations< DIM >::point_output_data(), oomph::StorableShapeElementBase::pre_compute_d2shape_local_at_knots(), oomph::StorableShapeElementBase::pre_compute_dshape_local_at_knots(), oomph::RefineableImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::RefineableFSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::DGFaceElement::report_info(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::residual_for_projection(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::residual_for_projection(), oomph::ProjectableElement< ELEMENT >::residual_for_projection(), self_test(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::set_boundary_shape_geom_object_pt(), set_dimension(), oomph::QElementBase::set_macro_elem_pt(), oomph::NavierStokesSchurComplementPreconditioner::setup(), oomph::LineMeshBase::setup_boundary_element_info(), oomph::QuadMeshBase::setup_boundary_element_info(), oomph::TetMeshBase::setup_boundary_element_info(), oomph::TriangleMeshBase::setup_boundary_element_info(), oomph::HermiteQuadMesh< ELEMENT >::setup_boundary_element_info(), oomph::FourierDecomposedHelmholtzDtNMesh< ELEMENT >::setup_gamma(), oomph::HelmholtzDtNMesh< ELEMENT >::setup_gamma(), oomph::DGFaceElement::setup_neighbour_info(), oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >::shape_and_test_at_knot(), oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >::shape_and_test_at_knot(), shape_at_knot(), oomph::DGElement::slope_limit(), oomph::AxisymmetricPoroelasticityEquations::solid_body_force(), oomph::PVDEquationsWithPressure< DIM >::solid_pshape_at_knot(), oomph::SolidTractionElement< ELEMENT >::SolidTractionElement(), oomph::DarcyEquations< DIM >::source(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::square_of_l2_norm_of_error(), oomph::TreeBasedRefineableMeshBase::synchronise_nonhanging_nodes(), transform_derivatives(), transform_derivatives_diagonal(), transform_second_derivatives(), oomph::YoungLaplaceContactAngleElement< ELEMENT >::YoungLaplaceContactAngleElement(), oomph::FaceElement::zeta_nodal(), and oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::zeta_nodal().

◆ disable_ALE()

virtual void oomph::FiniteElement::disable_ALE ( )
inlinevirtual

This is an empty function that establishes a uniform interface for all (derived) elements that involve time-derivatives. Such elements are/should be implemented in ALE form to allow mesh motions. The additional expense associated with the computation of the mesh velocities is, of course, superfluous if the elements are used in problems in which the mesh is stationary. This function should therefore be overloaded in all derived elements that are formulated in ALE form to suppress the computation of the mesh velocities. The user disables the ALE functionality at his/her own risk! If the mesh does move after all, then the results will be wrong. Here we simply issue a warning message stating that the empty function has been called.

Reimplemented in oomph::UnsteadyHeatEquations< DIM >, oomph::SphericalNavierStokesEquations, oomph::SphericalAdvectionDiffusionEquations, oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::NavierStokesEquations< DIM >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, oomph::LinearisedNavierStokesEquations, oomph::LinearisedAxisymmetricNavierStokesEquations, oomph::GeneralisedNewtonianNavierStokesEquations< DIM >, oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations, oomph::AxisymmetricNavierStokesEquations, oomph::GeneralisedAxisymAdvectionDiffusionEquations, oomph::AxisymAdvectionDiffusionEquations, oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >, oomph::GeneralisedAdvectionDiffusionEquations< DIM >, and oomph::AdvectionDiffusionEquations< DIM >.

Definition at line 2408 of file elements.h.

◆ dJ_eulerian_at_knot()

double oomph::FiniteElement::dJ_eulerian_at_knot ( const unsigned &  ipt,
Shape psi,
DenseMatrix< double > &  djacobian_dX 
) const

Compute the geometric shape functions (psi) at integration point ipt. Return the determinant of the jacobian of the mapping (detJ). Additionally calculate the derivatives of "detJ" w.r.t. the nodal coordinates.

Definition at line 3354 of file elements.cc.

References dim(), dJ_eulerian_dnodal_coordinates(), dshape_local_at_knot(), local_to_eulerian_mapping(), and nnode().

◆ dJ_eulerian_dnodal_coordinates()

void oomph::FiniteElement::dJ_eulerian_dnodal_coordinates ( const DenseMatrix< double > &  jacobian,
const DShape dpsids,
DenseMatrix< double > &  djacobian_dX 
) const
protectedvirtual

A template-free interface that calculates the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij. To do this it requires the jacobian matrix and the derivatives of the shape functions w.r.t. the local coordinates. By default the function will use the dimension of the element to call the correct dJ_eulerian_dnodal_coordinates_templated_helper(..) function. This should be overloaded for efficiency (removal of a switch statement) in specific elements.

Template-free interface calculating the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij. This is slightly inefficient, given that it uses a switch statement. It can always be overloaded in specific geometric elements, for efficiency reasons.

Definition at line 2669 of file elements.cc.

References dim(), oomph::DenseMatrix< T >::ncol(), nnode(), and oomph::DenseMatrix< T >::nrow().

Referenced by dJ_eulerian_at_knot(), dshape_eulerian_at_knot(), oomph::AxisymmetricNavierStokesEquations::interpolated_d_dudx_dX_axi_nst(), and oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_d_dudx_dX_axi_nst().

◆ dJ_eulerian_dnodal_coordinates_templated_helper() [1/5]

template<>
void oomph::FiniteElement::dJ_eulerian_dnodal_coordinates_templated_helper ( const DenseMatrix< double > &  jacobian,
const DShape dpsids,
DenseMatrix< double > &  djacobian_dX 
) const
protected

Zero-d specialisation of function to calculate the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij.

Definition at line 2206 of file elements.cc.

References oomph::oomph_info.

◆ dJ_eulerian_dnodal_coordinates_templated_helper() [2/5]

template<>
void oomph::FiniteElement::dJ_eulerian_dnodal_coordinates_templated_helper ( const DenseMatrix< double > &  jacobian,
const DShape dpsids,
DenseMatrix< double > &  djacobian_dX 
) const
protected

One-d specialisation of function to calculate the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij.

Definition at line 2225 of file elements.cc.

References nnode().

◆ dJ_eulerian_dnodal_coordinates_templated_helper() [3/5]

template<>
void oomph::FiniteElement::dJ_eulerian_dnodal_coordinates_templated_helper ( const DenseMatrix< double > &  jacobian,
const DShape dpsids,
DenseMatrix< double > &  djacobian_dX 
) const
protected

Two-d specialisation of function to calculate the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij.

Definition at line 2245 of file elements.cc.

References nnode().

◆ dJ_eulerian_dnodal_coordinates_templated_helper() [4/5]

template<>
void oomph::FiniteElement::dJ_eulerian_dnodal_coordinates_templated_helper ( const DenseMatrix< double > &  jacobian,
const DShape dpsids,
DenseMatrix< double > &  djacobian_dX 
) const
protected

Three-d specialisation of function to calculate the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij.

Definition at line 2271 of file elements.cc.

References nnode().

◆ dJ_eulerian_dnodal_coordinates_templated_helper() [5/5]

template<unsigned DIM>
void oomph::FiniteElement::dJ_eulerian_dnodal_coordinates_templated_helper ( const DenseMatrix< double > &  jacobian,
const DShape dpsids,
DenseMatrix< double > &  djacobian_dX 
) const
protected

Calculate the derivative of the jacobian of a mapping with respect to the nodal coordinates X_ij using the jacobian matrix and the derivatives of the shape functions w.r.t. the local coordinates. This function is templated by the dimension of the element.

◆ dnodal_position_dt() [1/2]

double oomph::FiniteElement::dnodal_position_dt ( const unsigned &  n,
const unsigned &  i 
) const
inline

◆ dnodal_position_dt() [2/2]

double oomph::FiniteElement::dnodal_position_dt ( const unsigned &  n,
const unsigned &  j,
const unsigned &  i 
) const
inline

Return the i-th component of j-th derivative of nodal position: d^jx/dt^j at node n.

Definition at line 2340 of file elements.h.

References oomph::Node::dposition_dt(), i, and node_pt().

◆ dnodal_position_gen_dt() [1/2]

double oomph::FiniteElement::dnodal_position_gen_dt ( const unsigned &  j,
const unsigned &  n,
const unsigned &  k,
const unsigned &  i 
) const
inline

i-th component of j-th time derivative of the generalised position, dx(k,i)/dt at local node n. ‘Type’: k; Coordinate direction: i.

Definition at line 2379 of file elements.h.

References oomph::Node::dposition_gen_dt(), i, and node_pt().

◆ dnodal_position_gen_dt() [2/2]

double oomph::FiniteElement::dnodal_position_gen_dt ( const unsigned &  n,
const unsigned &  k,
const unsigned &  i 
) const
inline

i-th component of time derivative (velocity) of the generalised position, dx(k,i)/dt at local node n. ‘Type’: k; Coordinate direction: i.

Definition at line 2369 of file elements.h.

References oomph::Node::dposition_gen_dt(), i, and node_pt().

Referenced by oomph::KirchhoffLoveShellEquations::get_energy(), interpolated_dxdt(), and oomph::KirchhoffLoveShellEquations::load_rate_of_work().

◆ dposition_dt()

void oomph::FiniteElement::dposition_dt ( const Vector< double > &  zeta,
const unsigned &  t,
Vector< double > &  drdt 
)
inlinevirtual

Return the t-th time derivative of the parametrised position of the FiniteElement in its GeomObject incarnation: $ \frac{d^{t} dr(zeta)}{d t^{t}} $. Call the t-th time derivative of the FE-interpolated Eulerian coordinate.

Reimplemented from oomph::GeomObject.

Definition at line 2701 of file elements.h.

References interpolated_dxdt(), and t.

◆ dshape_eulerian()

double oomph::FiniteElement::dshape_eulerian ( const Vector< double > &  s,
Shape psi,
DShape dpsidx 
) const

Compute the geometric shape functions and also first derivatives w.r.t. global coordinates at local coordinate s; Returns Jacobian of mapping from global to local coordinates.

Compute the geometric shape functions and also first derivatives w.r.t. global coordinates at local coordinate s; Returns Jacobian of mapping from global to local coordinates. Most general form of the function, but may be over-loaded, if desired.

Definition at line 3298 of file elements.cc.

References dim(), dshape_local(), local_to_eulerian_mapping(), s, and transform_derivatives().

Referenced by oomph::Mesh::check_inverted_elements(), oomph::AxisymmetricQCrouzeixRaviartElement::dshape_and_dtest_eulerian_axi_nst(), oomph::AxisymmetricQTaylorHoodElement::dshape_and_dtest_eulerian_axi_nst(), oomph::AxisymmetricTCrouzeixRaviartElement::dshape_and_dtest_eulerian_axi_nst(), oomph::AxisymmetricTTaylorHoodElement::dshape_and_dtest_eulerian_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement::dshape_and_dtest_eulerian_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement::dshape_and_dtest_eulerian_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement::dshape_and_dtest_eulerian_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::dshape_and_dtest_eulerian_axi_nst(), oomph::LinearisedAxisymmetricQCrouzeixRaviartElement::dshape_and_dtest_eulerian_linearised_axi_nst(), oomph::LinearisedAxisymmetricQTaylorHoodElement::dshape_and_dtest_eulerian_linearised_axi_nst(), oomph::LinearisedQCrouzeixRaviartElement::dshape_and_dtest_eulerian_linearised_nst(), oomph::LinearisedQTaylorHoodElement::dshape_and_dtest_eulerian_linearised_nst(), oomph::QSphericalCrouzeixRaviartElement::dshape_and_dtest_eulerian_spherical_nst(), oomph::QSphericalTaylorHoodElement::dshape_and_dtest_eulerian_spherical_nst(), oomph::PolarNavierStokesEquations::full_output(), oomph::SphericalNavierStokesEquations::full_output(), oomph::PoissonEquations< DIM >::get_dflux_dnodal_u(), oomph::AdvectionDiffusionEquations< DIM >::get_flux(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::get_flux(), oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >::get_flux(), oomph::AxisymAdvectionDiffusionEquations::get_flux(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::get_flux(), oomph::LinearWaveEquations< DIM >::get_flux(), oomph::PoissonEquations< DIM >::get_flux(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::get_flux(), oomph::SphericalAdvectionDiffusionEquations::get_flux(), oomph::SteadyAxisymAdvectionDiffusionEquations::get_flux(), oomph::UnsteadyHeatEquations< DIM >::get_flux(), oomph::WomersleyEquations< DIM >::get_flux(), oomph::YoungLaplaceEquations::get_flux(), oomph::FourierDecomposedHelmholtzEquations::get_flux(), oomph::HelmholtzEquations< DIM >::get_flux(), oomph::PMLFourierDecomposedHelmholtzEquations::get_flux(), oomph::PMLHelmholtzEquations< DIM >::get_flux(), oomph::AxisymFoepplvonKarmanEquations::get_gradient_of_deflection(), oomph::DisplacementBasedFoepplvonKarmanEquations::get_gradient_of_deflection(), oomph::FoepplvonKarmanEquations::get_gradient_of_deflection(), oomph::DisplacementBasedFoepplvonKarmanEquations::get_gradient_of_field(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::get_strain(), oomph::DisplacementBasedFoepplvonKarmanEquations::get_stress_and_strain_for_output(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::get_total_flux(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::get_total_flux(), oomph::SphericalNavierStokesEquations::get_vorticity(), oomph::SpectralPeriodicOrbitElement< NNODE_1D >::get_Z2_flux(), oomph::RefineableSpaceTimeNavierStokesEquations< DIM >::get_Z2_flux(), oomph::RefineableSpaceTimeNavierStokesMixedOrderEquations< DIM >::get_Z2_flux(), oomph::RefineableSpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::get_Z2_flux(), oomph::RefineableSpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::get_Z2_flux(), oomph::AxisymmetricPoroelasticityEquations::interpolated_div_du_dt(), oomph::AxisymmetricPoroelasticityEquations::interpolated_div_u(), oomph::SpaceTimeNavierStokesEquations< DIM >::interpolated_du_dt_nst(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::interpolated_du_dt_ust_heat(), oomph::BiharmonicEquations< DIM >::interpolated_dudx(), oomph::AxisymmetricNavierStokesEquations::interpolated_dudx_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_dudx_axi_nst(), oomph::NavierStokesEquations< DIM >::interpolated_dudx_nst(), oomph::PolarNavierStokesEquations::interpolated_dudx_pnst(), oomph::SphericalNavierStokesEquations::interpolated_dudx_spherical_nst(), oomph::AxisymFoepplvonKarmanEquations::interpolated_stress(), oomph::FoepplvonKarmanEquations::interpolated_stress(), oomph::ProjectableAxisymLinearElasticityElement< AXISYM_LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::PeriodicOrbitEquations::orbit_output(), oomph::AxisymmetricNavierStokesEquations::strain_rate(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::strain_rate(), oomph::LinearisedAxisymmetricNavierStokesEquations::strain_rate(), oomph::PolarNavierStokesEquations::strain_rate(), oomph::SphericalNavierStokesEquations::strain_rate(), oomph::LinearisedNavierStokesEquations::strain_rate(), and oomph::PolarNavierStokesEquations::strain_rate_by_r().

◆ dshape_eulerian_at_knot() [1/2]

double oomph::FiniteElement::dshape_eulerian_at_knot ( const unsigned &  ipt,
Shape psi,
DShape dpsi,
DenseMatrix< double > &  djacobian_dX,
RankFourTensor< double > &  d_dpsidx_dX 
) const
virtual

Compute the geometric shape functions (psi) and first derivatives w.r.t. global coordinates (dpsidx) at the ipt-th integration point. Return the determinant of the jacobian of the mapping (detJ). Additionally calculate the derivatives of both "detJ" and "dpsidx" w.r.t. the nodal coordinates.

Compute the geometric shape functions (psi) and first derivatives w.r.t. global coordinates (dpsidx) at integration point ipt. Return the determinant of the jacobian of the mapping (detJ). Additionally calculate the derivatives of both "detJ" and "dpsidx" w.r.t. the nodal coordinates. Most general form of function, but may be over-loaded if desired.

Definition at line 3390 of file elements.cc.

References d_dshape_eulerian_dnodal_coordinates(), dim(), dJ_eulerian_dnodal_coordinates(), dshape_local_at_knot(), local_to_eulerian_mapping(), and transform_derivatives().

◆ dshape_eulerian_at_knot() [2/2]

double oomph::FiniteElement::dshape_eulerian_at_knot ( const unsigned &  ipt,
Shape psi,
DShape dpsidx 
) const
virtual

Return the geometric shape functions and also first derivatives w.r.t. global coordinates at the ipt-th integration point.

Compute the geometric shape functions and also first derivatives w.r.t. global coordinates at integration point ipt. Most general form of function, but may be over-loaded if desired.

Reimplemented in oomph::StorableShapeElementBase.

Definition at line 3325 of file elements.cc.

References dim(), dshape_local_at_knot(), local_to_eulerian_mapping(), and transform_derivatives().

Referenced by check_J_eulerian_at_knots(), oomph::EulerEquations< DIM >::compute_error(), oomph::ScalarAdvectionEquations< DIM >::compute_error(), oomph::SphericalNavierStokesEquations::d_kin_energy_dt(), oomph::AxisymmetricQCrouzeixRaviartElement::dshape_and_dtest_eulerian_at_knot_axi_nst(), oomph::AxisymmetricQTaylorHoodElement::dshape_and_dtest_eulerian_at_knot_axi_nst(), oomph::AxisymmetricTCrouzeixRaviartElement::dshape_and_dtest_eulerian_at_knot_axi_nst(), oomph::AxisymmetricTTaylorHoodElement::dshape_and_dtest_eulerian_at_knot_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement::dshape_and_dtest_eulerian_at_knot_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement::dshape_and_dtest_eulerian_at_knot_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement::dshape_and_dtest_eulerian_at_knot_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::dshape_and_dtest_eulerian_at_knot_axi_nst(), oomph::LinearisedAxisymmetricQCrouzeixRaviartElement::dshape_and_dtest_eulerian_at_knot_linearised_axi_nst(), oomph::LinearisedAxisymmetricQTaylorHoodElement::dshape_and_dtest_eulerian_at_knot_linearised_axi_nst(), oomph::LinearisedQCrouzeixRaviartElement::dshape_and_dtest_eulerian_at_knot_linearised_nst(), oomph::LinearisedQTaylorHoodElement::dshape_and_dtest_eulerian_at_knot_linearised_nst(), oomph::QSphericalCrouzeixRaviartElement::dshape_and_dtest_eulerian_at_knot_spherical_nst(), oomph::QSphericalTaylorHoodElement::dshape_and_dtest_eulerian_at_knot_spherical_nst(), oomph::StorableShapeElementBase::dshape_eulerian_at_knot(), oomph::RefineableYoungLaplaceEquations::fill_in_contribution_to_residuals(), oomph::YoungLaplaceEquations::fill_in_contribution_to_residuals(), oomph::AxisymmetricLinearElasticityEquations::fill_in_generic_contribution_to_residuals_axisymmetric_linear_elasticity(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::fill_in_generic_contribution_to_residuals_fourier_decomp_time_harmonic_linear_elasticity(), oomph::FoepplvonKarmanEquations::get_bounded_volume(), oomph::StorableShapeElementBase::pre_compute_dshape_eulerian_at_knots(), and self_test().

◆ dshape_local()

virtual void oomph::FiniteElement::dshape_local ( const Vector< double > &  s,
Shape psi,
DShape dpsids 
) const
inlinevirtual

Function to compute the geometric shape functions and derivatives w.r.t. local coordinates at local coordinate s. This function must be overloaded for each specific geometric element. (Broken virtual function — specifies the interface)

Reimplemented in oomph::ClampedHermiteShellBoundaryConditionElement, oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >, oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >, and oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >.

Definition at line 1981 of file elements.h.

Referenced by oomph::HelmholtzBCElementBase< ELEMENT >::compute_contribution_to_fourier_components(), oomph::FaceElement::continuous_tangent_and_outer_unit_normal(), oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >::d_shape_and_test_local(), oomph::HelmholtzBCElementBase< ELEMENT >::d_shape_and_test_local(), oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >::d_shape_and_test_local(), oomph::AxisymmetricTCrouzeixRaviartElement::dpshape_and_dptest_eulerian_axi_nst(), oomph::AxisymmetricTTaylorHoodElement::dpshape_and_dptest_eulerian_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement::dpshape_and_dptest_eulerian_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::dpshape_and_dptest_eulerian_axi_nst(), dshape_eulerian(), oomph::SolidFiniteElement::dshape_lagrangian(), dshape_local_at_knot(), oomph::LineFluidInterfaceBoundingElement::fill_in_generic_residual_contribution_interface_boundary(), oomph::KirchhoffLoveBeamEquations::get_non_unit_tangent(), oomph::AxisymmetricNavierStokesEquations::interpolated_d_dudx_dX_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_d_dudx_dX_axi_nst(), oomph::AxisymmetricPoroelasticityEquations::interpolated_div_q(), oomph::DarcyEquations< DIM >::interpolated_div_q(), oomph::PoroelasticityEquations< DIM >::interpolated_div_q(), oomph::AxisymmetricNavierStokesEquations::interpolated_duds_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_duds_axi_nst(), oomph::SolidFiniteElement::interpolated_dxids(), J_eulerian(), oomph::FaceElement::J_eulerian(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::lagrangian_eulerian_translation_factor(), locate_zeta(), oomph::FaceElement::outer_unit_normal(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::output(), and oomph::AxisymmetricPoroelasticityEquations::transform_basis().

◆ dshape_local_at_knot()

void oomph::FiniteElement::dshape_local_at_knot ( const unsigned &  ipt,
Shape psi,
DShape dpsids 
) const
virtual

Return the geometric shape function and its derivative w.r.t. the local coordinates at the ipt-th integration point.

Return the shape function and its derivatives w.r.t. the local coordinates at the ipt-th integration point.

Reimplemented in oomph::StorableShapeElementBase.

Definition at line 3239 of file elements.cc.

References dim(), dshape_local(), i, integral_pt(), oomph::Integral::knot(), and s.

Referenced by oomph::FaceElement::check_J_eulerian_at_knots(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::contribution_to_enclosed_volume(), oomph::LineVolumeConstraintBoundingElement::contribution_to_enclosed_volume(), oomph::AxisymmetricVolumeConstraintBoundingElement::contribution_to_enclosed_volume(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::contribution_to_total_porous_flux(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::contribution_to_total_porous_flux(), oomph::AxisymmetricVolumeConstraintBoundingElement::contribution_to_volume_flux(), dJ_eulerian_at_knot(), dshape_eulerian_at_knot(), oomph::SolidFiniteElement::dshape_lagrangian_at_knot(), oomph::StorableShapeElementBase::dshape_local_at_knot(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::FluidInterfaceElement::fill_in_generic_residual_contribution_interface(), oomph::LineVolumeConstraintBoundingElement::fill_in_generic_residual_contribution_volume_constraint(), oomph::AxisymmetricVolumeConstraintBoundingElement::fill_in_generic_residual_contribution_volume_constraint(), oomph::SurfaceVolumeConstraintBoundingElement::fill_in_generic_residual_contribution_volume_constraint(), oomph::SurfactantTransportInterfaceElement::integrate_c(), J_eulerian_at_knot(), oomph::FaceElement::J_eulerian_at_knot(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::output(), oomph::StorableShapeElementBase::pre_compute_dshape_local_at_knots(), oomph::RefineableImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::RefineableFSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), and oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::square_of_l2_norm_of_error().

◆ element_geometry()

virtual ElementGeometry::ElementGeometry oomph::FiniteElement::element_geometry ( ) const
inlinevirtual

Return the geometry type of the element (either Q or T usually).

Reimplemented in oomph::TElementBase, and oomph::QElementBase.

Definition at line 2617 of file elements.h.

References oomph::Global_string_for_annotation::string().

◆ enable_ALE()

virtual void oomph::FiniteElement::enable_ALE ( )
inlinevirtual

◆ face_node_number_error_check()

void oomph::FiniteElement::face_node_number_error_check ( const unsigned &  i) const
inline

Range check for face node numbers.

Definition at line 3395 of file elements.h.

References i, nnode_on_face(), and oomph::Global_string_for_annotation::string().

◆ face_outer_unit_normal_sign()

virtual int oomph::FiniteElement::face_outer_unit_normal_sign ( const int &  face_index) const
inlinevirtual

Get the sign of the outer unit normal on the face given by face_index.

Reimplemented in oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, and oomph::QElement< 1, NNODE_1D >.

Definition at line 3380 of file elements.h.

References oomph::Global_string_for_annotation::string().

Referenced by build_face_element().

◆ face_to_bulk_coordinate_fct_pt()

virtual CoordinateMappingFctPt oomph::FiniteElement::face_to_bulk_coordinate_fct_pt ( const int &  face_index) const
inlinevirtual

Get a pointer to the function mapping face coordinates to bulk coordinates.

Reimplemented in oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, and oomph::QElement< 1, NNODE_1D >.

Definition at line 3409 of file elements.h.

References oomph::Global_string_for_annotation::string().

Referenced by build_face_element().

◆ fill_in_contribution_to_jacobian()

void oomph::FiniteElement::fill_in_contribution_to_jacobian ( Vector< double > &  residuals,
DenseMatrix< double > &  jacobian 
)
inlineprotectedvirtual

Add the elemental contribution to the jacobian matrix. and the residuals vector. Note that this function will NOT initialise the residuals vector or the jacobian matrix. It must be called after the residuals vector and jacobian matrix have been initialised to zero. The default is to use finite differences to calculate the jacobian.

Reimplemented from oomph::GeneralisedElement.

Reimplemented in oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >, oomph::WomersleyEquations< DIM >, oomph::UnsteadyHeatFluxElement< ELEMENT >, oomph::UnsteadyHeatEquations< DIM >, oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >, oomph::TimeHarmonicLinearElasticityEquations< DIM >, oomph::TimeHarmonicFourierDecomposedLinearElasticityTractionElement< ELEMENT >, oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations, oomph::SteadyAxisymAdvectionDiffusionFluxElement< ELEMENT >, oomph::SteadyAxisymAdvectionDiffusionEquations, oomph::SphericalNavierStokesEquations, oomph::SphericalAdvectionDiffusionFluxElement< ELEMENT >, oomph::SphericalAdvectionDiffusionEquations, oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::FpPressureAdvDiffRobinBCMixedOrderSpaceTimeElement< ELEMENT >, oomph::RefineableNavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >, oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >, oomph::RefineableNavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >, oomph::RefineableNavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >, oomph::RefineableNavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::RefineableFSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >, oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >, oomph::RefineableImposeDisplacementByLagrangeMultiplierElement< ELEMENT >, oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >, oomph::RefineableFSISolidTractionElement< ELEMENT, DIM >, oomph::FSISolidTractionElement< ELEMENT, DIM >, oomph::RefineableSolidTractionElement< ELEMENT >, oomph::SolidTractionElement< ELEMENT >, oomph::PVDEquationsWithPressure< DIM >, oomph::PVDEquations< DIM >, oomph::FSIDiagHermiteShellElement, oomph::KirchhoffLoveShellEquations, oomph::PoroelasticityFaceElement< ELEMENT >, oomph::PoroelasticityEquations< DIM >, oomph::PoroelasticityEquations< 2 >, oomph::PolarStressIntegralElement< ELEMENT >, oomph::PolarNavierStokesEquations, oomph::PolarNavierStokesTractionElement< ELEMENT >, oomph::PoissonFluxElement< ELEMENT >, oomph::PoissonEquations< DIM >, oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >, oomph::PMLTimeHarmonicLinearElasticityEquations< DIM >, oomph::PMLHelmholtzFluxElement< ELEMENT >, oomph::PMLHelmholtzEquations< DIM >, oomph::PMLFourierDecomposedHelmholtzFluxElement< ELEMENT >, oomph::PMLFourierDecomposedHelmholtzEquations, oomph::RefineableNavierStokesFluxControlElement< ELEMENT >, oomph::NavierStokesFluxControlElement< ELEMENT >, oomph::NavierStokesEquations< DIM >, oomph::FpPressureAdvDiffRobinBCElement< ELEMENT >, oomph::ImposeParallelOutflowElement< ELEMENT >, oomph::ImposeImpenetrabilityElement< ELEMENT >, oomph::RefineableNavierStokesTractionElement< ELEMENT >, oomph::NavierStokesTractionElement< ELEMENT >, oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >, oomph::NavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >, oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >, oomph::RefineableNavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >, oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, RefineableLinearisedQCrouzeixRaviartMultiDomainElement, RefineableLinearisedQTaylorHoodMultiDomainElement, LinearisedQCrouzeixRaviartMultiDomainElement, LinearisedQTaylorHoodMultiDomainElement, RefineableLinearisedAxisymmetricQCrouzeixRaviartMultiDomainElement, RefineableLinearisedAxisymmetricQTaylorHoodMultiDomainElement, LinearisedAxisymmetricQCrouzeixRaviartMultiDomainElement, LinearisedAxisymmetricQTaylorHoodMultiDomainElement, oomph::LinearisedAxisymmetricNavierStokesEquations, oomph::LinearWaveFluxElement< ELEMENT >, oomph::LinearWaveEquations< DIM >, oomph::LinearElasticityTractionElement< ELEMENT >, oomph::LinearElasticityEquations< DIM >, oomph::HelmholtzFluxElement< ELEMENT >, oomph::HelmholtzEquations< DIM >, oomph::HelmholtzDtNBoundaryElement< ELEMENT >, oomph::HelmholtzAbsorbingBCElement< ELEMENT >, oomph::ProjectableElement< ELEMENT >, oomph::ProjectableElement< FVK_ELEMENT >, oomph::ProjectableElement< AXISYM_LINEAR_ELAST_ELEMENT >, oomph::ProjectableElement< UNSTEADY_HEAT_ELEMENT >, oomph::ProjectableElement< LINEAR_ELAST_ELEMENT >, oomph::ProjectableElement< CROUZEIX_RAVIART_ELEMENT >, oomph::ProjectableElement< HELMHOLTZ_ELEMENT >, oomph::ProjectableElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >, oomph::ProjectableElement< TAYLOR_HOOD_ELEMENT >, oomph::ProjectableElement< PVD_ELEMENT >, oomph::ProjectableElement< ADR_ELEMENT >, oomph::ProjectableElement< DARCY_ELEMENT >, oomph::ProjectableElement< POISSON_ELEMENT >, oomph::ProjectableElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >, oomph::ProjectableElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >, oomph::FSIWallElement, oomph::FaceElementAsGeomObject< ELEMENT >, oomph::SolidFiniteElement, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, LineDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >, and oomph::AxisymmetricPoroelasticityTractionElement< POROELASTICITY_BULK_ELEMENT >.

Definition at line 1735 of file elements.h.

References oomph::GeneralisedElement::fill_in_contribution_to_residuals(), oomph::GeneralisedElement::fill_in_jacobian_from_external_by_fd(), oomph::GeneralisedElement::fill_in_jacobian_from_internal_by_fd(), fill_in_jacobian_from_nodal_by_fd(), oomph::GeneralisedElement::get_residuals(), and oomph::GeneralisedElement::ndof().

Referenced by LinearisedQTaylorHoodMultiDomainElement::fill_in_contribution_to_jacobian(), LinearisedQCrouzeixRaviartMultiDomainElement::fill_in_contribution_to_jacobian(), RefineableLinearisedQTaylorHoodMultiDomainElement::fill_in_contribution_to_jacobian(), RefineableLinearisedQCrouzeixRaviartMultiDomainElement::fill_in_contribution_to_jacobian(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::fill_in_contribution_to_jacobian(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::fill_in_contribution_to_jacobian(), oomph::SurfactantTransportInterfaceElement::fill_in_contribution_to_jacobian_and_mass_matrix(), and oomph::DisplacementBasedFoepplvonKarmanEquations::fill_in_contribution_to_jacobian_and_mass_matrix().

◆ fill_in_jacobian_from_nodal_by_fd() [1/2]

void oomph::FiniteElement::fill_in_jacobian_from_nodal_by_fd ( DenseMatrix< double > &  jacobian)
inlineprotected

Calculate the contributions to the jacobian from the nodal degrees of freedom using finite differences. This version computes the residuals vector before calculating the jacobian terms.

Definition at line 1695 of file elements.h.

References fill_in_jacobian_from_nodal_by_fd(), oomph::GeneralisedElement::get_residuals(), and oomph::GeneralisedElement::ndof().

◆ fill_in_jacobian_from_nodal_by_fd() [2/2]

void oomph::FiniteElement::fill_in_jacobian_from_nodal_by_fd ( Vector< double > &  residuals,
DenseMatrix< double > &  jacobian 
)
protectedvirtual

Calculate the contributions to the jacobian from the nodal degrees of freedom using finite differences. This version of the function assumes that the residuals vector has already been calculated.

This function calculates the entries of Jacobian matrix, used in the Newton method, associated with the nodal degrees of freedom. It does this using finite differences, rather than an analytical formulation, so can be done in total generality.

Reimplemented in oomph::RefineableElement.

Definition at line 3660 of file elements.cc.

References oomph::GeneralisedElement::Default_fd_jacobian_step, oomph::GeneralisedElement::get_residuals(), i, oomph::GeneralisedElement::ndof(), nnode(), nodal_local_eqn(), node_pt(), oomph::Data::nvalue(), reset_after_nodal_fd(), reset_in_nodal_fd(), update_before_nodal_fd(), update_in_nodal_fd(), and oomph::Data::value_pt().

Referenced by oomph::ElementWithExternalElement::fill_in_contribution_to_jacobian(), fill_in_contribution_to_jacobian(), oomph::SolidFiniteElement::fill_in_contribution_to_jacobian(), oomph::FSIWallElement::fill_in_contribution_to_jacobian(), and fill_in_jacobian_from_nodal_by_fd().

◆ geom_data_pt()

Data* oomph::FiniteElement::geom_data_pt ( const unsigned &  j)
inlinevirtual

A standard FiniteElement is fixed, so there are no geometric data when viewed in its GeomObject incarnation.

Reimplemented from oomph::GeomObject.

Reimplemented in oomph::RefineableSolidElement, oomph::FaceElementAsGeomObject< ELEMENT >, and oomph::SolidFiniteElement.

Definition at line 2667 of file elements.h.

Referenced by oomph::ElementWithExternalElement::assign_external_interaction_data_local_eqn_numbers().

◆ get_bulk_node_number()

virtual unsigned oomph::FiniteElement::get_bulk_node_number ( const int &  face_index,
const unsigned &  i 
) const
inlinevirtual

Get the number of the ith node on face face_index (in the bulk node vector).

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, and oomph::QElement< 1, NNODE_1D >.

Definition at line 3371 of file elements.h.

References oomph::Global_string_for_annotation::string().

Referenced by build_face_element().

◆ get_centre_of_gravity_and_max_radius_in_terms_of_zeta()

void oomph::FiniteElement::get_centre_of_gravity_and_max_radius_in_terms_of_zeta ( Vector< double > &  cog,
double &  max_radius 
) const

Compute centre of gravity of all nodes and radius of node that is furthest from it. Used to assess approximately if a point is likely to be contained with an element in locate_zeta-like operations.

Compute centre of gravity of all nodes and radius of node that is furthest from it. Used to assess approximately if a point is likely to be contained with an element in locate_zeta-like operations. NOTE: All computed in terms of zeta!

Definition at line 3924 of file elements.cc.

References Elemental_dimension, i, nnode(), and zeta_nodal().

Referenced by locate_zeta().

◆ get_dresidual_dnodal_coordinates()

void oomph::FiniteElement::get_dresidual_dnodal_coordinates ( RankThreeTensor< double > &  dresidual_dnodal_coordinates)
virtual

Compute derivatives of elemental residual vector with respect to nodal coordinates. Default implementation by FD can be overwritten for specific elements. dresidual_dnodal_coordinates(l,i,j) = d res(l) / dX_{ij}.

Compute derivatives of elemental residual vector with respect to nodal coordinates. Default implementation by FD can be overwritten for specific elements. dresidual_dnodal_coordinates(l,i,j) = d res(l) / dX_{ij} /=======================================================================.

Reimplemented in oomph::RefineableSpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::RefineableSpaceTimeNavierStokesEquations< DIM >, oomph::RefineableSpaceTimeNavierStokesEquations< DIM >, oomph::RefineableSpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::RefineablePoissonEquations< DIM >, oomph::PoissonEquations< DIM >, oomph::RefineableNavierStokesEquations< DIM >, oomph::NavierStokesEquations< DIM >, oomph::RefineableElement, oomph::RefineableGeneralisedNewtonianNavierStokesEquations< DIM >, oomph::GeneralisedNewtonianNavierStokesEquations< DIM >, oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations, oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations, oomph::RefineableAxisymmetricNavierStokesEquations, and oomph::AxisymmetricNavierStokesEquations.

Definition at line 3744 of file elements.cc.

References oomph::GeneralisedElement::Default_fd_jacobian_step, oomph::GeneralisedElement::get_residuals(), i, oomph::Node::ndim(), oomph::GeneralisedElement::ndof(), nnode(), node_pt(), oomph::Node::perform_auxiliary_node_update_fct(), and oomph::Node::x().

Referenced by oomph::ElementWithMovingNodes::fill_in_jacobian_from_geometric_data().

◆ get_node_at_local_coordinate()

Node * oomph::FiniteElement::get_node_at_local_coordinate ( const Vector< double > &  s) const
virtual

If there is a node at this local coordinate, return the pointer to the node.

If there is a node at the local coordinate, s, return the pointer to the node. If not return 0. Note that this is a default, brute force implementation, can almost certainly be made more efficient for specific elements.

Reimplemented in oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >, oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >, and oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >.

Definition at line 3882 of file elements.cc.

Referenced by oomph::RefineableQElement< 3 >::build(), oomph::RefineableQElement< 1 >::build(), oomph::RefineableQElement< 2 >::build(), oomph::RefineableAxisymmetricQTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableLinearisedQTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableQSphericalTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::get_interpolating_node_at_local_coordinate(), oomph::RefineableElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableQTaylorHoodElement< DIM >::get_interpolating_node_at_local_coordinate(), oomph::RefineablePolarTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::get_interpolating_node_at_local_coordinate(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::get_interpolating_node_at_local_coordinate(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::get_interpolating_node_at_local_coordinate(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::node_created_by_neighbour(), oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >::node_created_by_neighbour(), oomph::RefineableQElement< 3 >::node_created_by_neighbour(), oomph::RefineableQElement< 1 >::node_created_by_neighbour(), oomph::RefineableQElement< 2 >::node_created_by_neighbour(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::node_created_by_son_of_neighbour(), oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >::node_created_by_son_of_neighbour(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::pre_build(), and oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >::pre_build().

◆ get_node_number()

int oomph::FiniteElement::get_node_number ( Node *const &  node_pt) const

Return the number of the node *node_pt if this node is in the element, else return -1;.

Return the number of the node located at *node_pt if this node is in the element, else return $ -1 $.

Definition at line 3814 of file elements.cc.

References i, nnode(), and node_pt().

Referenced by oomph::OcTreeForest::construct_up_right_equivalents(), oomph::Mesh::convert_to_boundary_node(), and oomph::RefineableElement::unbuild().

◆ get_s_plot()

virtual void oomph::FiniteElement::get_s_plot ( const unsigned &  i,
const unsigned &  nplot,
Vector< double > &  s,
const bool &  shifted_to_interior = false 
) const
inlinevirtual

Get cector of local coordinates of plot point i (when plotting nplot points in each "coordinate direction"). Generally these plot points will be uniformly spaced across the element. The optional final boolean flag (default: false) allows them to be shifted inwards to avoid duplication of plot point points between elements – useful when they are used in locate_zeta, say.

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, and oomph::QHermiteElement< DIM - 1 >.

Definition at line 3148 of file elements.h.

Referenced by oomph::Mesh::doc_boundary_coordinates(), oomph::Z2ErrorEstimator::doc_flux(), oomph::PolarNavierStokesEquations::full_output(), oomph::SphericalNavierStokesEquations::full_output(), locate_zeta(), oomph::AxisymFoepplvonKarmanEquations::output(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::output(), oomph::AxisymmetricLinearElasticityEquations::output(), oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >::output(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::output(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::output(), oomph::FluidInterfaceElement::output(), oomph::SurfactantTransportInterfaceElement::output(), oomph::DisplacementBasedFoepplvonKarmanEquations::output(), oomph::FoepplvonKarmanEquations::output(), oomph::FourierDecomposedHelmholtzEquations::output(), oomph::NavierStokesSurfaceDragTorqueElement< ELEMENT >::output(), oomph::PMLFourierDecomposedHelmholtzEquations::output(), oomph::SolidTractionElement< ELEMENT >::output(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::output(), oomph::YoungLaplaceEquations::output(), oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::output(), oomph::AxisymAdvectionDiffusionEquations::output(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::output(), oomph::AxisymmetricNavierStokesEquations::output(), oomph::AxisymmetricPoroelasticityEquations::output(), oomph::BiharmonicEquations< DIM >::output(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output(), oomph::LinearisedAxisymmetricNavierStokesEquations::output(), oomph::LinearisedNavierStokesEquations::output(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::output(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::output(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::PoissonFluxElement< ELEMENT >::output(), oomph::PolarNavierStokesEquations::output(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::SphericalAdvectionDiffusionEquations::output(), oomph::SphericalNavierStokesEquations::output(), oomph::SteadyAxisymAdvectionDiffusionEquations::output(), oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::AxisymFoepplvonKarmanEquations::output_fct(), oomph::DisplacementBasedFoepplvonKarmanEquations::output_fct(), oomph::FoepplvonKarmanEquations::output_fct(), oomph::FourierDecomposedHelmholtzEquations::output_fct(), oomph::PMLFourierDecomposedHelmholtzEquations::output_fct(), oomph::YoungLaplaceEquations::output_fct(), oomph::AxisymAdvectionDiffusionEquations::output_fct(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::output_fct(), oomph::AxisymmetricLinearElasticityEquations::output_fct(), oomph::AxisymmetricNavierStokesEquations::output_fct(), oomph::AxisymmetricPoroelasticityEquations::output_fct(), oomph::BiharmonicEquations< DIM >::output_fct(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_fct(), oomph::PolarNavierStokesEquations::output_fct(), oomph::SphericalAdvectionDiffusionEquations::output_fct(), oomph::SphericalNavierStokesEquations::output_fct(), oomph::SteadyAxisymAdvectionDiffusionEquations::output_fct(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::output_fct(), oomph::BiharmonicEquations< DIM >::output_fluid_velocity(), output_paraview(), oomph::FourierDecomposedHelmholtzEquations::output_real(), oomph::PMLFourierDecomposedHelmholtzEquations::output_real(), oomph::FourierDecomposedHelmholtzEquations::output_real_fct(), oomph::PMLFourierDecomposedHelmholtzEquations::output_real_fct(), oomph::AxisymmetricNavierStokesEquations::output_veloc(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedNavierStokesEquations::output_veloc(), oomph::PolarNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_vorticity(), oomph::FaceElement::output_zeta(), oomph::NavierStokesEquations< DIM >::scalar_value_fct_paraview(), oomph::SpaceTimeNavierStokesEquations< DIM >::scalar_value_fct_paraview(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::scalar_value_fct_paraview(), oomph::PMLHelmholtzEquations< DIM >::scalar_value_fct_paraview(), oomph::PoissonEquations< DIM >::scalar_value_fct_paraview(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::scalar_value_fct_paraview(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::scalar_value_fct_paraview(), oomph::AdvectionDiffusionEquations< DIM >::scalar_value_paraview(), oomph::AxisymAdvectionDiffusionEquations::scalar_value_paraview(), oomph::AxisymmetricNavierStokesEquations::scalar_value_paraview(), oomph::AxisymmetricPoroelasticityEquations::scalar_value_paraview(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::scalar_value_paraview(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::scalar_value_paraview(), oomph::HelmholtzEquations< DIM >::scalar_value_paraview(), oomph::NavierStokesEquations< DIM >::scalar_value_paraview(), oomph::PMLHelmholtzEquations< DIM >::scalar_value_paraview(), oomph::PoissonEquations< DIM >::scalar_value_paraview(), oomph::SpaceTimeNavierStokesEquations< DIM >::scalar_value_paraview(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::scalar_value_paraview(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::scalar_value_paraview(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::scalar_value_paraview(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::scalar_value_paraview(), and oomph::Multi_domain_functions::setup_bulk_elements_adjacent_to_face_mesh().

◆ get_x() [1/2]

void oomph::FiniteElement::get_x ( const unsigned &  t,
const Vector< double > &  s,
Vector< double > &  x 
)
inline

Global coordinates as function of local coordinates at previous time "level" t (t=0: present; t>0: previous). Either via FE representation of QElement or via macro-element (if Macro_elem_pt!=0).

Definition at line 1904 of file elements.h.

References get_x_from_macro_element(), interpolated_x(), Macro_elem_pt, node_pt(), oomph::TimeStepper::nprev_values(), s, t, oomph::GeomObject::time_stepper_pt(), and oomph::Data::time_stepper_pt().

◆ get_x() [2/2]

void oomph::FiniteElement::get_x ( const Vector< double > &  s,
Vector< double > &  x 
) const
inline

◆ get_x_from_macro_element() [1/2]

virtual void oomph::FiniteElement::get_x_from_macro_element ( const unsigned &  t,
const Vector< double > &  s,
Vector< double > &  x 
)
inlinevirtual

Global coordinates as function of local coordinates at previous time "level" t (t=0: present; t>0: previous). using macro element representation (Broken virtual – overload in specific geometric element class if you want to use this functionality.)

Reimplemented in oomph::QElementBase.

Definition at line 1948 of file elements.h.

◆ get_x_from_macro_element() [2/2]

virtual void oomph::FiniteElement::get_x_from_macro_element ( const Vector< double > &  s,
Vector< double > &  x 
) const
inlinevirtual

Global coordinates as function of local coordinates using macro element representation. (Broken virtual — this must be overloaded in specific geometric element classes)

Reimplemented in oomph::QElementBase.

Definition at line 1934 of file elements.h.

Referenced by get_x(), and interpolated_zeta().

◆ has_hanging_nodes()

bool oomph::FiniteElement::has_hanging_nodes ( ) const
inline

Return boolean to indicate if any of the element's nodes are geometrically hanging.

Definition at line 2470 of file elements.h.

References nnode(), and node_pt().

Referenced by oomph::AdvectionDiffusionFluxElement< ELEMENT >::AdvectionDiffusionFluxElement(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::AxisymmetricPoroelasticityTractionElement(), oomph::DarcyFaceElement< ELEMENT >::DarcyFaceElement(), oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement(), oomph::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement(), oomph::FpPressureAdvDiffRobinBCElement< ELEMENT >::FpPressureAdvDiffRobinBCElement(), oomph::FpPressureAdvDiffRobinBCMixedOrderSpaceTimeElement< ELEMENT >::FpPressureAdvDiffRobinBCMixedOrderSpaceTimeElement(), oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >::FpPressureAdvDiffRobinBCSpaceTimeElement(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::FSIImposeDisplacementByLagrangeMultiplierElement(), oomph::HelmholtzFluxElement< ELEMENT >::HelmholtzFluxElement(), oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::HelmholtzFluxFromNormalDisplacementBCElement(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::ImposeDisplacementByLagrangeMultiplierElement(), oomph::LinearElasticityTractionElement< ELEMENT >::LinearElasticityTractionElement(), oomph::LinearWaveFluxElement< ELEMENT >::LinearWaveFluxElement(), oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::NavierStokesImpedanceTractionElement(), oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >::NavierStokesMixedOrderSpaceTimeTractionElement(), oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >::NavierStokesSpaceTimeTractionElement(), oomph::NavierStokesTractionElement< ELEMENT >::NavierStokesTractionElement(), oomph::PMLHelmholtzFluxElement< ELEMENT >::PMLHelmholtzFluxElement(), oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::PMLHelmholtzFluxFromNormalDisplacementBCElement(), oomph::PMLHelmholtzPowerElement< ELEMENT >::PMLHelmholtzPowerElement(), oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >::PMLTimeHarmonicLinearElasticityTractionElement(), oomph::PoissonFluxElement< ELEMENT >::PoissonFluxElement(), oomph::PolarNavierStokesTractionElement< ELEMENT >::PolarNavierStokesTractionElement(), oomph::PolarStressIntegralElement< ELEMENT >::PolarStressIntegralElement(), oomph::SolidTractionElement< ELEMENT >::SolidTractionElement(), oomph::SphericalAdvectionDiffusionFluxElement< ELEMENT >::SphericalAdvectionDiffusionFluxElement(), oomph::SpineUpdateFluidInterfaceElement< EQUATION_CLASS, DERIVATIVE_CLASS, ELEMENT >::SpineUpdateFluidInterfaceElement(), oomph::SteadyAxisymAdvectionDiffusionFluxElement< ELEMENT >::SteadyAxisymAdvectionDiffusionFluxElement(), oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >::TimeHarmonicLinearElasticityTractionElement(), oomph::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement(), oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement(), and oomph::UnsteadyHeatFluxElement< ELEMENT >::UnsteadyHeatFluxElement().

◆ identify_field_data_for_interactions()

void oomph::FiniteElement::identify_field_data_for_interactions ( std::set< std::pair< Data *, unsigned >> &  paired_field_data)
virtual

The purpose of this function is to identify all possible Data that can affect the fields interpolated by the FiniteElement. The information will typically be used in interaction problems in which the FiniteElement provides a forcing term for an ElementWithExternalElement. The Data must be provided as paired_load data containing.

The purpose of this function is to identify all possible Data that can affect the fields interpolated by the FiniteElement. The information will typically be used in interaction problems in which the FiniteElement provides a forcing term for an ElementWithExternalElement. The Data must be provided as paired_load data containing (a) the pointer to a Data object and (b) the index of the value in that Data object. The generic implementation (should be overloaded in more specific applications) is to include all nodal and internal Data stored in the FiniteElement. Note that the geometric data, which includes the positions of SolidNodes, is treated separately by the function identify_geometric_data()

  • the pointer to a Data object and

the index of the value in that Data objectThe generic implementation (should be overloaded in more specific applications) is to include all nodal and internal Data stored in the FiniteElement. The geometric data, which includes the positions of SolidNodes, is treated separately by the function identify_geometric_data()

Reimplemented in oomph::RefineableElement.

Definition at line 5096 of file elements.cc.

References i, oomph::GeneralisedElement::internal_data_pt(), oomph::GeneralisedElement::ninternal_data(), nnode(), node_pt(), and oomph::Data::nvalue().

◆ identify_geometric_data()

virtual void oomph::FiniteElement::identify_geometric_data ( std::set< Data * > &  geometric_data_pt)
inlinevirtual

The purpose of this function is to identify all Data objects that affect the elements' geometry. This function is implemented as an empty virtual function since it can only be implemented in conjunction with a node-update strategy. A specific implementation is provided in the ElementWithMovingNodes class.

Reimplemented in oomph::RefineableSolidElement, oomph::SolidFiniteElement, and oomph::ElementWithMovingNodes.

Definition at line 2789 of file elements.h.

Referenced by oomph::ImmersedRigidBodyElement::set_drag_mesh().

◆ integral_pt()

Integral* const& oomph::FiniteElement::integral_pt ( ) const
inline

Return the pointer to the integration scheme (const version)

Definition at line 1963 of file elements.h.

References Integral_pt.

Referenced by oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::add_element_contribution_to_aux_integral(), oomph::DGFaceElement::add_flux_contributions(), oomph::ElementWithExternalElement::assign_external_interaction_data_local_eqn_numbers(), oomph::Multi_domain_functions::aux_setup_multi_domain_interaction(), oomph::Mesh::check_inverted_elements(), check_J_eulerian_at_knots(), oomph::FaceElement::check_J_eulerian_at_knots(), oomph::HelmholtzBCElementBase< ELEMENT >::compute_contribution_to_fourier_components(), oomph::AxisymAdvectionDiffusionEquations::compute_error(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::compute_error(), oomph::AxisymFoepplvonKarmanEquations::compute_error(), oomph::AxisymmetricLinearElasticityEquations::compute_error(), oomph::BiharmonicEquations< DIM >::compute_error(), oomph::DisplacementBasedFoepplvonKarmanEquations::compute_error(), oomph::FoepplvonKarmanEquations::compute_error(), oomph::FourierDecomposedHelmholtzEquations::compute_error(), oomph::PMLFourierDecomposedHelmholtzEquations::compute_error(), oomph::SphericalAdvectionDiffusionEquations::compute_error(), oomph::SteadyAxisymAdvectionDiffusionEquations::compute_error(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::compute_error(), oomph::YoungLaplaceEquations::compute_error(), oomph::AxisymmetricPoroelasticityEquations::compute_error(), oomph::AxisymmetricNavierStokesEquations::compute_error(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::compute_error(), oomph::PolarNavierStokesEquations::compute_error(), oomph::SphericalNavierStokesEquations::compute_error(), oomph::EulerEquations< DIM >::compute_error(), oomph::ScalarAdvectionEquations< DIM >::compute_error(), oomph::SphericalNavierStokesEquations::compute_error_e(), oomph::SolidFiniteElement::compute_norm(), oomph::FourierDecomposedHelmholtzEquations::compute_norm(), oomph::PMLFourierDecomposedHelmholtzEquations::compute_norm(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::compute_norm(), oomph::AxisymmetricNavierStokesEquations::compute_physical_size(), oomph::AxisymmetricPVDEquations::compute_physical_size(), oomph::AxisymmetricPVDEquationsWithPressure::compute_physical_size(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::compute_physical_size(), oomph::FaceElement::continuous_tangent_and_outer_unit_normal(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::contribution_to_enclosed_volume(), oomph::LineVolumeConstraintBoundingElement::contribution_to_enclosed_volume(), oomph::AxisymmetricVolumeConstraintBoundingElement::contribution_to_enclosed_volume(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::contribution_to_total_porous_flux(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::contribution_to_total_porous_flux(), oomph::AxisymmetricVolumeConstraintBoundingElement::contribution_to_volume_flux(), oomph::Multi_domain_functions::create_external_halo_elements(), d2shape_local_at_knot(), oomph::SphericalNavierStokesEquations::d_kin_energy_dt(), oomph::AxisymmetricNavierStokesEquations::dissipation(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::dissipation(), oomph::PolarNavierStokesEquations::dissipation(), oomph::SphericalNavierStokesEquations::dissipation(), oomph::FSI_functions::doc_fsi(), oomph::NavierStokesSurfacePowerElement< ELEMENT >::drag_force(), dshape_local_at_knot(), oomph::SphericalNavierStokesEquations::extract_velocity(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::extrapolated_strain_rate(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::extrapolated_strain_rate(), oomph::AxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::AxisymFoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::DisplacementBasedFoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::FoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::ClampedHermiteShellBoundaryConditionElement::fill_in_contribution_to_residuals(), oomph::RefineableYoungLaplaceEquations::fill_in_contribution_to_residuals(), oomph::YoungLaplaceEquations::fill_in_contribution_to_residuals(), oomph::AxisymmetricPVDEquations::fill_in_contribution_to_residuals_axisym_pvd(), oomph::KirchhoffLoveBeamEquations::fill_in_contribution_to_residuals_beam(), oomph::KirchhoffLoveShellEquations::fill_in_contribution_to_residuals_shell(), oomph::AxisymmetricLinearElasticityEquations::fill_in_generic_contribution_to_residuals_axisymmetric_linear_elasticity(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::fill_in_generic_contribution_to_residuals_fourier_decomp_time_harmonic_linear_elasticity(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::ImposeImpenetrabilityElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::ImposeParallelOutflowElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::SolidFiniteElement::fill_in_generic_jacobian_for_solid_ic(), oomph::AxisymmetricPoroelasticityEquations::fill_in_generic_residual_contribution(), oomph::PolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::RefineablePolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::SteadyAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_adv_diff(), oomph::AxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::RefineableAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::AxisymmetricPVDEquationsWithPressure::fill_in_generic_residual_contribution_axisym_pvd_with_pressure(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::NavierStokesFluxControlElement< ELEMENT >::fill_in_generic_residual_contribution_fluid_traction(), oomph::FourierDecomposedHelmholtzEquations::fill_in_generic_residual_contribution_fourier_decomposed_helmholtz(), oomph::FourierDecomposedHelmholtzDtNBoundaryElement< ELEMENT >::fill_in_generic_residual_contribution_fourier_decomposed_helmholtz_DtN_bc(), oomph::HelmholtzAbsorbingBCElement< ELEMENT >::fill_in_generic_residual_contribution_helmholtz_abc(), oomph::HelmholtzDtNBoundaryElement< ELEMENT >::fill_in_generic_residual_contribution_helmholtz_DtN_bc(), oomph::FluidInterfaceElement::fill_in_generic_residual_contribution_interface(), oomph::LineFluidInterfaceBoundingElement::fill_in_generic_residual_contribution_interface_boundary(), oomph::LinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::RefineableLinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::LinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::RefineableLinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::PeriodicOrbitEquations::fill_in_generic_residual_contribution_orbit(), oomph::PMLFourierDecomposedHelmholtzEquations::fill_in_generic_residual_contribution_pml_fourier_decomposed_helmholtz(), oomph::RefineableSphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::SphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::RefineableSphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::SphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::LineVolumeConstraintBoundingElement::fill_in_generic_residual_contribution_volume_constraint(), oomph::AxisymmetricVolumeConstraintBoundingElement::fill_in_generic_residual_contribution_volume_constraint(), oomph::SurfaceVolumeConstraintBoundingElement::fill_in_generic_residual_contribution_volume_constraint(), oomph::SolidFiniteElement::fill_in_jacobian_for_newmark_accel(), oomph::RefineableNavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::NavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::FoepplvonKarmanEquations::get_bounded_volume(), oomph::NavierStokesSurfaceDragTorqueElement< ELEMENT >::get_drag_and_torque(), oomph::AxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::Z2ErrorEstimator::get_element_errors(), oomph::KirchhoffLoveShellEquations::get_energy(), oomph::KirchhoffLoveBeamEquations::get_energy(), oomph::NavierStokesSurfacePowerElement< ELEMENT >::get_kinetic_energy_flux(), oomph::AxisymmetricNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::SphericalNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::NavierStokesSurfacePowerElement< ELEMENT >::get_rate_of_traction_work(), oomph::NavierStokesSurfacePowerElement< ELEMENT >::get_rate_of_traction_work_components(), oomph::FSILinearisedAxisymPoroelasticTractionElement< POROELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::get_traction(), oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::get_volume_flux(), oomph::NavierStokesSurfacePowerElement< ELEMENT >::get_volume_flux(), oomph::PMLHelmholtzPowerElement< ELEMENT >::global_flux_contribution(), oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::global_flux_contribution_from_helmholtz(), oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::global_flux_contribution_from_solid(), oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >::global_power_contribution(), oomph::HelmholtzBCElementBase< ELEMENT >::global_power_contribution(), oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >::global_power_contribution(), oomph::PMLHelmholtzPowerElement< ELEMENT >::global_power_contribution(), oomph::ElementWithExternalElement::initialise_external_element_storage(), oomph::SurfactantTransportInterfaceElement::integrate_c(), integrate_fct(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::integrate_u(), oomph::AxisymmetricNavierStokesEquations::kin_energy(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::kin_energy(), oomph::PolarNavierStokesEquations::kin_energy(), oomph::SphericalNavierStokesEquations::kin_energy(), oomph::KirchhoffLoveShellEquations::load_rate_of_work(), oomph::Multi_domain_functions::locate_zeta_for_local_coordinates(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::max_and_min_invariant_and_viscosity(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::node_update_adjacent_fluid_elements(), oomph::FSIWallElement::node_update_adjacent_fluid_elements(), oomph::FaceElement::outer_unit_normal(), oomph::FSIAxisymmetricLinearElasticityTractionElement< ELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::output(), oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >::output(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::output(), oomph::FSILinearisedAxisymPoroelasticTractionElement< POROELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::output(), oomph::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::output(), oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::output(), oomph::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::output(), oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::output(), oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::output(), oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::output(), oomph::ClampedHermiteShellBoundaryConditionElement::output(), oomph::FSISolidTractionElement< ELEMENT, DIM >::output(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::output_adjacent_fluid_elements(), oomph::ElementWithExternalElement::output_external_elements(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::output_integration_points(), oomph::NavierStokesEquations< DIM >::output_pressure_advection_diffusion_robin_elements(), oomph::SpaceTimeNavierStokesEquations< DIM >::output_pressure_advection_diffusion_robin_elements(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::output_pressure_advection_diffusion_robin_elements(), oomph::StorableShapeElementBase::pre_compute_d2shape_eulerian_at_knots(), oomph::StorableShapeSolidElementBase::pre_compute_d2shape_lagrangian_at_knots(), oomph::StorableShapeElementBase::pre_compute_d2shape_local_at_knots(), oomph::StorableShapeElementBase::pre_compute_dshape_eulerian_at_knots(), oomph::StorableShapeSolidElementBase::pre_compute_dshape_lagrangian_at_knots(), oomph::StorableShapeElementBase::pre_compute_dshape_local_at_knots(), oomph::StorableShapeElementBase::pre_compute_J_eulerian_at_knots(), oomph::StorableShapeElementBase::pre_compute_shape_at_knots(), oomph::AxisymmetricNavierStokesEquations::pressure_integral(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::pressure_integral(), oomph::PolarNavierStokesEquations::pressure_integral(), oomph::SphericalNavierStokesEquations::pressure_integral(), oomph::RefineableImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::RefineableFSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::RefineableNavierStokesFluxControlElement< ELEMENT >::refineable_fill_in_generic_residual_contribution_fluid_traction(), oomph::DGFaceElement::report_info(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::residual_for_projection(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::residual_for_projection(), oomph::ProjectableElement< ELEMENT >::residual_for_projection(), self_test(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::set_boundary_shape_geom_object_pt(), set_integration_scheme(), oomph::StorableShapeElementBase::set_integration_scheme(), oomph::StorableShapeSolidElementBase::set_integration_scheme(), oomph::FourierDecomposedHelmholtzDtNMesh< ELEMENT >::setup_gamma(), oomph::HelmholtzDtNMesh< ELEMENT >::setup_gamma(), oomph::DGFaceElement::setup_neighbour_info(), oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >::shape_and_test_at_knot(), oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >::shape_and_test_at_knot(), shape_at_knot(), oomph::TAxisymmetricPoroelasticityElement< ORDER >::shape_basis_test_local_at_knot(), oomph::TPoroelasticityElement< ORDER >::shape_basis_test_local_at_knot(), oomph::TRaviartThomasDarcyElement< ORDER >::shape_basis_test_local_at_knot(), size(), oomph::AxisymmetricPVDEquationsWithPressure::solid_pshape_at_knot(), oomph::PVDEquationsWithPressure< DIM >::solid_pshape_at_knot(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::square_of_l2_norm_of_error(), oomph::StorableShapeElement< ELEMENT >::StorableShapeElement(), oomph::StorableShapeSolidElement< ELEMENT >::StorableShapeSolidElement(), oomph::PRefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::~PRefineableGeneralisedNewtonianQCrouzeixRaviartElement(), oomph::PRefineableQCrouzeixRaviartElement< DIM >::~PRefineableQCrouzeixRaviartElement(), oomph::PRefineableQLinearElasticityElement< DIM >::~PRefineableQLinearElasticityElement(), oomph::PRefineableQPoissonElement< DIM >::~PRefineableQPoissonElement(), and oomph::QTaylorHoodSpaceTimeElement< DIM >::~QTaylorHoodSpaceTimeElement().

◆ integrate_fct() [1/2]

void oomph::FiniteElement::integrate_fct ( FiniteElement::SteadyExactSolutionFctPt  integrand_fct_pt,
Vector< double > &  integral 
)

Evaluate integral of a Vector-valued function $ {\bf f}({\bf x}) $ over the element.

Integrate Vector-valued function over element.

Definition at line 4377 of file elements.cc.

References dim(), i, integral_pt(), interpolated_x(), J_eulerian(), oomph::Integral::knot(), nodal_dimension(), oomph::Integral::nweight(), s, and oomph::Integral::weight().

◆ integrate_fct() [2/2]

void oomph::FiniteElement::integrate_fct ( FiniteElement::UnsteadyExactSolutionFctPt  integrand_fct_pt,
const double &  time,
Vector< double > &  integral 
)

Evaluate integral of a Vector-valued, time-dependent function $ {\bf f}(t,{\bf x}) $ over the element.

Integrate Vector-valued time-dep function over element.

Definition at line 4315 of file elements.cc.

References dim(), i, integral_pt(), interpolated_x(), J_eulerian(), oomph::Integral::knot(), nodal_dimension(), oomph::Integral::nweight(), s, and oomph::Integral::weight().

◆ interpolated_dxdt() [1/2]

double oomph::FiniteElement::interpolated_dxdt ( const Vector< double > &  s,
const unsigned &  i,
const unsigned &  t 
)
virtual

Return t-th time-derivative of the i-th FE-interpolated Eulerian coordinate at local coordinate s.

Return the t-th time-derivative of the i-th FE-interpolated Eulerian coordinate at local coordinate s.

Reimplemented in oomph::FaceElement.

Definition at line 4596 of file elements.cc.

References dnodal_position_gen_dt(), i, nnodal_position_type(), nnode(), s, and shape().

Referenced by dposition_dt(), oomph::FaceElement::interpolated_dxdt(), and oomph::HermiteShellElement::output_with_time_dep_quantities().

◆ interpolated_dxdt() [2/2]

void oomph::FiniteElement::interpolated_dxdt ( const Vector< double > &  s,
const unsigned &  t,
Vector< double > &  dxdt 
)
virtual

Compte t-th time-derivative of the FE-interpolated Eulerian coordinate vector at local coordinate s.

Compute t-th time-derivative of the FE-interpolated Eulerian coordinate vector at local coordinate s.

Reimplemented in oomph::FaceElement.

Definition at line 4629 of file elements.cc.

References dnodal_position_gen_dt(), i, nnodal_position_type(), nnode(), nodal_dimension(), s, and shape().

◆ interpolated_x() [1/4]

double oomph::FiniteElement::interpolated_x ( const unsigned &  t,
const Vector< double > &  s,
const unsigned &  i 
) const
virtual

Return FE interpolated coordinate x[i] at local coordinate s at previous timestep t (t=0: present; t>0: previous timestep)

Reimplemented in oomph::FaceElement.

Definition at line 3993 of file elements.cc.

References i, interpolated_x(), nnodal_position_type(), nnode(), nodal_position_gen(), s, shape(), and t.

◆ interpolated_x() [2/4]

void oomph::FiniteElement::interpolated_x ( const unsigned &  t,
const Vector< double > &  s,
Vector< double > &  x 
) const
virtual

Return FE interpolated position x[] at local coordinate s at previous timestep t as Vector (t=0: present; t>0: previous timestep)

Reimplemented in oomph::FaceElement.

Definition at line 4061 of file elements.cc.

References i, nnodal_position_type(), nnode(), nodal_dimension(), nodal_position_gen(), s, shape(), and t.

◆ interpolated_x() [3/4]

double oomph::FiniteElement::interpolated_x ( const Vector< double > &  s,
const unsigned &  i 
) const
virtual

Return FE interpolated coordinate x[i] at local coordinate s.

Reimplemented in oomph::FaceElement.

Definition at line 3962 of file elements.cc.

References i, nnodal_position_type(), nnode(), nodal_position_gen(), s, and shape().

Referenced by oomph::SpineUpdateFluidInterfaceElement< EQUATION_CLASS, DERIVATIVE_CLASS, ELEMENT >::add_additional_residual_contributions_interface(), oomph::Multi_domain_functions::aux_setup_multi_domain_interaction(), oomph::RefineableSolidQElement< 3 >::build(), oomph::RefineableSolidQElement< 2 >::build(), oomph::GmshTetMesh< ELEMENT >::build_from_scaffold(), oomph::TetgenMesh< ELEMENT >::build_from_scaffold(), oomph::TriangleMesh< ELEMENT >::build_from_scaffold(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::check_integrity(), oomph::RefineableQElement< 3 >::check_integrity(), oomph::RefineableQElement< 1 >::check_integrity(), oomph::RefineableQElement< 2 >::check_integrity(), oomph::AxisymAdvectionDiffusionEquations::compute_error(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::compute_error(), oomph::AxisymFoepplvonKarmanEquations::compute_error(), oomph::AxisymmetricLinearElasticityEquations::compute_error(), oomph::BiharmonicEquations< DIM >::compute_error(), oomph::DisplacementBasedFoepplvonKarmanEquations::compute_error(), oomph::FoepplvonKarmanEquations::compute_error(), oomph::FourierDecomposedHelmholtzEquations::compute_error(), oomph::PMLFourierDecomposedHelmholtzEquations::compute_error(), oomph::SphericalAdvectionDiffusionEquations::compute_error(), oomph::SteadyAxisymAdvectionDiffusionEquations::compute_error(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::compute_error(), oomph::AxisymmetricPoroelasticityEquations::compute_error(), oomph::AxisymmetricNavierStokesEquations::compute_error(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::compute_error(), oomph::PolarNavierStokesEquations::compute_error(), oomph::SphericalNavierStokesEquations::compute_error(), oomph::EulerEquations< DIM >::compute_error(), oomph::ScalarAdvectionEquations< DIM >::compute_error(), oomph::SphericalNavierStokesEquations::compute_error_e(), oomph::SolidFiniteElement::compute_norm(), oomph::AxisymmetricNavierStokesEquations::compute_physical_size(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::compute_physical_size(), oomph::SphericalNavierStokesEquations::compute_shear_stress(), oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::compute_stabilisation_parameter(), oomph::SpineUpdateFluidInterfaceElement< EQUATION_CLASS, DERIVATIVE_CLASS, ELEMENT >::compute_surface_derivatives(), oomph::Z2ErrorEstimator::doc_flux(), oomph::FSI_functions::doc_fsi(), oomph::TAxisymmetricPoroelasticityElement< ORDER >::edge_flux_interpolation_point_global(), oomph::TRaviartThomasDarcyElement< ORDER >::edge_flux_interpolation_point_global(), oomph::TPoroelasticityElement< ORDER >::edge_gauss_point_global(), oomph::YoungLaplaceEquations::exact_position(), oomph::SphericalNavierStokesEquations::extract_velocity(), oomph::AxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::DisplacementBasedFoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::FoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::DisplacementControlElement::fill_in_contribution_to_residuals(), oomph::KirchhoffLoveBeamEquations::fill_in_contribution_to_residuals_beam(), oomph::KirchhoffLoveShellEquations::fill_in_contribution_to_residuals_shell(), oomph::AxisymmetricLinearElasticityEquations::fill_in_generic_contribution_to_residuals_axisymmetric_linear_elasticity(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::fill_in_generic_contribution_to_residuals_fourier_decomp_time_harmonic_linear_elasticity(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::SolidFiniteElement::fill_in_generic_jacobian_for_solid_ic(), oomph::AxisymmetricPoroelasticityEquations::fill_in_generic_residual_contribution(), oomph::PolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::RefineablePolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::SteadyAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_adv_diff(), oomph::AxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::RefineableAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::FourierDecomposedHelmholtzEquations::fill_in_generic_residual_contribution_fourier_decomposed_helmholtz(), oomph::LinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::RefineableLinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::LinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::RefineableLinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::PMLFourierDecomposedHelmholtzEquations::fill_in_generic_residual_contribution_pml_fourier_decomposed_helmholtz(), oomph::RefineableSphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::SphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::RefineableSphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::SphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::PolarNavierStokesEquations::full_output(), oomph::SphericalNavierStokesEquations::full_output(), oomph::AxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::Z2ErrorEstimator::get_element_errors(), oomph::KirchhoffLoveBeamEquations::get_energy(), oomph::Z2ErrorEstimator::get_recovered_flux_in_patch(), oomph::AxisymmetricLinearElasticityEquations::get_strain(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::get_strain(), oomph::KirchhoffLoveShellEquations::get_strain_and_bend(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::get_total_flux(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::get_total_flux(), oomph::FSILinearisedAxisymPoroelasticTractionElement< POROELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::get_traction(), get_x(), oomph::QSolidElementBase::get_x_and_xi(), integrate_fct(), oomph::AxisymmetricPoroelasticityEquations::interpolated_div_du_dt(), oomph::AxisymmetricPoroelasticityEquations::interpolated_div_q(), oomph::AxisymmetricPoroelasticityEquations::interpolated_div_u(), oomph::AxisymFoepplvonKarmanEquations::interpolated_stress(), interpolated_x(), oomph::FaceElement::interpolated_x(), oomph::AxisymmetricNavierStokesEquations::kin_energy(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::kin_energy(), oomph::RefineableQElement< 3 >::oc_hang_helper(), oomph::HermiteBeamElement::output(), oomph::AxisymFoepplvonKarmanEquations::output(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::output(), oomph::AxisymmetricLinearElasticityEquations::output(), oomph::FSILinearisedAxisymPoroelasticTractionElement< POROELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::output(), oomph::AxisymmetricPVDEquations::output(), oomph::AxisymDiagHermitePVDElement::output(), oomph::AxisymmetricPVDEquationsWithPressure::output(), oomph::DisplacementBasedFoepplvonKarmanEquations::output(), oomph::FoepplvonKarmanEquations::output(), oomph::FourierDecomposedHelmholtzEquations::output(), oomph::PMLFourierDecomposedHelmholtzEquations::output(), oomph::HermiteShellElement::output(), oomph::ClampedHermiteShellBoundaryConditionElement::output(), oomph::FSISolidTractionElement< ELEMENT, DIM >::output(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::output(), oomph::YoungLaplaceEquations::output(), oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::output(), oomph::AxisymAdvectionDiffusionEquations::output(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::output(), oomph::AxisymmetricNavierStokesEquations::output(), oomph::AxisymmetricPoroelasticityEquations::output(), oomph::BiharmonicEquations< DIM >::output(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output(), oomph::LinearisedAxisymmetricNavierStokesEquations::output(), oomph::LinearisedNavierStokesEquations::output(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::output(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::output(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::PolarNavierStokesEquations::output(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::SphericalAdvectionDiffusionEquations::output(), oomph::SphericalNavierStokesEquations::output(), oomph::SteadyAxisymAdvectionDiffusionEquations::output(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::ElementWithExternalElement::output_external_elements(), oomph::AxisymFoepplvonKarmanEquations::output_fct(), oomph::DisplacementBasedFoepplvonKarmanEquations::output_fct(), oomph::FoepplvonKarmanEquations::output_fct(), oomph::FourierDecomposedHelmholtzEquations::output_fct(), oomph::PMLFourierDecomposedHelmholtzEquations::output_fct(), oomph::YoungLaplaceEquations::output_fct(), oomph::AxisymAdvectionDiffusionEquations::output_fct(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::output_fct(), oomph::AxisymmetricLinearElasticityEquations::output_fct(), oomph::AxisymmetricNavierStokesEquations::output_fct(), oomph::AxisymmetricPoroelasticityEquations::output_fct(), oomph::BiharmonicEquations< DIM >::output_fct(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_fct(), oomph::PolarNavierStokesEquations::output_fct(), oomph::SphericalAdvectionDiffusionEquations::output_fct(), oomph::SphericalNavierStokesEquations::output_fct(), oomph::SteadyAxisymAdvectionDiffusionEquations::output_fct(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::output_fct(), oomph::BiharmonicEquations< DIM >::output_fluid_velocity(), output_paraview(), oomph::FourierDecomposedHelmholtzEquations::output_real(), oomph::PMLFourierDecomposedHelmholtzEquations::output_real(), oomph::FourierDecomposedHelmholtzEquations::output_real_fct(), oomph::PMLFourierDecomposedHelmholtzEquations::output_real_fct(), oomph::AxisymmetricNavierStokesEquations::output_veloc(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedNavierStokesEquations::output_veloc(), oomph::PolarNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_vorticity(), oomph::HermiteShellElement::output_with_time_dep_quantities(), oomph::AxisymmetricNavierStokesEquations::point_output_data(), oomph::AxisymmetricPoroelasticityEquations::point_output_data(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::point_output_data(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::point_output_data(), oomph::NavierStokesEquations< DIM >::point_output_data(), oomph::PoissonEquations< DIM >::point_output_data(), oomph::SpaceTimeNavierStokesEquations< DIM >::point_output_data(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::point_output_data(), oomph::YoungLaplaceEquations::position(), position(), oomph::AxisymmetricNavierStokesEquations::pressure_integral(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::pressure_integral(), oomph::RefineableQElement< 2 >::quad_hang_helper(), oomph::RefineableFSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::residual_for_projection(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::residual_for_projection(), oomph::ProjectableElement< ELEMENT >::residual_for_projection(), oomph::NavierStokesEquations< DIM >::scalar_value_fct_paraview(), oomph::SpaceTimeNavierStokesEquations< DIM >::scalar_value_fct_paraview(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::scalar_value_fct_paraview(), oomph::PMLHelmholtzEquations< DIM >::scalar_value_fct_paraview(), oomph::PoissonEquations< DIM >::scalar_value_fct_paraview(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::scalar_value_fct_paraview(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::scalar_value_fct_paraview(), oomph::AdvectionDiffusionEquations< DIM >::scalar_value_paraview(), oomph::AxisymAdvectionDiffusionEquations::scalar_value_paraview(), oomph::PolarNavierStokesEquations::strain_rate(), and oomph::PolarNavierStokesEquations::strain_rate_by_r().

◆ interpolated_x() [4/4]

void oomph::FiniteElement::interpolated_x ( const Vector< double > &  s,
Vector< double > &  x 
) const
virtual

Return FE interpolated position x[] at local coordinate s as Vector.

Reimplemented in oomph::FaceElement.

Definition at line 4025 of file elements.cc.

References i, nnodal_position_type(), nnode(), nodal_dimension(), nodal_position_gen(), s, and shape().

◆ interpolated_zeta()

void oomph::FiniteElement::interpolated_zeta ( const Vector< double > &  s,
Vector< double > &  zeta 
) const
virtual

Calculate the interpolated value of zeta, the intrinsic coordinate of the element when viewed as a compound geometric object within a Mesh as a function of the local coordinate of the element, s. The default assumption is the zeta is interpolated using the shape functions of the element with the values given by zeta_nodal(). A MacroElement representation of the intrinsic coordinate parametrised by the local coordinate s is used if available. Choosing the MacroElement representation of zeta (Eulerian x by default) allows a correspondence to be established between elements on different Meshes covering the same curvilinear domain in cases where one element is much coarser than the other.

Reimplemented from oomph::GeomObject.

Definition at line 4675 of file elements.cc.

References dim(), get_x_from_macro_element(), i, Macro_elem_pt, nnodal_position_type(), nnode(), shape(), and zeta_nodal().

Referenced by oomph::BrickFromTetMesh< ELEMENT >::build_mesh(), oomph::Mesh::doc_boundary_coordinates(), oomph::RefineableYoungLaplaceEquations::fill_in_contribution_to_residuals(), oomph::YoungLaplaceEquations::fill_in_contribution_to_residuals(), oomph::Multi_domain_functions::first_closer_than_second(), oomph::FSIHermiteBeamElement::locate_zeta(), locate_zeta(), oomph::Multi_domain_functions::locate_zeta_for_local_coordinates(), oomph::FSIAxisymmetricLinearElasticityTractionElement< ELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::output(), oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >::output(), oomph::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::output(), oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::output(), oomph::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::output(), oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::output(), oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::output(), oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::output(), oomph::FaceElement::output_zeta(), oomph::Multi_domain_functions::setup_bulk_elements_adjacent_to_face_mesh(), and oomph::ThinLayerBrickOnTetMesh< ELEMENT >::ThinLayerBrickOnTetMesh().

◆ invert_jacobian() [1/5]

template<>
double oomph::FiniteElement::invert_jacobian ( const DenseMatrix< double > &  jacobian,
DenseMatrix< double > &  inverse_jacobian 
) const
protected

Zero-d specialisation of function to calculate inverse of jacobian mapping.

Definition at line 2044 of file elements.cc.

References oomph::oomph_info.

◆ invert_jacobian() [2/5]

template<>
double oomph::FiniteElement::invert_jacobian ( const DenseMatrix< double > &  jacobian,
DenseMatrix< double > &  inverse_jacobian 
) const
protected

One-d specialisation of function to calculate inverse of jacobian mapping.

Definition at line 2064 of file elements.cc.

References check_jacobian().

◆ invert_jacobian() [3/5]

template<>
double oomph::FiniteElement::invert_jacobian ( const DenseMatrix< double > &  jacobian,
DenseMatrix< double > &  inverse_jacobian 
) const
protected

Two-d specialisation of function to calculate inverse of jacobian mapping.

Definition at line 2087 of file elements.cc.

References check_jacobian().

◆ invert_jacobian() [4/5]

template<>
double oomph::FiniteElement::invert_jacobian ( const DenseMatrix< double > &  jacobian,
DenseMatrix< double > &  inverse_jacobian 
) const
protected

Three-d specialisation of function to calculate inverse of jacobian mapping.

Definition at line 2115 of file elements.cc.

References check_jacobian().

◆ invert_jacobian() [5/5]

template<unsigned DIM>
double oomph::FiniteElement::invert_jacobian ( const DenseMatrix< double > &  jacobian,
DenseMatrix< double > &  inverse_jacobian 
) const
protected

Take the matrix passed as jacobian and return its inverse in inverse_jacobian. This function is templated by the dimension of the element because matrix inversion cannot be written efficiently in a generic manner.

◆ invert_jacobian_mapping()

double oomph::FiniteElement::invert_jacobian_mapping ( const DenseMatrix< double > &  jacobian,
DenseMatrix< double > &  inverse_jacobian 
) const
protectedvirtual

A template-free interface that takes the matrix passed as jacobian and return its inverse in inverse_jacobian. By default the function will use the dimension of the element to call the correct invert_jacobian(..) function. This should be overloaded for efficiency (removal of a switch statement) in specific elements.

Template-free interface for inversion of the jacobian of a mapping. This is slightly inefficient, given that it uses a switch statement. It can always be overloaded in specific geometric elements, for efficiency reasons.

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::DiagQHermiteElement< DIM >, oomph::QHermiteElement< DIM >, and oomph::QHermiteElement< DIM - 1 >.

Definition at line 2166 of file elements.cc.

References dim().

Referenced by local_to_eulerian_mapping(), and oomph::SolidFiniteElement::local_to_lagrangian_mapping().

◆ J_eulerian()

double oomph::FiniteElement::J_eulerian ( const Vector< double > &  s) const
virtual

Return the Jacobian of mapping from local to global coordinates at local position s.

Calculate the determinant of the Jacobian of the mapping between local and global coordinates at the position. Works directly from the base vectors without assuming that coordinates match spatial dimension. Will be overloaded in FaceElements, in which the elemental dimension does not match the spatial dimension. WARNING: this is always positive and cannot be used to check if the element is inverted, say!

Reimplemented in oomph::FaceElement, oomph::BiharmonicFluxElement< DIM >, and oomph::BiharmonicFluxElement< DIM >.

Definition at line 4103 of file elements.cc.

References assemble_eulerian_base_vectors(), dim(), dshape_local(), i, nnodal_position_type(), nnode(), nodal_dimension(), oomph::oomph_info, and s.

Referenced by oomph::AxisymAdvectionDiffusionEquations::compute_error(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::compute_error(), oomph::AxisymFoepplvonKarmanEquations::compute_error(), oomph::AxisymmetricLinearElasticityEquations::compute_error(), oomph::BiharmonicEquations< DIM >::compute_error(), oomph::DisplacementBasedFoepplvonKarmanEquations::compute_error(), oomph::FoepplvonKarmanEquations::compute_error(), oomph::FourierDecomposedHelmholtzEquations::compute_error(), oomph::PMLFourierDecomposedHelmholtzEquations::compute_error(), oomph::SphericalAdvectionDiffusionEquations::compute_error(), oomph::SteadyAxisymAdvectionDiffusionEquations::compute_error(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::compute_error(), oomph::YoungLaplaceEquations::compute_error(), oomph::AxisymmetricPoroelasticityEquations::compute_error(), oomph::AxisymmetricNavierStokesEquations::compute_error(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::compute_error(), oomph::PolarNavierStokesEquations::compute_error(), oomph::SphericalNavierStokesEquations::compute_error(), oomph::SphericalNavierStokesEquations::compute_error_e(), oomph::SolidFiniteElement::compute_norm(), oomph::FourierDecomposedHelmholtzEquations::compute_norm(), oomph::PMLFourierDecomposedHelmholtzEquations::compute_norm(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::compute_norm(), oomph::AxisymmetricNavierStokesEquations::compute_physical_size(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::compute_physical_size(), oomph::AxisymmetricNavierStokesEquations::dissipation(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::dissipation(), oomph::PolarNavierStokesEquations::dissipation(), oomph::SphericalNavierStokesEquations::dissipation(), oomph::SphericalNavierStokesEquations::extract_velocity(), oomph::Z2ErrorEstimator::get_element_errors(), oomph::Z2ErrorEstimator::get_recovered_flux_in_patch(), integrate_fct(), oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectablePVDElement< PVD_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectablePVDElementWithContinuousPressure< PVD_ELEMENT >::jacobian_and_shape_of_field(), oomph::AxisymmetricNavierStokesEquations::kin_energy(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::kin_energy(), oomph::PolarNavierStokesEquations::kin_energy(), oomph::SphericalNavierStokesEquations::kin_energy(), oomph::AxisymmetricNavierStokesEquations::pressure_integral(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::pressure_integral(), oomph::PolarNavierStokesEquations::pressure_integral(), oomph::SphericalNavierStokesEquations::pressure_integral(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::residual_for_projection(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::residual_for_projection(), oomph::ProjectableElement< ELEMENT >::residual_for_projection(), and self_test().

◆ J_eulerian_at_knot()

double oomph::FiniteElement::J_eulerian_at_knot ( const unsigned &  ipt) const
virtual

◆ local_coord_is_valid()

virtual bool oomph::FiniteElement::local_coord_is_valid ( const Vector< double > &  s)
inlinevirtual

Broken assignment operator.

Check whether the local coordinate are valid or not

Reimplemented in oomph::TElementBase, oomph::QElementBase, oomph::QHermiteElement< DIM >, and oomph::QHermiteElement< DIM - 1 >.

Definition at line 1813 of file elements.h.

Referenced by locate_zeta().

◆ local_coordinate_of_node()

virtual void oomph::FiniteElement::local_coordinate_of_node ( const unsigned &  j,
Vector< double > &  s 
) const
inlinevirtual

Get local coordinates of node j in the element; vector sets its own size (broken virtual)

Reimplemented in oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >, oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >, oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >, oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, and oomph::PointElement.

Definition at line 1842 of file elements.h.

Referenced by oomph::TreeBasedRefineableMeshBase::adapt_mesh(), oomph::GmshTetMesh< ELEMENT >::build_from_scaffold(), oomph::TetgenMesh< ELEMENT >::build_from_scaffold(), oomph::TriangleMesh< ELEMENT >::build_from_scaffold(), oomph::BrickFromTetMesh< ELEMENT >::build_mesh(), oomph::Multi_domain_functions::construct_new_external_halo_master_node_helper(), oomph::Missing_masters_functions::construct_new_external_halo_master_node_helper(), oomph::Multi_domain_functions::construct_new_external_halo_node_helper(), oomph::Missing_masters_functions::construct_new_external_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::construct_new_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::construct_new_node_load_balance_helper(), oomph::TPVDElement< DIM, NNODE_1D >::describe_local_dofs(), oomph::SpaceTimeNavierStokesEquations< DIM >::du_dt_nst(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::du_dt_nst(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::du_dt_ust_heat(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::du_dt_ust_heat(), local_fraction_of_node(), oomph::Mesh::node_update(), oomph::TreeBasedRefineableMeshBase::p_adapt_mesh(), oomph::MacroElementNodeUpdateElement< ELEMENT >::rebuild_from_sons(), oomph::MacroElementNodeUpdateElement< ELEMENT >::set_node_update_info(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::setup_algebraic_node_update(), oomph::RefineableTriangleMesh< ELEMENT >::snap_nodes_onto_boundary(), and oomph::TreeBasedRefineableMeshBase::synchronise_nonhanging_nodes().

◆ local_fraction_of_node()

void oomph::FiniteElement::local_fraction_of_node ( const unsigned &  j,
Vector< double > &  s_fraction 
)
virtual

◆ local_one_d_fraction_of_node()

virtual double oomph::FiniteElement::local_one_d_fraction_of_node ( const unsigned &  n1d,
const unsigned &  i 
)
inlinevirtual

Get the local fraction of any node in the n-th position in a one dimensional expansion along the i-th local coordinate.

Reimplemented in oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >, oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >, oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >, oomph::QHermiteElement< DIM >, and oomph::QHermiteElement< DIM - 1 >.

Definition at line 1858 of file elements.h.

References oomph::Global_string_for_annotation::string().

Referenced by oomph::RefineableAxisymmetricQTaylorHoodElement::local_one_d_fraction_of_interpolating_node(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::local_one_d_fraction_of_interpolating_node(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::local_one_d_fraction_of_interpolating_node(), oomph::RefineableLinearisedQTaylorHoodElement::local_one_d_fraction_of_interpolating_node(), oomph::RefineableQSphericalTaylorHoodElement::local_one_d_fraction_of_interpolating_node(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::local_one_d_fraction_of_interpolating_node(), oomph::RefineableElement::local_one_d_fraction_of_interpolating_node(), oomph::RefineableQTaylorHoodElement< DIM >::local_one_d_fraction_of_interpolating_node(), oomph::RefineablePolarTaylorHoodElement::local_one_d_fraction_of_interpolating_node(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::local_one_d_fraction_of_interpolating_node(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::local_one_d_fraction_of_interpolating_node(), and oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::local_one_d_fraction_of_interpolating_node().

◆ local_to_eulerian_mapping() [1/2]

double oomph::FiniteElement::local_to_eulerian_mapping ( const DShape dpsids,
DenseMatrix< double > &  inverse_jacobian 
) const
inlineprotected

Calculate the mapping from local to Eulerian coordinates, given the derivatives of the shape functions w.r.t. local coordinates, Return only the determinant of the jacobian and the inverse of the mapping (ds/dx).

Definition at line 1524 of file elements.h.

References dim(), and local_to_eulerian_mapping().

◆ local_to_eulerian_mapping() [2/2]

virtual double oomph::FiniteElement::local_to_eulerian_mapping ( const DShape dpsids,
DenseMatrix< double > &  jacobian,
DenseMatrix< double > &  inverse_jacobian 
) const
inlineprotectedvirtual

Calculate the mapping from local to Eulerian coordinates, given the derivatives of the shape functions w.r.t. local coordinates. Returns the determinant of the jacobian, the jacobian and inverse jacobian.

Reimplemented in oomph::DiagQHermiteElement< DIM >.

Definition at line 1508 of file elements.h.

References assemble_local_to_eulerian_jacobian(), and invert_jacobian_mapping().

Referenced by d2shape_eulerian(), d2shape_eulerian_at_knot(), dJ_eulerian_at_knot(), oomph::AxisymmetricTCrouzeixRaviartElement::dpshape_and_dptest_eulerian_axi_nst(), oomph::AxisymmetricTTaylorHoodElement::dpshape_and_dptest_eulerian_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement::dpshape_and_dptest_eulerian_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::dpshape_and_dptest_eulerian_axi_nst(), dshape_eulerian(), dshape_eulerian_at_knot(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::get_flux(), oomph::AxisymmetricNavierStokesEquations::interpolated_d_dudx_dX_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_d_dudx_dX_axi_nst(), oomph::AxisymmetricPoroelasticityEquations::interpolated_div_q(), oomph::DarcyEquations< DIM >::interpolated_div_q(), oomph::PoroelasticityEquations< DIM >::interpolated_div_q(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::interpolated_du_dt_nst(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::interpolated_du_dt_ust_heat(), local_to_eulerian_mapping(), and oomph::AxisymmetricPoroelasticityEquations::transform_basis().

◆ local_to_eulerian_mapping_diagonal()

double oomph::FiniteElement::local_to_eulerian_mapping_diagonal ( const DShape dpsids,
DenseMatrix< double > &  jacobian,
DenseMatrix< double > &  inverse_jacobian 
) const
protectedvirtual

Calculate the mapping from local to Eulerian coordinates given the derivatives of the shape functions w.r.t the local coordinates. assuming that the coordinates are aligned in the direction of the local coordinates, i.e. there are no cross terms and the jacobian is diagonal. This function returns the determinant of the jacobian, the jacobian and the inverse jacobian.

Calculate the mapping from local to eulerian coordinates assuming that the coordinates are aligned in the direction of the local coordinates, i.e. there are no cross terms and the jacobian is diagonal. The local derivatives are passed as dpsids and the jacobian and inverse jacobian are returned.

Reimplemented in oomph::RefineableElement.

Definition at line 2588 of file elements.cc.

References check_jacobian(), dim(), Elemental_dimension, i, nnodal_position_type(), nnode(), Nodal_dimension, and raw_nodal_position_gen().

Referenced by oomph::DiagQHermiteElement< DIM >::local_to_eulerian_mapping().

◆ locate_zeta()

void oomph::FiniteElement::locate_zeta ( const Vector< double > &  zeta,
GeomObject *&  geom_object_pt,
Vector< double > &  s,
const bool &  use_coordinate_as_initial_guess = false 
)
virtual

For a given value of zeta, the "global" intrinsic coordinate of a mesh of FiniteElements represented as a compound geometric object, find the local coordinate in this element that corresponds to the requested value of zeta. If zeta cannot be located in this element, geom_object_pt is set to NULL. If zeta is located in this element, we return its "this" pointer. By default don't use any value passed in to the local coordinate s as the initial guess in the Newton method.

For a given value of zeta, the "global" intrinsic coordinate of a mesh of FiniteElements represented as a compound geometric object, find the local coordinate in this element that corresponds to the requested value of zeta. This is achieved in generality by using Newton's method to find the value of the local coordinate, s, such that interpolated_zeta(s) is equal to the requested value of zeta. If zeta cannot be located in this element, geom_object_pt is set to NULL. If zeta is located in this element, we return its "this" pointer. Setting the optional bool argument to true means that the coordinate argument "s" is used as the initial guess. (Default is false).

Reimplemented from oomph::GeomObject.

Definition at line 4734 of file elements.cc.

References oomph::GeneralisedElement::Default_fd_jacobian_step, dim(), oomph::OomphLibException::disable_error_message(), dshape_local(), get_centre_of_gravity_and_max_radius_in_terms_of_zeta(), get_s_plot(), i, interpolated_zeta(), local_coord_is_valid(), macro_elem_pt(), oomph::Locate_zeta_helpers::Max_newton_iterations, move_local_coord_back_into_element(), oomph::Locate_zeta_helpers::N_local_points, oomph::Locate_zeta_helpers::Newton_tolerance, nnodal_position_type(), nnode(), nplot_points(), oomph::oomph_info, oomph::Locate_zeta_helpers::Radius_multiplier_for_fast_exit_from_locate_zeta, s, oomph::DoubleMatrixBase::solve(), and zeta_nodal().

◆ macro_elem_pt()

MacroElement* oomph::FiniteElement::macro_elem_pt ( )
inline

◆ move_local_coord_back_into_element()

virtual void oomph::FiniteElement::move_local_coord_back_into_element ( Vector< double > &  s) const
inlinevirtual

Adjust local coordinates so that they're located inside the element.

Reimplemented in oomph::TElementBase, oomph::QElementBase, oomph::QHermiteElement< DIM >, and oomph::QHermiteElement< DIM - 1 >.

Definition at line 1824 of file elements.h.

Referenced by locate_zeta().

◆ ngeom_data()

unsigned oomph::FiniteElement::ngeom_data ( ) const
inlinevirtual

A standard FiniteElement is fixed, so there are no geometric data when viewed in its GeomObject incarnation.

Reimplemented from oomph::GeomObject.

Reimplemented in oomph::RefineableSolidElement, oomph::FaceElementAsGeomObject< ELEMENT >, and oomph::SolidFiniteElement.

Definition at line 2660 of file elements.h.

Referenced by oomph::ElementWithExternalElement::assign_external_interaction_data_local_eqn_numbers().

◆ nnodal_position_type()

unsigned oomph::FiniteElement::nnodal_position_type ( ) const
inline

Return the number of coordinate types that the element requires to interpolate the geometry between the nodes. For Lagrange elements it is 1.

Definition at line 2463 of file elements.h.

References Nnodal_position_type.

Referenced by assemble_eulerian_base_vectors(), oomph::RefineableElement::assemble_eulerian_base_vectors(), assemble_local_to_eulerian_jacobian(), oomph::RefineableElement::assemble_local_to_eulerian_jacobian(), assemble_local_to_eulerian_jacobian2(), oomph::RefineableElement::assemble_local_to_eulerian_jacobian2(), oomph::RefineableSolidElement::assign_solid_hanging_local_eqn_numbers(), oomph::SolidFiniteElement::assign_solid_local_eqn_numbers(), oomph::SolidICProblem::backup_original_state(), check_J_eulerian_at_knots(), oomph::FaceElement::check_J_eulerian_at_knots(), oomph::ElementWithSpecificMovingNodes< ELEMENT, NODE_TYPE >::construct_boundary_node(), oomph::SolidFiniteElement::construct_boundary_node(), oomph::ElementWithSpecificMovingNodes< ELEMENT, NODE_TYPE >::construct_node(), oomph::SolidFiniteElement::construct_node(), oomph::FaceElement::continuous_tangent_and_outer_unit_normal(), oomph::FSIHermiteBeamElement::dposition_dlagrangian_at_local_coordinate(), oomph::FSIDiagHermiteShellElement::dposition_dlagrangian_at_local_coordinate(), oomph::ClampedSlidingHermiteBeamBoundaryConditionElement::fill_in_contribution_to_residuals(), oomph::AxisymmetricPVDEquations::fill_in_contribution_to_residuals_axisym_pvd(), oomph::KirchhoffLoveBeamEquations::fill_in_contribution_to_residuals_beam(), oomph::KirchhoffLoveShellEquations::fill_in_contribution_to_residuals_shell(), oomph::AxisymmetricLinearElasticityEquations::fill_in_generic_contribution_to_residuals_axisymmetric_linear_elasticity(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::fill_in_generic_contribution_to_residuals_fourier_decomp_time_harmonic_linear_elasticity(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::SolidFiniteElement::fill_in_generic_jacobian_for_solid_ic(), oomph::AxisymmetricPVDEquationsWithPressure::fill_in_generic_residual_contribution_axisym_pvd_with_pressure(), oomph::SolidFiniteElement::fill_in_jacobian_for_newmark_accel(), oomph::SolidFiniteElement::fill_in_jacobian_from_solid_position_by_fd(), oomph::RefineableSolidElement::fill_in_jacobian_from_solid_position_by_fd(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::FSIImposeDisplacementByLagrangeMultiplierElement(), oomph::FSIHermiteBeamElement::get_dof_numbers_for_unknowns(), oomph::FSIDiagHermiteShellElement::get_dof_numbers_for_unknowns(), oomph::ClampedHermiteShellBoundaryConditionElement::get_dof_numbers_for_unknowns(), oomph::PVDEquationsBase< DIM >::get_dof_numbers_for_unknowns(), oomph::PVDEquationsWithPressure< DIM >::get_dof_numbers_for_unknowns(), oomph::KirchhoffLoveShellEquations::get_energy(), oomph::KirchhoffLoveBeamEquations::get_energy(), oomph::KirchhoffLoveBeamEquations::get_non_unit_tangent(), oomph::KirchhoffLoveShellEquations::get_normal(), oomph::KirchhoffLoveBeamEquations::get_normal(), oomph::AxisymmetricLinearElasticityEquations::get_strain(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::get_strain(), oomph::KirchhoffLoveShellEquations::get_strain_and_bend(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::ImposeDisplacementByLagrangeMultiplierElement(), interpolated_dxdt(), interpolated_x(), interpolated_zeta(), J_eulerian(), oomph::FaceElement::J_eulerian(), J_eulerian_at_knot(), oomph::FaceElement::J_eulerian_at_knot(), oomph::KirchhoffLoveShellEquations::load_rate_of_work(), local_to_eulerian_mapping_diagonal(), oomph::RefineableElement::local_to_eulerian_mapping_diagonal(), locate_zeta(), oomph::FaceElement::outer_unit_normal(), oomph::HermiteBeamElement::output(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::SolidFiniteElement::position_local_eqn(), oomph::StorableShapeElementBase::pre_compute_d2shape_eulerian_at_knots(), oomph::StorableShapeElementBase::pre_compute_d2shape_local_at_knots(), oomph::StorableShapeElementBase::pre_compute_dshape_eulerian_at_knots(), oomph::StorableShapeElementBase::pre_compute_dshape_local_at_knots(), oomph::StorableShapeElementBase::pre_compute_shape_at_knots(), oomph::RefineableImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::RefineableFSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::SolidICProblem::reset_original_state(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::residual_for_projection(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::residual_for_projection(), oomph::ProjectableElement< ELEMENT >::residual_for_projection(), self_test(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::set_boundary_shape_geom_object_pt(), oomph::SolidICProblem::setup_problem(), and oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::square_of_l2_norm_of_error().

◆ nnode()

unsigned oomph::FiniteElement::nnode ( ) const
inline

Return the number of nodes.

Definition at line 2210 of file elements.h.

References Nnode.

Referenced by oomph::TreeBasedRefineableMeshBase::adapt_mesh(), oomph::SurfactantTransportInterfaceElement::add_additional_residual_contributions_interface(), oomph::FaceElement::add_additional_values(), oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::add_element_contribution_to_aux_integral(), oomph::DGFaceElement::add_flux_contributions(), assemble_eulerian_base_vectors(), oomph::RefineableElement::assemble_eulerian_base_vectors(), assemble_local_to_eulerian_jacobian(), oomph::RefineableElement::assemble_local_to_eulerian_jacobian(), assemble_local_to_eulerian_jacobian2(), oomph::RefineableElement::assemble_local_to_eulerian_jacobian2(), oomph::SolidFiniteElement::assemble_local_to_lagrangian_jacobian(), oomph::RefineableSolidElement::assemble_local_to_lagrangian_jacobian(), oomph::SolidFiniteElement::assemble_local_to_lagrangian_jacobian2(), oomph::RefineableSolidElement::assemble_local_to_lagrangian_jacobian2(), oomph::ElementWithMovingNodes::assemble_set_of_all_geometric_data(), oomph::ElementWithExternalElement::assign_external_interaction_data_local_eqn_numbers(), oomph::RefineableElement::assign_hanging_local_eqn_numbers(), oomph::GeneralisedElement::assign_local_eqn_numbers(), assign_nodal_local_eqn_numbers(), oomph::RefineableSolidElement::assign_solid_hanging_local_eqn_numbers(), oomph::SolidFiniteElement::assign_solid_local_eqn_numbers(), oomph::BackupMeshForProjection< GEOMETRIC_ELEMENT >::BackupMeshForProjection(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::BrethertonSpineMesh(), oomph::GmshTetMesh< ELEMENT >::build_from_scaffold(), oomph::BackwardStepQuadMesh< ELEMENT >::build_mesh(), oomph::ExtrudedCubeMeshFromQuadMesh< ELEMENT >::build_mesh(), oomph::TriangleMesh< ELEMENT >::check_connections_of_polyline_nodes(), oomph::Mesh::check_halo_schemes(), oomph::Mesh::check_inverted_elements(), check_J_eulerian_at_knots(), oomph::FaceElement::check_J_eulerian_at_knots(), check_jacobian(), oomph::TriangleScaffoldMesh::check_mesh_integrity(), oomph::Mesh::classify_halo_and_haloed_nodes(), oomph::FourierDecomposedHelmholtzDtNBoundaryElement< ELEMENT >::complete_setup_of_dependencies(), oomph::HelmholtzDtNBoundaryElement< ELEMENT >::complete_setup_of_dependencies(), oomph::TriangleMesh< ELEMENT >::compute_boundary_segments_connectivity_and_initial_zeta_values(), oomph::HelmholtzBCElementBase< ELEMENT >::compute_contribution_to_fourier_components(), oomph::AxisymAdvectionDiffusionEquations::compute_error(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::compute_error(), oomph::AxisymFoepplvonKarmanEquations::compute_error(), oomph::BiharmonicEquations< DIM >::compute_error(), oomph::DisplacementBasedFoepplvonKarmanEquations::compute_error(), oomph::FoepplvonKarmanEquations::compute_error(), oomph::FourierDecomposedHelmholtzEquations::compute_error(), oomph::PMLFourierDecomposedHelmholtzEquations::compute_error(), oomph::SphericalAdvectionDiffusionEquations::compute_error(), oomph::SteadyAxisymAdvectionDiffusionEquations::compute_error(), oomph::EulerEquations< DIM >::compute_error(), oomph::ScalarAdvectionEquations< DIM >::compute_error(), oomph::RefineableTriangleMesh< ELEMENT >::compute_global_node_names_and_shared_nodes(), oomph::SolidFiniteElement::compute_norm(), oomph::FourierDecomposedHelmholtzEquations::compute_norm(), oomph::PMLFourierDecomposedHelmholtzEquations::compute_norm(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::compute_norm(), oomph::AxisymmetricPVDEquations::compute_physical_size(), oomph::AxisymmetricPVDEquationsWithPressure::compute_physical_size(), oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::compute_stabilisation_parameter(), oomph::DGElement::construct_boundary_nodes_and_faces(), oomph::Multi_domain_functions::construct_new_external_halo_master_node_helper(), oomph::Missing_masters_functions::construct_new_external_halo_master_node_helper(), oomph::DGElement::construct_nodes_and_faces(), oomph::FaceElement::continuous_tangent_and_outer_unit_normal(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::contribution_to_enclosed_volume(), oomph::LineVolumeConstraintBoundingElement::contribution_to_enclosed_volume(), oomph::AxisymmetricVolumeConstraintBoundingElement::contribution_to_enclosed_volume(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::contribution_to_total_porous_flux(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::contribution_to_total_porous_flux(), oomph::AxisymmetricVolumeConstraintBoundingElement::contribution_to_volume_flux(), oomph::LinearisedQCrouzeixRaviartElement::copy_efunction_to_normalisation(), oomph::RefineableTriangleMesh< ELEMENT >::create_adjacency_matrix_new_shared_edges_helper(), oomph::RefineableTriangleMesh< ELEMENT >::create_element_load_balance_helper(), oomph::Multi_domain_functions::create_external_halo_elements(), oomph::RefineableTriangleMesh< ELEMENT >::create_halo_element(), oomph::RefineableTriangleMesh< ELEMENT >::create_new_shared_boundaries(), oomph::TriangleMesh< ELEMENT >::create_polylines_from_halo_elements_helper(), oomph::RefineableTriangleMesh< ELEMENT >::create_sorted_face_mesh_representation(), d_dshape_eulerian_dnodal_coordinates(), d_dshape_eulerian_dnodal_coordinates_templated_helper(), oomph::SphericalNavierStokesEquations::d_kin_energy_dt(), oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >::d_shape_and_test_local(), oomph::HelmholtzBCElementBase< ELEMENT >::d_shape_and_test_local(), oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >::d_shape_and_test_local(), oomph::ProjectableAdvectionDiffusionReactionElement< ADR_ELEMENT >::data_values_of_field(), oomph::ProjectableAxisymLinearElasticityElement< AXISYM_LINEAR_ELAST_ELEMENT >::data_values_of_field(), oomph::ProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::data_values_of_field(), oomph::ProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::data_values_of_field(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::data_values_of_field(), oomph::ProjectableDisplacementBasedFoepplvonKarmanElement< FVK_ELEMENT >::data_values_of_field(), oomph::ProjectableFoepplvonKarmanElement< FVK_ELEMENT >::data_values_of_field(), oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::data_values_of_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::data_values_of_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::data_values_of_field(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::data_values_of_field(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::data_values_of_field(), oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::data_values_of_field(), oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >::data_values_of_field(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::data_values_of_field(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::data_values_of_field(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::data_values_of_field(), oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::data_values_of_field(), oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >::data_values_of_field(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::data_values_of_field(), oomph::ProjectablePoissonElement< POISSON_ELEMENT >::data_values_of_field(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::data_values_of_field(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::data_values_of_field(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::data_values_of_field(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::data_values_of_field(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::data_values_of_field(), oomph::RefineableElement::deactivate_element(), describe_nodal_local_dofs(), oomph::SolidFiniteElement::describe_solid_local_dofs(), oomph::AdvectionDiffusionEquations< DIM >::dinterpolated_u_adv_diff_ddata(), oomph::RefineableAdvectionDiffusionEquations< DIM >::dinterpolated_u_adv_diff_ddata(), oomph::RefineableAxisymAdvectionDiffusionEquations::dinterpolated_u_adv_diff_ddata(), oomph::RefineableSphericalAdvectionDiffusionEquations::dinterpolated_u_adv_diff_ddata(), oomph::SphericalAdvectionDiffusionEquations::dinterpolated_u_adv_diff_ddata(), oomph::SteadyAxisymAdvectionDiffusionEquations::dinterpolated_u_adv_diff_ddata(), oomph::AxisymAdvectionDiffusionEquations::dinterpolated_u_axi_adv_diff_ddata(), oomph::AxisymmetricNavierStokesEquations::dinterpolated_u_axi_nst_ddata(), oomph::RefineableAxisymmetricNavierStokesEquations::dinterpolated_u_axi_nst_ddata(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::dinterpolated_u_axi_nst_ddata(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::dinterpolated_u_axi_nst_ddata(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::RefineableGeneralisedNewtonianNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::NavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::RefineableNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::SpaceTimeNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::RefineableSpaceTimeNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::RefineableSpaceTimeNavierStokesMixedOrderEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::DisplacementControlElement::DisplacementControlElement(), oomph::Mesh::distribute(), dJ_eulerian_at_knot(), dJ_eulerian_dnodal_coordinates(), dJ_eulerian_dnodal_coordinates_templated_helper(), oomph::Z2ErrorEstimator::doc_flux(), oomph::Mesh::doc_mesh_distribution(), oomph::FSIHermiteBeamElement::dposition_dlagrangian_at_local_coordinate(), oomph::FSIDiagHermiteShellElement::dposition_dlagrangian_at_local_coordinate(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::dposition_dt(), oomph::DummyErrorEstimator::DummyErrorEstimator(), oomph::AxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::AxisymFoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::DisplacementBasedFoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::FoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::ClampedHermiteShellBoundaryConditionElement::fill_in_contribution_to_residuals(), oomph::RefineableYoungLaplaceEquations::fill_in_contribution_to_residuals(), oomph::YoungLaplaceEquations::fill_in_contribution_to_residuals(), oomph::AxisymmetricPVDEquations::fill_in_contribution_to_residuals_axisym_pvd(), oomph::KirchhoffLoveBeamEquations::fill_in_contribution_to_residuals_beam(), oomph::KirchhoffLoveShellEquations::fill_in_contribution_to_residuals_shell(), oomph::AxisymmetricLinearElasticityEquations::fill_in_generic_contribution_to_residuals_axisymmetric_linear_elasticity(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::fill_in_generic_contribution_to_residuals_fourier_decomp_time_harmonic_linear_elasticity(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::ImposeImpenetrabilityElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::ImposeParallelOutflowElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::SolidFiniteElement::fill_in_generic_jacobian_for_solid_ic(), oomph::AxisymmetricPoroelasticityEquations::fill_in_generic_residual_contribution(), oomph::PolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::RefineablePolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::SteadyAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_adv_diff(), oomph::AxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::RefineableAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::AxisymmetricPVDEquationsWithPressure::fill_in_generic_residual_contribution_axisym_pvd_with_pressure(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::NavierStokesFluxControlElement< ELEMENT >::fill_in_generic_residual_contribution_fluid_traction(), oomph::FourierDecomposedHelmholtzEquations::fill_in_generic_residual_contribution_fourier_decomposed_helmholtz(), oomph::FourierDecomposedHelmholtzDtNBoundaryElement< ELEMENT >::fill_in_generic_residual_contribution_fourier_decomposed_helmholtz_DtN_bc(), oomph::HelmholtzAbsorbingBCElement< ELEMENT >::fill_in_generic_residual_contribution_helmholtz_abc(), oomph::HelmholtzDtNBoundaryElement< ELEMENT >::fill_in_generic_residual_contribution_helmholtz_DtN_bc(), oomph::FluidInterfaceElement::fill_in_generic_residual_contribution_interface(), oomph::LineFluidInterfaceBoundingElement::fill_in_generic_residual_contribution_interface_boundary(), oomph::LinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::RefineableLinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::LinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::RefineableLinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::PeriodicOrbitEquations::fill_in_generic_residual_contribution_orbit(), oomph::PMLFourierDecomposedHelmholtzEquations::fill_in_generic_residual_contribution_pml_fourier_decomposed_helmholtz(), oomph::RefineableSphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::SphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::RefineableSphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::SphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::LineVolumeConstraintBoundingElement::fill_in_generic_residual_contribution_volume_constraint(), oomph::AxisymmetricVolumeConstraintBoundingElement::fill_in_generic_residual_contribution_volume_constraint(), oomph::SurfaceVolumeConstraintBoundingElement::fill_in_generic_residual_contribution_volume_constraint(), oomph::SolidFiniteElement::fill_in_jacobian_for_newmark_accel(), oomph::ElementWithMovingNodes::fill_in_jacobian_from_geometric_data(), fill_in_jacobian_from_nodal_by_fd(), oomph::RefineableElement::fill_in_jacobian_from_nodal_by_fd(), oomph::SolidFiniteElement::fill_in_jacobian_from_solid_position_by_fd(), oomph::RefineableSolidElement::fill_in_jacobian_from_solid_position_by_fd(), oomph::RefineableNavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::NavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_by_fd(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::FSIImposeDisplacementByLagrangeMultiplierElement(), oomph::PolarNavierStokesEquations::full_output(), oomph::SphericalNavierStokesEquations::full_output(), oomph::RefineableSolidElement::geom_data_pt(), oomph::RefineableTriangleMesh< ELEMENT >::get_boundary_segment_nodes_helper(), oomph::FoepplvonKarmanEquations::get_bounded_volume(), get_centre_of_gravity_and_max_radius_in_terms_of_zeta(), oomph::Problem::get_data_to_be_sent_during_load_balancing(), oomph::PoissonEquations< DIM >::get_dflux_dnodal_u(), oomph::ElementWithMovingNodes::get_dnodal_coordinates_dgeom_dofs(), oomph::AxisymmetricLinearElasticityEquationsBase::get_dof_numbers_for_unknowns(), oomph::AxisymmetricQCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::AxisymmetricQTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::AxisymmetricTCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::AxisymmetricTTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::FSIHermiteBeamElement::get_dof_numbers_for_unknowns(), oomph::BiharmonicEquations< DIM >::get_dof_numbers_for_unknowns(), oomph::TDisplacementBasedFoepplvonKarmanElement< NNODE_1D >::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >::get_dof_numbers_for_unknowns(), oomph::LinearElasticityEquationsBase< DIM >::get_dof_numbers_for_unknowns(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::get_dof_numbers_for_unknowns(), oomph::ImposeImpenetrabilityElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::ImposeParallelOutflowElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::TTaylorHoodElement< DIM >::get_dof_numbers_for_unknowns(), oomph::PMLHelmholtzEquations< DIM >::get_dof_numbers_for_unknowns(), oomph::PMLHelmholtzFluxElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::PMLTimeHarmonicLinearElasticityEquationsBase< DIM >::get_dof_numbers_for_unknowns(), oomph::FSIDiagHermiteShellElement::get_dof_numbers_for_unknowns(), oomph::ClampedHermiteShellBoundaryConditionElement::get_dof_numbers_for_unknowns(), oomph::PVDEquationsBase< DIM >::get_dof_numbers_for_unknowns(), oomph::PVDEquationsWithPressure< DIM >::get_dof_numbers_for_unknowns(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::BlockPrecQTaylorHoodSpaceTimeElement::get_dof_numbers_for_unknowns(), oomph::BlockPrecQTaylorHoodMixedOrderSpaceTimeElement::get_dof_numbers_for_unknowns(), oomph::QSphericalCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::QSphericalTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquationsBase::get_dof_numbers_for_unknowns(), oomph::TimeHarmonicLinearElasticityEquationsBase< DIM >::get_dof_numbers_for_unknowns(), oomph::AxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), get_dresidual_dnodal_coordinates(), oomph::RefineableElement::get_dresidual_dnodal_coordinates(), oomph::TriangleMesh< ELEMENT >::get_element_edges_on_boundary(), oomph::Z2ErrorEstimator::get_element_errors(), oomph::KirchhoffLoveShellEquations::get_energy(), oomph::KirchhoffLoveBeamEquations::get_energy(), oomph::RefineableTriangleMesh< ELEMENT >::get_face_mesh_representation(), oomph::ProjectableAdvectionDiffusionReactionElement< ADR_ELEMENT >::get_field(), oomph::ProjectableAxisymLinearElasticityElement< AXISYM_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::ProjectableDisplacementBasedFoepplvonKarmanElement< FVK_ELEMENT >::get_field(), oomph::ProjectableFoepplvonKarmanElement< FVK_ELEMENT >::get_field(), oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::get_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::get_field(), oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >::get_field(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::get_field(), oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >::get_field(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectablePoissonElement< POISSON_ELEMENT >::get_field(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::get_field(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::get_field(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::get_field(), oomph::AdvectionDiffusionEquations< DIM >::get_flux(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::get_flux(), oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >::get_flux(), oomph::AxisymAdvectionDiffusionEquations::get_flux(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::get_flux(), oomph::LinearWaveEquations< DIM >::get_flux(), oomph::PoissonEquations< DIM >::get_flux(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::get_flux(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::get_flux(), oomph::SphericalAdvectionDiffusionEquations::get_flux(), oomph::SteadyAxisymAdvectionDiffusionEquations::get_flux(), oomph::UnsteadyHeatEquations< DIM >::get_flux(), oomph::WomersleyEquations< DIM >::get_flux(), oomph::YoungLaplaceEquations::get_flux(), oomph::FourierDecomposedHelmholtzEquations::get_flux(), oomph::HelmholtzEquations< DIM >::get_flux(), oomph::PMLFourierDecomposedHelmholtzEquations::get_flux(), oomph::PMLHelmholtzEquations< DIM >::get_flux(), oomph::AxisymFoepplvonKarmanEquations::get_gradient_of_deflection(), oomph::DisplacementBasedFoepplvonKarmanEquations::get_gradient_of_deflection(), oomph::FoepplvonKarmanEquations::get_gradient_of_deflection(), oomph::DisplacementBasedFoepplvonKarmanEquations::get_gradient_of_field(), oomph::TriangleMesh< ELEMENT >::get_halo_elements_on_all_procs(), oomph::SpectralPeriodicOrbitElement< NNODE_1D >::get_interpolated_values(), oomph::RefineableAxisymmetricQTaylorHoodElement::get_interpolated_values(), oomph::RefineableAxisymmetricQCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::get_interpolated_values(), oomph::RefineableGeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::get_interpolated_values(), oomph::RefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::get_interpolated_values(), oomph::PRefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::get_interpolated_values(), oomph::RefineableLinearElasticityEquations< DIM >::get_interpolated_values(), oomph::RefineableLinearisedAxisymmetricQCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::get_interpolated_values(), oomph::RefineableLinearisedQCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableLinearisedQTaylorHoodElement::get_interpolated_values(), oomph::RefineableQTaylorHoodElement< DIM >::get_interpolated_values(), oomph::RefineableQCrouzeixRaviartElement< DIM >::get_interpolated_values(), oomph::PRefineableQCrouzeixRaviartElement< DIM >::get_interpolated_values(), oomph::RefineablePolarTaylorHoodElement::get_interpolated_values(), oomph::RefineablePolarCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableQSphericalTaylorHoodElement::get_interpolated_values(), oomph::RefineableQSphericalCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableTimeHarmonicLinearElasticityEquations< DIM >::get_interpolated_values(), oomph::RefineableAdvectionDiffusionEquations< DIM >::get_interpolated_values(), oomph::RefineableGeneralisedAdvectionDiffusionEquations< DIM >::get_interpolated_values(), oomph::RefineableAdvectionDiffusionReactionEquations< NREAGENT, DIM >::get_interpolated_values(), oomph::RefineableAxisymAdvectionDiffusionEquations::get_interpolated_values(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::get_interpolated_values(), oomph::RefineableHelmholtzEquations< DIM >::get_interpolated_values(), oomph::RefineableLinearWaveEquations< DIM >::get_interpolated_values(), oomph::RefineablePMLHelmholtzEquations< DIM >::get_interpolated_values(), oomph::RefineablePoissonEquations< DIM >::get_interpolated_values(), oomph::RefineableSpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::get_interpolated_values(), oomph::RefineableSpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::get_interpolated_values(), oomph::RefineableSphericalAdvectionDiffusionEquations::get_interpolated_values(), oomph::RefineableUnsteadyHeatEquations< DIM >::get_interpolated_values(), oomph::RefineableYoungLaplaceEquations::get_interpolated_values(), oomph::DGFaceElement::get_interpolation_data(), oomph::PolarCrouzeixRaviartElement::get_load_data(), oomph::PolarTaylorHoodElement::get_load_data(), get_node_number(), oomph::Mesh::get_node_reordering(), oomph::KirchhoffLoveBeamEquations::get_non_unit_tangent(), oomph::KirchhoffLoveShellEquations::get_normal(), oomph::KirchhoffLoveBeamEquations::get_normal(), oomph::AxisymmetricNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::SphericalNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::AxisymmetricPoroelasticityEquations::get_q_basis(), oomph::DarcyEquations< DIM >::get_q_basis(), oomph::PoroelasticityEquations< DIM >::get_q_basis(), oomph::Missing_masters_functions::get_required_master_nodal_information_helper(), oomph::Multi_domain_functions::get_required_master_nodal_information_helper(), oomph::RefineableTriangleMesh< ELEMENT >::get_required_nodal_information_load_balance_helper(), oomph::RefineableTriangleMesh< ELEMENT >::get_shared_boundary_segment_nodes_helper(), oomph::AxisymmetricLinearElasticityEquations::get_strain(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::get_strain(), oomph::KirchhoffLoveShellEquations::get_strain_and_bend(), oomph::DisplacementBasedFoepplvonKarmanEquations::get_stress_and_strain_for_output(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::get_total_flux(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::get_total_flux(), oomph::SphericalNavierStokesEquations::get_vorticity(), oomph::SpectralPeriodicOrbitElement< NNODE_1D >::get_Z2_flux(), oomph::RefineableSpaceTimeNavierStokesEquations< DIM >::get_Z2_flux(), oomph::RefineableSpaceTimeNavierStokesMixedOrderEquations< DIM >::get_Z2_flux(), oomph::RefineableSpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::get_Z2_flux(), oomph::RefineableSpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::get_Z2_flux(), oomph::PMLHelmholtzPowerElement< ELEMENT >::global_flux_contribution(), oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >::global_power_contribution(), oomph::HelmholtzBCElementBase< ELEMENT >::global_power_contribution(), oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >::global_power_contribution(), oomph::PMLHelmholtzPowerElement< ELEMENT >::global_power_contribution(), has_hanging_nodes(), oomph::TriangleMesh< ELEMENT >::identify_boundary_segments_and_assign_initial_zeta_values(), identify_field_data_for_interactions(), oomph::RefineableElement::identify_field_data_for_interactions(), oomph::SolidFiniteElement::identify_geometric_data(), oomph::RefineableSolidElement::identify_geometric_data(), oomph::FSIAxisymmetricQTaylorHoodElement::identify_load_data(), oomph::AxisymmetricTCrouzeixRaviartElement::identify_load_data(), oomph::AxisymmetricTTaylorHoodElement::identify_load_data(), oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement::identify_load_data(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::identify_load_data(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::identify_load_data(), oomph::RefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::identify_load_data(), oomph::RefineableQTaylorHoodElement< DIM >::identify_load_data(), oomph::RefineableQCrouzeixRaviartElement< DIM >::identify_load_data(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::identify_load_data(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::identify_load_data(), oomph::QSphericalCrouzeixRaviartElement::identify_load_data(), oomph::QSphericalTaylorHoodElement::identify_load_data(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::ImposeDisplacementByLagrangeMultiplierElement(), oomph::ImposeImpenetrabilityElement< ELEMENT >::ImposeImpenetrabilityElement(), oomph::ImposeParallelOutflowElement< ELEMENT >::ImposeParallelOutflowElement(), oomph::RefineablePolarTaylorHoodElement::insert_load_data(), oomph::RefineablePolarCrouzeixRaviartElement::insert_load_data(), oomph::SurfactantTransportInterfaceElement::integrate_c(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::integrate_u(), oomph::SurfactantTransportInterfaceElement::interpolated_C(), oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >::interpolated_c_adv_diff_react(), oomph::AxisymmetricLinearElasticityEquationsBase::interpolated_d2u_dt2_axisymmetric_linear_elasticity(), oomph::LinearWaveEquations< DIM >::interpolated_d2u_dt2_lin_wave(), oomph::AxisymmetricNavierStokesEquations::interpolated_d_dudx_dX_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_d_dudx_dX_axi_nst(), oomph::AxisymmetricPoroelasticityEquations::interpolated_div_du_dt(), oomph::AxisymmetricPoroelasticityEquations::interpolated_div_q(), oomph::DarcyEquations< DIM >::interpolated_div_q(), oomph::PoroelasticityEquations< DIM >::interpolated_div_q(), oomph::AxisymmetricPoroelasticityEquations::interpolated_div_u(), oomph::AxisymmetricPoroelasticityEquations::interpolated_du_dt(), oomph::AxisymmetricLinearElasticityEquationsBase::interpolated_du_dt_axisymmetric_linear_elasticity(), oomph::LinearWaveEquations< DIM >::interpolated_du_dt_lin_wave(), oomph::SpaceTimeNavierStokesEquations< DIM >::interpolated_du_dt_nst(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::interpolated_du_dt_nst(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::interpolated_du_dt_ust_heat(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::interpolated_du_dt_ust_heat(), oomph::UnsteadyHeatEquations< DIM >::interpolated_du_dt_ust_heat(), oomph::AxisymmetricNavierStokesEquations::interpolated_duds_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_duds_axi_nst(), oomph::AxisymmetricNavierStokesEquations::interpolated_dudt_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_dudt_axi_nst(), oomph::BiharmonicEquations< DIM >::interpolated_dudx(), oomph::AxisymmetricNavierStokesEquations::interpolated_dudx_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_dudx_axi_nst(), oomph::NavierStokesEquations< DIM >::interpolated_dudx_nst(), oomph::PolarNavierStokesEquations::interpolated_dudx_pnst(), oomph::SphericalNavierStokesEquations::interpolated_dudx_spherical_nst(), interpolated_dxdt(), oomph::SolidFiniteElement::interpolated_dxids(), oomph::AxisymFoepplvonKarmanEquations::interpolated_stress(), oomph::FoepplvonKarmanEquations::interpolated_stress(), oomph::YoungLaplaceEquations::interpolated_u(), oomph::FluidInterfaceElement::interpolated_u(), oomph::AxisymmetricPoroelasticityEquations::interpolated_u(), oomph::PoroelasticityEquations< DIM >::interpolated_u(), oomph::DGFaceElement::interpolated_u(), oomph::AdvectionDiffusionEquations< DIM >::interpolated_u_adv_diff(), oomph::SteadyAxisymAdvectionDiffusionEquations::interpolated_u_adv_diff(), oomph::AxisymAdvectionDiffusionEquations::interpolated_u_axi_adv_diff(), oomph::AxisymmetricNavierStokesEquations::interpolated_u_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_u_axi_nst(), oomph::AxisymmetricLinearElasticityEquationsBase::interpolated_u_axisymmetric_linear_elasticity(), oomph::BiharmonicEquations< DIM >::interpolated_u_biharmonic(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::interpolated_u_cons_adv_diff(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::interpolated_u_cons_axisym_adv_diff(), oomph::FourierDecomposedHelmholtzEquations::interpolated_u_fourier_decomposed_helmholtz(), oomph::AxisymFoepplvonKarmanEquations::interpolated_u_fvk(), oomph::HelmholtzEquations< DIM >::interpolated_u_helmholtz(), oomph::LinearWaveEquations< DIM >::interpolated_u_lin_wave(), oomph::LinearElasticityEquationsBase< DIM >::interpolated_u_linear_elasticity(), oomph::LinearisedAxisymmetricNavierStokesEquations::interpolated_u_linearised_axi_nst(), oomph::LinearisedNavierStokesEquations::interpolated_u_linearised_nst(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::interpolated_u_nst(), oomph::NavierStokesEquations< DIM >::interpolated_u_nst(), oomph::SpaceTimeNavierStokesEquations< DIM >::interpolated_u_nst(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::interpolated_u_nst(), oomph::PMLFourierDecomposedHelmholtzEquations::interpolated_u_pml_fourier_decomposed_helmholtz(), oomph::PMLHelmholtzEquations< DIM >::interpolated_u_pml_helmholtz(), oomph::PolarNavierStokesEquations::interpolated_u_pnst(), oomph::PoissonEquations< DIM >::interpolated_u_poisson(), oomph::SphericalAdvectionDiffusionEquations::interpolated_u_spherical_adv_diff(), oomph::SphericalNavierStokesEquations::interpolated_u_spherical_nst(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquationsBase::interpolated_u_time_harmonic_fourier_decomposed_linear_elasticity(), oomph::PMLTimeHarmonicLinearElasticityEquationsBase< DIM >::interpolated_u_time_harmonic_linear_elasticity(), oomph::TimeHarmonicLinearElasticityEquationsBase< DIM >::interpolated_u_time_harmonic_linear_elasticity(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::interpolated_u_ust_heat(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::interpolated_u_ust_heat(), oomph::UnsteadyHeatEquations< DIM >::interpolated_u_ust_heat(), oomph::WomersleyEquations< DIM >::interpolated_u_womersley(), oomph::AxisymFoepplvonKarmanEquations::interpolated_w_fvk(), oomph::DisplacementBasedFoepplvonKarmanEquations::interpolated_w_fvk(), oomph::FoepplvonKarmanEquations::interpolated_w_fvk(), interpolated_x(), oomph::SolidFiniteElement::interpolated_xi(), interpolated_zeta(), J_eulerian(), oomph::FaceElement::J_eulerian(), J_eulerian_at_knot(), oomph::FaceElement::J_eulerian_at_knot(), oomph::ProjectableAdvectionDiffusionReactionElement< ADR_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableAxisymLinearElasticityElement< AXISYM_LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableDisplacementBasedFoepplvonKarmanElement< FVK_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableFoepplvonKarmanElement< FVK_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::jacobian_and_shape_of_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::jacobian_and_shape_of_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectablePoissonElement< POISSON_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::jacobian_and_shape_of_field(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::jacobian_and_shape_of_field(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::lagrangian_eulerian_translation_factor(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::LinearisedAxisymPoroelasticBJS_FSIElement(), oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >::LinearisedFSIAxisymmetricNStNoSlipBCElementElement(), oomph::RefineableTriangleMesh< ELEMENT >::load_balance(), oomph::KirchhoffLoveShellEquations::load_rate_of_work(), local_to_eulerian_mapping_diagonal(), oomph::RefineableElement::local_to_eulerian_mapping_diagonal(), oomph::SolidFiniteElement::local_to_lagrangian_mapping_diagonal(), oomph::RefineableSolidElement::local_to_lagrangian_mapping_diagonal(), locate_zeta(), oomph::Multi_domain_functions::locate_zeta_for_missing_coordinates(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::ngeom_data(), oomph::SolidFiniteElement::ngeom_data(), oomph::RefineableSolidElement::ngeom_data(), oomph::RefineableAxisymmetricQTaylorHoodElement::ninterpolating_node(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::ninterpolating_node(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::ninterpolating_node(), oomph::RefineableLinearisedQTaylorHoodElement::ninterpolating_node(), oomph::RefineableQSphericalTaylorHoodElement::ninterpolating_node(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::ninterpolating_node(), oomph::RefineableElement::ninterpolating_node(), oomph::RefineableQTaylorHoodElement< DIM >::ninterpolating_node(), oomph::RefineablePolarTaylorHoodElement::ninterpolating_node(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::ninterpolating_node(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::ninterpolating_node(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::ninterpolating_node(), node_update(), oomph::Mesh::node_update(), oomph::PRefineableElement::nodes_built(), oomph::DGFaceElement::numerical_flux_at_knot(), oomph::ProjectableAdvectionDiffusionReactionElement< ADR_ELEMENT >::nvalue_of_field(), oomph::ProjectableAxisymLinearElasticityElement< AXISYM_LINEAR_ELAST_ELEMENT >::nvalue_of_field(), oomph::ProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nvalue_of_field(), oomph::ProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nvalue_of_field(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::nvalue_of_field(), oomph::ProjectableDisplacementBasedFoepplvonKarmanElement< FVK_ELEMENT >::nvalue_of_field(), oomph::ProjectableFoepplvonKarmanElement< FVK_ELEMENT >::nvalue_of_field(), oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::nvalue_of_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nvalue_of_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nvalue_of_field(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nvalue_of_field(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nvalue_of_field(), oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::nvalue_of_field(), oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >::nvalue_of_field(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::nvalue_of_field(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nvalue_of_field(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nvalue_of_field(), oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::nvalue_of_field(), oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >::nvalue_of_field(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::nvalue_of_field(), oomph::ProjectablePoissonElement< POISSON_ELEMENT >::nvalue_of_field(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::nvalue_of_field(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::nvalue_of_field(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::nvalue_of_field(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::nvalue_of_field(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::nvalue_of_field(), oomph::LinearElasticitySmoothMesh< LINEAR_ELASTICITY_ELEMENT >::operator()(), oomph::PoissonSmoothMesh< POISSON_ELEMENT >::operator()(), oomph::PeriodicOrbitEquations::orbit_output(), oomph::FaceElement::outer_unit_normal(), oomph::DummyFaceElement< ELEMENT >::output(), oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >::output(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::output(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::output(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::output(), oomph::HermiteBeamElement::output(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::output(), oomph::TriangleMesh< ELEMENT >::output_boundary_coordinates(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::output_integration_points(), output_paraview(), oomph::AxisymmetricNavierStokesEquations::output_veloc(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedNavierStokesEquations::output_veloc(), oomph::PolarNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_veloc(), oomph::TreeBasedRefineableMeshBase::p_adapt_mesh(), oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >::p_refine(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::p_refine(), oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >::p_refine(), oomph::Tree::p_refine_if_required(), oomph::ProjectionProblem< PROJECTABLE_ELEMENT >::pin_all(), oomph::AxisymmetricTTaylorHoodElement::pin_all_nodal_pressure_dofs(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::pin_all_nodal_pressure_dofs(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::pin_all_non_pressure_dofs(), oomph::NavierStokesEquations< DIM >::pin_all_non_pressure_dofs(), oomph::SpaceTimeNavierStokesEquations< DIM >::pin_all_non_pressure_dofs(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::pin_all_non_pressure_dofs(), oomph::RefineableAxisymmetricQTaylorHoodElement::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableLinearisedQTaylorHoodElement::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableQTaylorHoodElement< DIM >::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineablePolarTaylorHoodElement::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableQSphericalTaylorHoodElement::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::pin_elemental_redundant_nodal_solid_pressures(), oomph::LinearisedQCrouzeixRaviartElement::pin_real_or_imag(), oomph::MGSolver< DIM >::plot(), oomph::PMLQuadMeshBase< ELEMENT >::pml_locate_zeta(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::position(), oomph::SolidFiniteElement::position_local_eqn(), oomph::StorableShapeElementBase::pre_compute_d2shape_eulerian_at_knots(), oomph::StorableShapeSolidElementBase::pre_compute_d2shape_lagrangian_at_knots(), oomph::StorableShapeElementBase::pre_compute_d2shape_local_at_knots(), oomph::StorableShapeElementBase::pre_compute_dshape_eulerian_at_knots(), oomph::StorableShapeSolidElementBase::pre_compute_dshape_lagrangian_at_knots(), oomph::StorableShapeElementBase::pre_compute_dshape_local_at_knots(), oomph::StorableShapeElementBase::pre_compute_shape_at_knots(), oomph::ProjectionProblem< PROJECTABLE_ELEMENT >::project(), oomph::Mesh::prune_halo_elements_and_nodes(), oomph::TriangleMesh< ELEMENT >::re_assign_initial_zeta_values_for_internal_boundary(), oomph::TriangleMesh< ELEMENT >::re_scale_re_assigned_initial_zeta_values_for_internal_boundary(), oomph::MacroElementNodeUpdateElement< ELEMENT >::rebuild_from_sons(), oomph::TreeBasedRefineableMeshBase::refine_as_in_reference_mesh(), oomph::RefineableImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::RefineableFSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::RefineableNavierStokesFluxControlElement< ELEMENT >::refineable_fill_in_generic_residual_contribution_fluid_traction(), oomph::Problem::remove_duplicate_data(), oomph::DGFaceElement::report_info(), oomph::RefineableTriangleMesh< ELEMENT >::reset_halo_haloed_scheme(), oomph::RefineableTriangleMesh< ELEMENT >::reset_halo_haloed_scheme_helper(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::residual_for_projection(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::residual_for_projection(), oomph::ProjectableElement< ELEMENT >::residual_for_projection(), oomph::FaceElement::resize_nodes(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::scalar_value_paraview(), oomph::TriangleMesh< ELEMENT >::select_boundary_face_elements(), self_test(), oomph::Problem::send_data_to_be_sent_during_load_balancing(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::set_boundary_shape_geom_object_pt(), oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::set_external_data_from_navier_stokes_outflow_mesh(), oomph::MacroElementNodeUpdateElement< ELEMENT >::set_node_update_info(), oomph::MGSolver< DIM >::set_self_test_vector(), oomph::PeriodicOrbitEquations::set_timestepper_weights(), oomph::VolumeConstraintBoundingElement::set_volume_constraint_element(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::setup_algebraic_node_update(), oomph::AlgebraicRefineableQuarterCircleSectorMesh< ELEMENT >::setup_algebraic_node_update(), oomph::AlgebraicRefineableQuarterTubeMesh< ELEMENT >::setup_algebraic_node_update(), oomph::AlgebraicElementBase::setup_algebraic_node_update(), oomph::UnstructuredTwoDMeshGeometryBase::setup_boundary_coordinates(), oomph::FluidInterfaceAdditionalValues< SurfactantTransportInterfaceElement >::setup_equation_indices(), oomph::FourierDecomposedHelmholtzDtNMesh< ELEMENT >::setup_gamma(), oomph::HelmholtzDtNMesh< ELEMENT >::setup_gamma(), oomph::MGSolver< DIM >::setup_interpolation_matrices_unstructured(), oomph::HelmholtzMGPreconditioner< DIM >::setup_interpolation_matrices_unstructured(), oomph::Z2ErrorEstimator::setup_patches(), oomph::Mesh::setup_shared_node_scheme(), oomph::AdvectionDiffusionFluxElement< ELEMENT >::shape_and_test(), oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >::shape_and_test(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::shape_and_test(), oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >::shape_and_test(), oomph::FourierDecomposedHelmholtzFluxElement< ELEMENT >::shape_and_test(), oomph::HelmholtzFluxElement< ELEMENT >::shape_and_test(), oomph::LinearWaveFluxElement< ELEMENT >::shape_and_test(), oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::shape_and_test(), oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::shape_and_test(), oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::shape_and_test(), oomph::PMLFourierDecomposedHelmholtzFluxElement< ELEMENT >::shape_and_test(), oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >::shape_and_test(), oomph::PMLHelmholtzFluxElement< ELEMENT >::shape_and_test(), oomph::PoissonFluxElement< ELEMENT >::shape_and_test(), oomph::SphericalAdvectionDiffusionFluxElement< ELEMENT >::shape_and_test(), oomph::SteadyAxisymAdvectionDiffusionFluxElement< ELEMENT >::shape_and_test(), oomph::UnsteadyHeatFluxElement< ELEMENT >::shape_and_test(), oomph::AdvectionDiffusionFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >::shape_and_test_at_knot(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::shape_and_test_at_knot(), oomph::FourierDecomposedHelmholtzFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::HelmholtzFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::shape_and_test_at_knot(), oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::shape_and_test_at_knot(), oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::shape_and_test_at_knot(), oomph::NavierStokesTractionElement< ELEMENT >::shape_and_test_at_knot(), oomph::NavierStokesFluxControlElement< ELEMENT >::shape_and_test_at_knot(), oomph::PMLFourierDecomposedHelmholtzFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::PMLHelmholtzFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::PoissonFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::PolarNavierStokesTractionElement< ELEMENT >::shape_and_test_at_knot(), oomph::PolarStressIntegralElement< ELEMENT >::shape_and_test_at_knot(), oomph::SphericalAdvectionDiffusionFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::SteadyAxisymAdvectionDiffusionFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::shape_and_test_at_knot(), oomph::SurfactantTransportInterfaceElement::sigma(), oomph::RefineableTriangleMesh< ELEMENT >::snap_nodes_onto_boundary(), oomph::TetMeshBase::snap_nodes_onto_geometric_objects(), oomph::TetMeshBase::snap_to_quadratic_surface(), oomph::SolidQHermiteElement< DIM >::SolidQHermiteElement(), oomph::SpineElement< ELEMENT >::spine_local_eqn(), oomph::SpineUpdateFluidInterfaceElement< EQUATION_CLASS, DERIVATIVE_CLASS, ELEMENT >::SpineUpdateFluidInterfaceElement(), oomph::TetMeshBase::split_elements_in_corners(), oomph::Tree::split_if_required(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::square_of_l2_norm_of_error(), oomph::AxisymmetricNavierStokesEquations::strain_rate(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::strain_rate(), oomph::LinearisedAxisymmetricNavierStokesEquations::strain_rate(), oomph::PolarNavierStokesEquations::strain_rate(), oomph::SphericalNavierStokesEquations::strain_rate(), oomph::LinearisedNavierStokesEquations::strain_rate(), oomph::PolarNavierStokesEquations::strain_rate_by_r(), oomph::TreeBasedRefineableMeshBase::synchronise_nonhanging_nodes(), oomph::TriangleMesh< ELEMENT >::synchronize_boundary_coordinates(), oomph::AxisymmetricPoroelasticityEquations::transform_basis(), oomph::PoroelasticityEquations< DIM >::transform_basis(), oomph::RefineableElement::unbuild(), oomph::AxisymmetricTTaylorHoodElement::unpin_all_nodal_pressure_dofs(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::unpin_all_nodal_pressure_dofs(), oomph::RefineableAxisymmetricQTaylorHoodElement::unpin_elemental_pressure_dofs(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::unpin_elemental_pressure_dofs(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::unpin_elemental_pressure_dofs(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::unpin_elemental_pressure_dofs(), oomph::RefineableLinearisedQTaylorHoodElement::unpin_elemental_pressure_dofs(), oomph::RefineableQTaylorHoodElement< DIM >::unpin_elemental_pressure_dofs(), oomph::RefineablePolarTaylorHoodElement::unpin_elemental_pressure_dofs(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::unpin_elemental_pressure_dofs(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::unpin_elemental_pressure_dofs(), oomph::RefineableQSphericalTaylorHoodElement::unpin_elemental_pressure_dofs(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::unpin_elemental_solid_pressure_dofs(), oomph::QPVDElementWithContinuousPressure< DIM >::unpin_elemental_solid_pressure_dofs(), oomph::TPVDElementWithContinuousPressure< DIM >::unpin_elemental_solid_pressure_dofs(), oomph::LinearisedQCrouzeixRaviartElement::unpin_real_or_imag(), oomph::RefineableTriangleMesh< ELEMENT >::update_open_curve_after_restart(), oomph::RefineableTriangleMesh< ELEMENT >::update_open_curve_using_elements_area(), oomph::RefineableTriangleMesh< ELEMENT >::update_open_curve_using_face_mesh(), oomph::RefineableTriangleMesh< ELEMENT >::update_polygon_after_restart(), oomph::RefineableTriangleMesh< ELEMENT >::update_polygon_using_elements_area(), oomph::RefineableTriangleMesh< ELEMENT >::update_polygon_using_face_mesh(), oomph::RefineableTriangleMesh< ELEMENT >::update_shared_curve_using_elements_area(), oomph::AxisymFoepplvonKarmanEquations::use_linear_bending_model(), oomph::DisplacementBasedFoepplvonKarmanEquations::use_linear_bending_model(), oomph::FoepplvonKarmanEquations::use_linear_bending_model(), and oomph::WomersleyMesh< WOMERSLEY_ELEMENT >::WomersleyMesh().

◆ nnode_1d()

virtual unsigned oomph::FiniteElement::nnode_1d ( ) const
inlinevirtual

Return the number of nodes along one edge of the element Default is to return zero — must be overloaded by geometric elements.

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >, oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >, oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >, oomph::QHermiteElement< DIM >, and oomph::QHermiteElement< DIM - 1 >.

Definition at line 2218 of file elements.h.

Referenced by oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::BrethertonSpineMesh(), oomph::GmshTetMesh< ELEMENT >::build_from_scaffold(), oomph::BackwardStepQuadMesh< ELEMENT >::build_mesh(), oomph::ExtrudedCubeMeshFromQuadMesh< ELEMENT >::build_mesh(), oomph::ChannelWithLeafletMesh< ELEMENT >::ChannelWithLeafletMesh(), oomph::CollapsibleChannelMesh< ELEMENT >::CollapsibleChannelMesh(), oomph::Missing_masters_functions::construct_new_external_halo_master_node_helper(), oomph::EighthSphereMesh< ELEMENT >::EighthSphereMesh(), oomph::FSIDrivenCavityMesh< ELEMENT >::FSIDrivenCavityMesh(), oomph::BlockPrecQTaylorHoodSpaceTimeElement::get_dof_numbers_for_unknowns(), oomph::BlockPrecQTaylorHoodMixedOrderSpaceTimeElement::get_dof_numbers_for_unknowns(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::get_interpolating_node_at_local_coordinate(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::get_interpolating_node_at_local_coordinate(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::nfree_surface_spines(), oomph::RefineableAxisymmetricQTaylorHoodElement::ninterpolating_node_1d(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::ninterpolating_node_1d(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::ninterpolating_node_1d(), oomph::RefineableLinearisedQTaylorHoodElement::ninterpolating_node_1d(), oomph::RefineableQSphericalTaylorHoodElement::ninterpolating_node_1d(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::ninterpolating_node_1d(), oomph::RefineableElement::ninterpolating_node_1d(), oomph::RefineableQTaylorHoodElement< DIM >::ninterpolating_node_1d(), oomph::RefineablePolarTaylorHoodElement::ninterpolating_node_1d(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::ninterpolating_node_1d(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::ninterpolating_node_1d(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::ninterpolating_node_1d(), oomph::QElementBase::nnode_on_face(), oomph::MGSolver< DIM >::plot(), oomph::PMLQuadMeshBase< ELEMENT >::pml_locate_zeta(), oomph::PMLCornerQuadMesh< ELEMENT >::PMLCornerQuadMesh(), oomph::PMLQuadMesh< ELEMENT >::PMLQuadMesh(), oomph::AlgebraicRefineableQuarterTubeMesh< ELEMENT >::setup_algebraic_node_update(), oomph::BrickMeshBase::setup_boundary_element_info(), oomph::LineMeshBase::setup_boundary_element_info(), oomph::QuadMeshBase::setup_boundary_element_info(), oomph::HermiteQuadMesh< ELEMENT >::setup_boundary_element_info(), oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >::shape_and_test_at_knot(), oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >::shape_and_test_at_knot(), oomph::SimpleRectangularTriMesh< ELEMENT >::SimpleRectangularTriMesh(), oomph::TetMeshBase::snap_nodes_onto_geometric_objects(), and oomph::TetMeshBase::split_elements_in_corners().

◆ nnode_on_face()

virtual unsigned oomph::FiniteElement::nnode_on_face ( ) const
inlinevirtual

◆ nodal_dimension()

unsigned oomph::FiniteElement::nodal_dimension ( ) const
inline

Return the required Eulerian dimension of the nodes in this element.

Definition at line 2484 of file elements.h.

References Nodal_dimension.

Referenced by assemble_eulerian_base_vectors(), oomph::RefineableElement::assemble_eulerian_base_vectors(), oomph::RefineableElement::assemble_local_to_eulerian_jacobian(), oomph::RefineableSolidElement::assign_solid_hanging_local_eqn_numbers(), oomph::SolidFiniteElement::assign_solid_local_eqn_numbers(), oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >::AxisymmetricLinearElasticityTractionElement(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::AxisymmetricNavierStokesTractionElement(), build_face_element(), oomph::Mesh::check_inverted_elements(), oomph::FaceElement::check_J_eulerian_at_knots(), oomph::AxisymmetricNavierStokesEquations::compute_physical_size(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::compute_physical_size(), oomph::ElementWithSpecificMovingNodes< ELEMENT, NODE_TYPE >::construct_boundary_node(), oomph::SolidFiniteElement::construct_boundary_node(), oomph::ElementWithSpecificMovingNodes< ELEMENT, NODE_TYPE >::construct_node(), oomph::SolidFiniteElement::construct_node(), oomph::FaceElement::continuous_tangent_and_outer_unit_normal(), oomph::FSI_functions::doc_fsi(), oomph::FaceElementAsGeomObject< ELEMENT >::FaceElementAsGeomObject(), oomph::ClampedSlidingHermiteBeamBoundaryConditionElement::fill_in_contribution_to_residuals(), oomph::SolidFiniteElement::fill_in_generic_jacobian_for_solid_ic(), oomph::FluidInterfaceElement::fill_in_generic_residual_contribution_interface(), oomph::PointFluidInterfaceBoundingElement::fill_in_generic_residual_contribution_interface_boundary(), oomph::LineFluidInterfaceBoundingElement::fill_in_generic_residual_contribution_interface_boundary(), oomph::SolidFiniteElement::fill_in_jacobian_for_newmark_accel(), oomph::SolidFiniteElement::fill_in_jacobian_from_solid_position_by_fd(), oomph::RefineableSolidElement::fill_in_jacobian_from_solid_position_by_fd(), oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement(), oomph::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement(), oomph::FSIAxisymmetricLinearElasticityTractionElement< ELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::FSIAxisymmetricLinearElasticityTractionElement(), oomph::FSIHermiteBeamElement::get_dof_numbers_for_unknowns(), oomph::FSIDiagHermiteShellElement::get_dof_numbers_for_unknowns(), oomph::ClampedHermiteShellBoundaryConditionElement::get_dof_numbers_for_unknowns(), oomph::PVDEquationsBase< DIM >::get_dof_numbers_for_unknowns(), oomph::PVDEquationsWithPressure< DIM >::get_dof_numbers_for_unknowns(), oomph::FSILinearisedAxisymPoroelasticTractionElement< POROELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::get_pressure(), oomph::FSILinearisedAxisymPoroelasticTractionElement< POROELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::get_traction(), oomph::SurfactantTransportInterfaceElement::integrate_c(), integrate_fct(), interpolated_dxdt(), interpolated_x(), J_eulerian(), oomph::FaceElement::J_eulerian(), J_eulerian_at_knot(), oomph::FaceElement::J_eulerian_at_knot(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::lagrangian_eulerian_translation_factor(), oomph::LinearElasticityTractionElement< ELEMENT >::LinearElasticityTractionElement(), oomph::RefineableElement::local_to_eulerian_mapping_diagonal(), oomph::Mesh::nodal_dimension(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::nscalar_paraview(), oomph::DGFaceElement::numerical_flux_at_knot(), oomph::FaceElement::outer_unit_normal(), oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >::output(), oomph::FSIAxisymmetricLinearElasticityTractionElement< ELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::output(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::output(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::output(), oomph::FSILinearisedAxisymPoroelasticTractionElement< POROELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::output(), oomph::FluidInterfaceElement::output(), oomph::SurfactantTransportInterfaceElement::output(), oomph::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::output(), oomph::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::output(), oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::output(), oomph::SolidTractionElement< ELEMENT >::output(), oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >::PMLTimeHarmonicLinearElasticityTractionElement(), oomph::SolidFiniteElement::position_local_eqn(), oomph::StorableShapeElementBase::pre_compute_d2shape_eulerian_at_knots(), oomph::StorableShapeElementBase::pre_compute_dshape_eulerian_at_knots(), oomph::DGFaceElement::report_info(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::scalar_name_paraview(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::scalar_value_paraview(), oomph::FaceElement::set_tangent_direction(), oomph::TimeHarmonicFourierDecomposedLinearElasticityTractionElement< ELEMENT >::TimeHarmonicFourierDecomposedLinearElasticityTractionElement(), oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >::TimeHarmonicLinearElasticityTractionElement(), oomph::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement(), and oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement().

◆ nodal_local_eqn()

int oomph::FiniteElement::nodal_local_eqn ( const unsigned &  n,
const unsigned &  i 
) const
inline

Return the local equation number corresponding to the i-th value at the n-th local node.

Definition at line 1432 of file elements.h.

References i, Nnode, Nodal_local_eqn, node_pt(), and oomph::Data::nvalue().

Referenced by oomph::SurfactantTransportInterfaceElement::add_additional_residual_contributions_interface(), oomph::DGFaceElement::add_flux_contributions(), oomph::RefineableElement::assign_hanging_local_eqn_numbers(), oomph::AxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::AxisymFoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::ClampedSlidingHermiteBeamBoundaryConditionElement::fill_in_contribution_to_residuals(), oomph::DisplacementBasedFoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::FoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::ClampedHermiteShellBoundaryConditionElement::fill_in_contribution_to_residuals(), oomph::AxisymmetricLinearElasticityEquations::fill_in_generic_contribution_to_residuals_axisymmetric_linear_elasticity(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::fill_in_generic_contribution_to_residuals_fourier_decomp_time_harmonic_linear_elasticity(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::ImposeImpenetrabilityElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::ImposeParallelOutflowElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::AxisymmetricPoroelasticityEquations::fill_in_generic_residual_contribution(), oomph::PolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::RefineablePolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::SteadyAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_adv_diff(), oomph::AxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::RefineableAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::BiharmonicFluidBoundaryElement::fill_in_generic_residual_contribution_biharmonic_boundary(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::FourierDecomposedHelmholtzEquations::fill_in_generic_residual_contribution_fourier_decomposed_helmholtz(), oomph::FourierDecomposedHelmholtzDtNBoundaryElement< ELEMENT >::fill_in_generic_residual_contribution_fourier_decomposed_helmholtz_DtN_bc(), oomph::HelmholtzAbsorbingBCElement< ELEMENT >::fill_in_generic_residual_contribution_helmholtz_abc(), oomph::HelmholtzDtNBoundaryElement< ELEMENT >::fill_in_generic_residual_contribution_helmholtz_DtN_bc(), oomph::FluidInterfaceElement::fill_in_generic_residual_contribution_interface(), oomph::PointFluidInterfaceBoundingElement::fill_in_generic_residual_contribution_interface_boundary(), oomph::LineFluidInterfaceBoundingElement::fill_in_generic_residual_contribution_interface_boundary(), oomph::LinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::RefineableLinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::LinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::RefineableLinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::PeriodicOrbitEquations::fill_in_generic_residual_contribution_orbit(), oomph::PMLFourierDecomposedHelmholtzEquations::fill_in_generic_residual_contribution_pml_fourier_decomposed_helmholtz(), oomph::RefineableSphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::SphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::RefineableSphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::SphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), fill_in_jacobian_from_nodal_by_fd(), oomph::RefineableElement::fill_in_jacobian_from_nodal_by_fd(), oomph::RefineableNavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::NavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_by_fd(), oomph::AxisymmetricLinearElasticityEquationsBase::get_dof_numbers_for_unknowns(), oomph::AxisymmetricQCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::AxisymmetricQTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::AxisymmetricTCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::AxisymmetricTTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::BiharmonicEquations< DIM >::get_dof_numbers_for_unknowns(), oomph::TDisplacementBasedFoepplvonKarmanElement< NNODE_1D >::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >::get_dof_numbers_for_unknowns(), oomph::LinearElasticityEquationsBase< DIM >::get_dof_numbers_for_unknowns(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::get_dof_numbers_for_unknowns(), oomph::ImposeImpenetrabilityElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::ImposeParallelOutflowElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::TTaylorHoodElement< DIM >::get_dof_numbers_for_unknowns(), oomph::PMLHelmholtzEquations< DIM >::get_dof_numbers_for_unknowns(), oomph::PMLHelmholtzFluxElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::PMLTimeHarmonicLinearElasticityEquationsBase< DIM >::get_dof_numbers_for_unknowns(), oomph::ClampedHermiteShellBoundaryConditionElement::get_dof_numbers_for_unknowns(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::BlockPrecQTaylorHoodSpaceTimeElement::get_dof_numbers_for_unknowns(), oomph::BlockPrecQTaylorHoodMixedOrderSpaceTimeElement::get_dof_numbers_for_unknowns(), oomph::QSphericalCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::QSphericalTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquationsBase::get_dof_numbers_for_unknowns(), oomph::TimeHarmonicLinearElasticityEquationsBase< DIM >::get_dof_numbers_for_unknowns(), oomph::AxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::AxisymmetricNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::SphericalNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::ElasticPointFluidInterfaceBoundingElement< ELEMENT >::kinematic_local_eqn(), oomph::ElasticLineFluidInterfaceBoundingElement< ELEMENT >::kinematic_local_eqn(), oomph::ProjectableAdvectionDiffusionReactionElement< ADR_ELEMENT >::local_equation(), oomph::ProjectableAxisymLinearElasticityElement< AXISYM_LINEAR_ELAST_ELEMENT >::local_equation(), oomph::ProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::local_equation(), oomph::ProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::local_equation(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::local_equation(), oomph::ProjectableDisplacementBasedFoepplvonKarmanElement< FVK_ELEMENT >::local_equation(), oomph::ProjectableFoepplvonKarmanElement< FVK_ELEMENT >::local_equation(), oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::local_equation(), oomph::GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::local_equation(), oomph::GeneralisedNewtonianProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::local_equation(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::local_equation(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::local_equation(), oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::local_equation(), oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >::local_equation(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::local_equation(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::local_equation(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::local_equation(), oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::local_equation(), oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >::local_equation(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::local_equation(), oomph::ProjectablePoissonElement< POISSON_ELEMENT >::local_equation(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::local_equation(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::local_equation(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::local_equation(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::local_equation(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::local_equation(), oomph::PolarTaylorHoodElement::p_local_eqn(), oomph::AxisymmetricQTaylorHoodElement::p_local_eqn(), oomph::AxisymmetricTTaylorHoodElement::p_local_eqn(), oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement::p_local_eqn(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::p_local_eqn(), oomph::GeneralisedNewtonianQTaylorHoodElement< DIM >::p_local_eqn(), oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >::p_local_eqn(), oomph::QTaylorHoodElement< DIM >::p_local_eqn(), oomph::TTaylorHoodElement< DIM >::p_local_eqn(), oomph::QTaylorHoodSpaceTimeElement< DIM >::p_local_eqn(), oomph::QTaylorHoodMixedOrderSpaceTimeElement< DIM >::p_local_eqn(), oomph::QSphericalTaylorHoodElement::p_local_eqn(), oomph::LinearisedAxisymmetricQTaylorHoodElement::p_local_eqn(), oomph::LinearisedQTaylorHoodElement::p_local_eqn(), oomph::VolumeConstraintBoundingElement::ptraded_local_eqn(), oomph::TAxisymmetricPoroelasticityElement< ORDER >::q_edge_local_eqn(), oomph::TRaviartThomasDarcyElement< ORDER >::q_edge_local_eqn(), oomph::TPoroelasticityElement< ORDER >::q_edge_local_eqn(), oomph::RefineableImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::RefineableFSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::RefineableNavierStokesFluxControlElement< ELEMENT >::refineable_fill_in_generic_residual_contribution_fluid_traction(), oomph::PeriodicOrbitEquations::set_timestepper_weights(), oomph::FourierDecomposedHelmholtzDtNMesh< ELEMENT >::setup_gamma(), oomph::HelmholtzDtNMesh< ELEMENT >::setup_gamma(), oomph::QPVDElementWithContinuousPressure< DIM >::solid_p_local_eqn(), oomph::TPVDElementWithContinuousPressure< DIM >::solid_p_local_eqn(), oomph::YoungLaplaceContactAngleElement< ELEMENT >::u_local_eqn(), oomph::YoungLaplaceEquations::u_local_eqn(), oomph::NavierStokesTractionElement< ELEMENT >::u_local_eqn(), oomph::NavierStokesFluxControlElement< ELEMENT >::u_local_eqn(), oomph::PolarNavierStokesTractionElement< ELEMENT >::u_local_eqn(), oomph::PolarStressIntegralElement< ELEMENT >::u_local_eqn(), oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >::u_local_eqn(), oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >::u_local_eqn(), and oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::u_local_eqn().

◆ nodal_position() [1/2]

double oomph::FiniteElement::nodal_position ( const unsigned &  n,
const unsigned &  i 
) const
inline

Return the i-th coordinate at local node n. If the node is hanging, the appropriate interpolation is handled by the position function in the Node class.

Definition at line 2317 of file elements.h.

References i, node_pt(), and oomph::Node::position().

Referenced by oomph::HelmholtzBCElementBase< ELEMENT >::compute_contribution_to_fourier_components(), oomph::EulerEquations< DIM >::compute_error(), oomph::ScalarAdvectionEquations< DIM >::compute_error(), oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::compute_stabilisation_parameter(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::contribution_to_enclosed_volume(), oomph::LineVolumeConstraintBoundingElement::contribution_to_enclosed_volume(), oomph::AxisymmetricVolumeConstraintBoundingElement::contribution_to_enclosed_volume(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::contribution_to_total_porous_flux(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::contribution_to_total_porous_flux(), oomph::AxisymmetricVolumeConstraintBoundingElement::contribution_to_volume_flux(), oomph::DisplacementBasedFoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::RefineableYoungLaplaceEquations::fill_in_contribution_to_residuals(), oomph::YoungLaplaceEquations::fill_in_contribution_to_residuals(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::AxisymmetricPoroelasticityEquations::fill_in_generic_residual_contribution(), oomph::PolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::RefineablePolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::RefineableAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::RefineableAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::FluidInterfaceElement::fill_in_generic_residual_contribution_interface(), oomph::LineFluidInterfaceBoundingElement::fill_in_generic_residual_contribution_interface_boundary(), oomph::RefineableLinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::RefineableLinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::RefineableSphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::RefineableSphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::LineVolumeConstraintBoundingElement::fill_in_generic_residual_contribution_volume_constraint(), oomph::AxisymmetricVolumeConstraintBoundingElement::fill_in_generic_residual_contribution_volume_constraint(), oomph::SurfaceVolumeConstraintBoundingElement::fill_in_generic_residual_contribution_volume_constraint(), oomph::RefineableAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::SphericalAdvectionDiffusionEquations::get_flux(), oomph::AxisymmetricNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::SphericalNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::get_strain(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::get_total_flux(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::get_total_flux(), oomph::SurfactantTransportInterfaceElement::integrate_c(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::integrate_u(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::lagrangian_eulerian_translation_factor(), oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >::output(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::output(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::output(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::output(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::AxisymmetricNavierStokesEquations::output_veloc(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedNavierStokesEquations::output_veloc(), oomph::PolarNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_veloc(), oomph::RefineableImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::RefineableFSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::scalar_value_paraview(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::square_of_l2_norm_of_error(), oomph::AxisymmetricNavierStokesEquations::strain_rate(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::strain_rate(), oomph::LinearisedAxisymmetricNavierStokesEquations::strain_rate(), oomph::PolarNavierStokesEquations::strain_rate(), oomph::SphericalNavierStokesEquations::strain_rate(), oomph::PolarNavierStokesEquations::strain_rate_by_r(), oomph::PolarNavierStokesTractionElement< ELEMENT >::x(), and oomph::PolarStressIntegralElement< ELEMENT >::x().

◆ nodal_position() [2/2]

double oomph::FiniteElement::nodal_position ( const unsigned &  t,
const unsigned &  n,
const unsigned &  i 
) const
inline

Return the i-th coordinate at local node n, at time level t (t=0: present; t>0: previous time level) Returns suitably interpolated version for hanging nodes.

Definition at line 2325 of file elements.h.

References i, node_pt(), oomph::Node::position(), and t.

◆ nodal_position_gen() [1/2]

double oomph::FiniteElement::nodal_position_gen ( const unsigned &  n,
const unsigned &  k,
const unsigned &  i 
) const
inline

◆ nodal_position_gen() [2/2]

double oomph::FiniteElement::nodal_position_gen ( const unsigned &  t,
const unsigned &  n,
const unsigned &  k,
const unsigned &  i 
) const
inline

Return the generalised nodal position (type k, i-th variable) at previous timesteps at local node n.

Definition at line 2358 of file elements.h.

References i, node_pt(), oomph::Node::position_gen(), and t.

◆ nodal_value() [1/2]

double oomph::FiniteElement::nodal_value ( const unsigned &  n,
const unsigned &  i 
) const
inline

Return the i-th value stored at local node n. Produces suitably interpolated values for hanging nodes.

Definition at line 2593 of file elements.h.

References i, node_pt(), and oomph::Node::value().

Referenced by oomph::SurfactantTransportInterfaceElement::add_additional_residual_contributions_interface(), oomph::HelmholtzBCElementBase< ELEMENT >::compute_contribution_to_fourier_components(), oomph::EulerEquations< DIM >::compute_error(), oomph::ScalarAdvectionEquations< DIM >::compute_error(), oomph::AxisymmetricPoroelasticityEquations::d2u_dt2(), oomph::PoroelasticityEquations< DIM >::d2u_dt2(), oomph::AxisymmetricLinearElasticityEquationsBase::d2u_dt2_axisymmetric_linear_elasticity(), oomph::LinearWaveEquations< DIM >::d2u_dt2_lin_wave(), oomph::LinearElasticityEquationsBase< DIM >::d2u_dt2_linear_elasticity(), oomph::SphericalNavierStokesEquations::d_kin_energy_dt(), oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >::dc_dt_adv_diff_react(), oomph::SurfactantTransportInterfaceElement::dcdt_surface(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::dposition_dt(), oomph::AxisymmetricPoroelasticityEquations::du_dt(), oomph::PoroelasticityEquations< DIM >::du_dt(), oomph::AdvectionDiffusionEquations< DIM >::du_dt_adv_diff(), oomph::AxisymAdvectionDiffusionEquations::du_dt_axi_adv_diff(), oomph::AxisymmetricNavierStokesEquations::du_dt_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::du_dt_axi_nst(), oomph::AxisymmetricLinearElasticityEquationsBase::du_dt_axisymmetric_linear_elasticity(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::du_dt_cons_adv_diff(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::du_dt_cons_axisym_adv_diff(), oomph::LinearWaveEquations< DIM >::du_dt_lin_wave(), oomph::LinearisedAxisymmetricNavierStokesEquations::du_dt_linearised_axi_nst(), oomph::LinearisedNavierStokesEquations::du_dt_linearised_nst(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::du_dt_nst(), oomph::NavierStokesEquations< DIM >::du_dt_nst(), oomph::SphericalAdvectionDiffusionEquations::du_dt_spherical_adv_diff(), oomph::SphericalNavierStokesEquations::du_dt_spherical_nst(), oomph::UnsteadyHeatEquations< DIM >::du_dt_ust_heat(), oomph::WomersleyEquations< DIM >::du_dt_womersley(), oomph::AxisymFoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::DisplacementBasedFoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::FoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::ImposeImpenetrabilityElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::ImposeParallelOutflowElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::PolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::RefineablePolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::RefineableAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::RefineableAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::HelmholtzAbsorbingBCElement< ELEMENT >::fill_in_generic_residual_contribution_helmholtz_abc(), oomph::RefineableLinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::RefineableLinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::RefineableSphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::RefineableSphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::SphericalNavierStokesEquations::full_output(), oomph::RefineableAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::ProjectableAdvectionDiffusionReactionElement< ADR_ELEMENT >::get_field(), oomph::ProjectableAxisymLinearElasticityElement< AXISYM_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::ProjectableDisplacementBasedFoepplvonKarmanElement< FVK_ELEMENT >::get_field(), oomph::ProjectableFoepplvonKarmanElement< FVK_ELEMENT >::get_field(), oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::get_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::get_field(), oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >::get_field(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::get_field(), oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >::get_field(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectablePoissonElement< POISSON_ELEMENT >::get_field(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::get_field(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::get_field(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::get_field(), oomph::AdvectionDiffusionEquations< DIM >::get_flux(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::get_flux(), oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >::get_flux(), oomph::AxisymAdvectionDiffusionEquations::get_flux(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::get_flux(), oomph::LinearWaveEquations< DIM >::get_flux(), oomph::PoissonEquations< DIM >::get_flux(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::get_flux(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::get_flux(), oomph::SphericalAdvectionDiffusionEquations::get_flux(), oomph::SteadyAxisymAdvectionDiffusionEquations::get_flux(), oomph::UnsteadyHeatEquations< DIM >::get_flux(), oomph::WomersleyEquations< DIM >::get_flux(), oomph::FourierDecomposedHelmholtzEquations::get_flux(), oomph::HelmholtzEquations< DIM >::get_flux(), oomph::PMLFourierDecomposedHelmholtzEquations::get_flux(), oomph::PMLHelmholtzEquations< DIM >::get_flux(), oomph::AxisymFoepplvonKarmanEquations::get_gradient_of_deflection(), oomph::DisplacementBasedFoepplvonKarmanEquations::get_gradient_of_deflection(), oomph::FoepplvonKarmanEquations::get_gradient_of_deflection(), oomph::DisplacementBasedFoepplvonKarmanEquations::get_gradient_of_field(), oomph::SpectralPeriodicOrbitElement< NNODE_1D >::get_interpolated_values(), oomph::RefineableAxisymmetricQTaylorHoodElement::get_interpolated_values(), oomph::RefineableAxisymmetricQCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::get_interpolated_values(), oomph::RefineableGeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::get_interpolated_values(), oomph::RefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::get_interpolated_values(), oomph::PRefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::get_interpolated_values(), oomph::RefineableLinearElasticityEquations< DIM >::get_interpolated_values(), oomph::RefineableLinearisedAxisymmetricQCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::get_interpolated_values(), oomph::RefineableLinearisedQCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableLinearisedQTaylorHoodElement::get_interpolated_values(), oomph::RefineableQTaylorHoodElement< DIM >::get_interpolated_values(), oomph::RefineableQCrouzeixRaviartElement< DIM >::get_interpolated_values(), oomph::PRefineableQCrouzeixRaviartElement< DIM >::get_interpolated_values(), oomph::RefineablePolarTaylorHoodElement::get_interpolated_values(), oomph::RefineablePolarCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableQSphericalTaylorHoodElement::get_interpolated_values(), oomph::RefineableQSphericalCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableTimeHarmonicLinearElasticityEquations< DIM >::get_interpolated_values(), oomph::RefineableAdvectionDiffusionEquations< DIM >::get_interpolated_values(), oomph::RefineableGeneralisedAdvectionDiffusionEquations< DIM >::get_interpolated_values(), oomph::RefineableAdvectionDiffusionReactionEquations< NREAGENT, DIM >::get_interpolated_values(), oomph::RefineableAxisymAdvectionDiffusionEquations::get_interpolated_values(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::get_interpolated_values(), oomph::RefineableHelmholtzEquations< DIM >::get_interpolated_values(), oomph::RefineableLinearWaveEquations< DIM >::get_interpolated_values(), oomph::RefineablePMLHelmholtzEquations< DIM >::get_interpolated_values(), oomph::RefineablePoissonEquations< DIM >::get_interpolated_values(), oomph::RefineableSpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::get_interpolated_values(), oomph::RefineableSpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::get_interpolated_values(), oomph::RefineableSphericalAdvectionDiffusionEquations::get_interpolated_values(), oomph::RefineableUnsteadyHeatEquations< DIM >::get_interpolated_values(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::get_strain(), oomph::DisplacementBasedFoepplvonKarmanEquations::get_stress_and_strain_for_output(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::get_total_flux(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::get_total_flux(), oomph::SphericalNavierStokesEquations::get_vorticity(), oomph::SpectralPeriodicOrbitElement< NNODE_1D >::get_Z2_flux(), oomph::RefineableSpaceTimeNavierStokesEquations< DIM >::get_Z2_flux(), oomph::RefineableSpaceTimeNavierStokesMixedOrderEquations< DIM >::get_Z2_flux(), oomph::RefineableSpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::get_Z2_flux(), oomph::RefineableSpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::get_Z2_flux(), oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >::global_power_contribution(), oomph::HelmholtzBCElementBase< ELEMENT >::global_power_contribution(), oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >::global_power_contribution(), oomph::PMLHelmholtzPowerElement< ELEMENT >::global_power_contribution(), oomph::SurfactantTransportInterfaceElement::integrate_c(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::integrate_u(), oomph::SurfactantTransportInterfaceElement::interpolated_C(), oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >::interpolated_c_adv_diff_react(), oomph::AxisymmetricNavierStokesEquations::interpolated_d_dudx_dX_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_d_dudx_dX_axi_nst(), oomph::AxisymmetricPoroelasticityEquations::interpolated_div_u(), oomph::SpaceTimeNavierStokesEquations< DIM >::interpolated_du_dt_nst(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::interpolated_du_dt_nst(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::interpolated_du_dt_ust_heat(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::interpolated_du_dt_ust_heat(), oomph::AxisymmetricNavierStokesEquations::interpolated_duds_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_duds_axi_nst(), oomph::AxisymmetricNavierStokesEquations::interpolated_dudx_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_dudx_axi_nst(), oomph::NavierStokesEquations< DIM >::interpolated_dudx_nst(), oomph::SphericalNavierStokesEquations::interpolated_dudx_spherical_nst(), oomph::AxisymFoepplvonKarmanEquations::interpolated_stress(), oomph::AxisymmetricPoroelasticityEquations::interpolated_u(), oomph::PoroelasticityEquations< DIM >::interpolated_u(), oomph::AdvectionDiffusionEquations< DIM >::interpolated_u_adv_diff(), oomph::SteadyAxisymAdvectionDiffusionEquations::interpolated_u_adv_diff(), oomph::AxisymAdvectionDiffusionEquations::interpolated_u_axi_adv_diff(), oomph::AxisymmetricNavierStokesEquations::interpolated_u_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_u_axi_nst(), oomph::AxisymmetricLinearElasticityEquationsBase::interpolated_u_axisymmetric_linear_elasticity(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::interpolated_u_cons_adv_diff(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::interpolated_u_cons_axisym_adv_diff(), oomph::FourierDecomposedHelmholtzEquations::interpolated_u_fourier_decomposed_helmholtz(), oomph::AxisymFoepplvonKarmanEquations::interpolated_u_fvk(), oomph::HelmholtzEquations< DIM >::interpolated_u_helmholtz(), oomph::LinearWaveEquations< DIM >::interpolated_u_lin_wave(), oomph::LinearElasticityEquationsBase< DIM >::interpolated_u_linear_elasticity(), oomph::LinearisedAxisymmetricNavierStokesEquations::interpolated_u_linearised_axi_nst(), oomph::LinearisedNavierStokesEquations::interpolated_u_linearised_nst(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::interpolated_u_nst(), oomph::NavierStokesEquations< DIM >::interpolated_u_nst(), oomph::SpaceTimeNavierStokesEquations< DIM >::interpolated_u_nst(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::interpolated_u_nst(), oomph::PMLFourierDecomposedHelmholtzEquations::interpolated_u_pml_fourier_decomposed_helmholtz(), oomph::PMLHelmholtzEquations< DIM >::interpolated_u_pml_helmholtz(), oomph::PoissonEquations< DIM >::interpolated_u_poisson(), oomph::SphericalAdvectionDiffusionEquations::interpolated_u_spherical_adv_diff(), oomph::SphericalNavierStokesEquations::interpolated_u_spherical_nst(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquationsBase::interpolated_u_time_harmonic_fourier_decomposed_linear_elasticity(), oomph::PMLTimeHarmonicLinearElasticityEquationsBase< DIM >::interpolated_u_time_harmonic_linear_elasticity(), oomph::TimeHarmonicLinearElasticityEquationsBase< DIM >::interpolated_u_time_harmonic_linear_elasticity(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::interpolated_u_ust_heat(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::interpolated_u_ust_heat(), oomph::UnsteadyHeatEquations< DIM >::interpolated_u_ust_heat(), oomph::WomersleyEquations< DIM >::interpolated_u_womersley(), oomph::AxisymFoepplvonKarmanEquations::interpolated_w_fvk(), oomph::DisplacementBasedFoepplvonKarmanEquations::interpolated_w_fvk(), oomph::FoepplvonKarmanEquations::interpolated_w_fvk(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::lagrangian_eulerian_translation_factor(), oomph::DGFaceElement::numerical_flux_at_knot(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::output(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::output_integration_points(), oomph::AxisymmetricNavierStokesEquations::output_veloc(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_veloc(), oomph::AxisymmetricQTaylorHoodElement::p_axi_nst(), oomph::AxisymmetricTTaylorHoodElement::p_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement::p_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::p_axi_nst(), oomph::LinearisedAxisymmetricQTaylorHoodElement::p_linearised_axi_nst(), oomph::LinearisedQTaylorHoodElement::p_linearised_nst(), oomph::GeneralisedNewtonianQTaylorHoodElement< DIM >::p_nst(), oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >::p_nst(), oomph::QTaylorHoodElement< DIM >::p_nst(), oomph::TTaylorHoodElement< DIM >::p_nst(), oomph::QTaylorHoodSpaceTimeElement< DIM >::p_nst(), oomph::QTaylorHoodMixedOrderSpaceTimeElement< DIM >::p_nst(), oomph::PolarTaylorHoodElement::p_pnst(), oomph::QSphericalTaylorHoodElement::p_spherical_nst(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::position(), oomph::TAxisymmetricPoroelasticityElement< ORDER >::q_edge(), oomph::TRaviartThomasDarcyElement< ORDER >::q_edge(), oomph::TPoroelasticityElement< ORDER >::q_edge(), oomph::SurfactantTransportInterfaceElement::sigma(), oomph::QPVDElementWithContinuousPressure< DIM >::solid_p(), oomph::TPVDElementWithContinuousPressure< DIM >::solid_p(), oomph::AxisymmetricNavierStokesEquations::strain_rate(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::strain_rate(), oomph::LinearisedAxisymmetricNavierStokesEquations::strain_rate(), oomph::PolarNavierStokesEquations::strain_rate(), oomph::SphericalNavierStokesEquations::strain_rate(), oomph::PolarNavierStokesEquations::strain_rate_by_r(), oomph::PolarNavierStokesTractionElement< ELEMENT >::u(), oomph::PolarStressIntegralElement< ELEMENT >::u(), oomph::YoungLaplaceEquations::u(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::u_nst(), oomph::NavierStokesEquations< DIM >::u_nst(), oomph::SpaceTimeNavierStokesEquations< DIM >::u_nst(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::u_nst(), oomph::PolarCrouzeixRaviartElement::u_pnst(), oomph::PolarTaylorHoodElement::u_pnst(), and oomph::SphericalNavierStokesEquations::u_spherical_nst().

◆ nodal_value() [2/2]

double oomph::FiniteElement::nodal_value ( const unsigned &  t,
const unsigned &  n,
const unsigned &  i 
) const
inline

Return the i-th value stored at local node n, at time level t (t=0: present; t>0 previous timesteps). Produces suitably interpolated values for hanging nodes.

Definition at line 2601 of file elements.h.

References i, node_pt(), t, and oomph::Node::value().

◆ node_pt() [1/2]

Node*& oomph::FiniteElement::node_pt ( const unsigned &  n)
inline

Return a pointer to the local node n.

Definition at line 2175 of file elements.h.

References Nnode, and Node_pt.

Referenced by oomph::RefineableTetgenMesh< ELEMENT >::adapt(), oomph::RefineableTriangleMesh< ELEMENT >::adapt(), oomph::TreeBasedRefineableMeshBase::adapt_mesh(), oomph::SurfactantTransportInterfaceElement::add_additional_residual_contributions_interface(), oomph::FaceElement::add_additional_values(), oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::add_element_contribution_to_aux_integral(), oomph::Multi_domain_functions::add_external_halo_node_helper(), oomph::Missing_masters_functions::add_external_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::add_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::add_received_node_load_balance_helper(), oomph::AdvectionDiffusionFluxElement< ELEMENT >::AdvectionDiffusionFluxElement(), oomph::ElementWithMovingNodes::assemble_set_of_all_geometric_data(), oomph::TetMeshBase::assess_mesh_quality(), oomph::ElementWithExternalElement::assign_external_interaction_data_local_eqn_numbers(), oomph::RefineableElement::assign_hanging_local_eqn_numbers(), oomph::GeneralisedElement::assign_local_eqn_numbers(), assign_nodal_local_eqn_numbers(), oomph::RefineableSolidElement::assign_solid_hanging_local_eqn_numbers(), oomph::SolidFiniteElement::assign_solid_local_eqn_numbers(), oomph::Multi_domain_functions::aux_setup_multi_domain_interaction(), oomph::BackupMeshForProjection< GEOMETRIC_ELEMENT >::BackupMeshForProjection(), oomph::BiharmonicFluidBoundaryElement::BiharmonicFluidBoundaryElement(), oomph::LinearElasticityEquationsBase< DIM >::body_force(), oomph::TimeHarmonicLinearElasticityEquationsBase< DIM >::body_force(), oomph::PVDEquationsBase< DIM >::body_force(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::BrethertonSpineMesh(), oomph::RefineableQElement< 3 >::build(), oomph::RefineableSolidQElement< 3 >::build(), oomph::RefineableQElement< 1 >::build(), oomph::RefineableQElement< 2 >::build(), oomph::RefineableSolidQElement< 2 >::build(), build_face_element(), oomph::QHermiteElement< DIM >::build_face_element(), oomph::QSpectralElement< 1, NNODE_1D >::build_face_element(), oomph::QSpectralElement< 2, NNODE_1D >::build_face_element(), oomph::QSpectralElement< 3, NNODE_1D >::build_face_element(), oomph::TBubbleEnrichedElement< DIM, NNODE_1D >::build_face_element(), oomph::TElement< 1, NNODE_1D >::build_face_element(), oomph::TElement< 2, NNODE_1D >::build_face_element(), oomph::TElement< 3, NNODE_1D >::build_face_element(), oomph::GmshTetMesh< ELEMENT >::build_from_scaffold(), oomph::TetgenMesh< ELEMENT >::build_from_scaffold(), oomph::TriangleMesh< ELEMENT >::build_from_scaffold(), oomph::QuadFromTriangleMesh< ELEMENT >::build_from_scaffold(), oomph::BackwardStepQuadMesh< ELEMENT >::build_mesh(), oomph::ExtrudedCubeMeshFromQuadMesh< ELEMENT >::build_mesh(), oomph::BrickFromTetMesh< ELEMENT >::build_mesh(), oomph::TwoLayerSpineMesh< ELEMENT >::build_two_layer_mesh(), oomph::ChannelWithLeafletMesh< ELEMENT >::ChannelWithLeafletMesh(), oomph::TriangleMesh< ELEMENT >::check_connections_of_polyline_nodes(), oomph::Mesh::check_halo_schemes(), check_jacobian(), oomph::TriangleScaffoldMesh::check_mesh_integrity(), oomph::Mesh::classify_halo_and_haloed_nodes(), oomph::CollapsibleChannelMesh< ELEMENT >::CollapsibleChannelMesh(), oomph::FourierDecomposedHelmholtzDtNBoundaryElement< ELEMENT >::complete_setup_of_dependencies(), oomph::HelmholtzDtNBoundaryElement< ELEMENT >::complete_setup_of_dependencies(), oomph::RefineableTriangleMesh< ELEMENT >::compute_area_target(), oomph::TriangleMesh< ELEMENT >::compute_boundary_segments_connectivity_and_initial_zeta_values(), oomph::RefineableTriangleMesh< ELEMENT >::compute_global_node_names_and_shared_nodes(), oomph::RefineableTetMeshBase::compute_volume_target(), oomph::ElementWithSpecificMovingNodes< ELEMENT, NODE_TYPE >::construct_boundary_node(), construct_boundary_node(), oomph::SolidFiniteElement::construct_boundary_node(), oomph::Multi_domain_functions::construct_new_external_halo_master_node_helper(), oomph::Missing_masters_functions::construct_new_external_halo_master_node_helper(), oomph::Missing_masters_functions::construct_new_external_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::construct_new_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::construct_new_node_load_balance_helper(), oomph::ElementWithSpecificMovingNodes< ELEMENT, NODE_TYPE >::construct_node(), construct_node(), oomph::SolidFiniteElement::construct_node(), oomph::AxisymmetricVolumeConstraintBoundingElement::contribution_to_volume_flux(), oomph::Mesh::convert_to_boundary_node(), oomph::LinearisedQCrouzeixRaviartElement::copy_efunction_to_normalisation(), oomph::RefineableTriangleMesh< ELEMENT >::create_adjacency_matrix_new_shared_edges_helper(), oomph::RefineableTriangleMesh< ELEMENT >::create_new_shared_boundaries(), oomph::TriangleMesh< ELEMENT >::create_polylines_from_halo_elements_helper(), oomph::RefineableTriangleMesh< ELEMENT >::create_sorted_face_mesh_representation(), oomph::AxisymmetricPoroelasticityEquations::d2u_dt2(), oomph::PoroelasticityEquations< DIM >::d2u_dt2(), oomph::AxisymmetricLinearElasticityEquationsBase::d2u_dt2_axisymmetric_linear_elasticity(), oomph::LinearWaveEquations< DIM >::d2u_dt2_lin_wave(), oomph::LinearElasticityEquationsBase< DIM >::d2u_dt2_linear_elasticity(), oomph::ProjectableAdvectionDiffusionReactionElement< ADR_ELEMENT >::data_values_of_field(), oomph::ProjectableAxisymLinearElasticityElement< AXISYM_LINEAR_ELAST_ELEMENT >::data_values_of_field(), oomph::ProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::data_values_of_field(), oomph::ProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::data_values_of_field(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::data_values_of_field(), oomph::ProjectableDisplacementBasedFoepplvonKarmanElement< FVK_ELEMENT >::data_values_of_field(), oomph::ProjectableFoepplvonKarmanElement< FVK_ELEMENT >::data_values_of_field(), oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::data_values_of_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::data_values_of_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::data_values_of_field(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::data_values_of_field(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::data_values_of_field(), oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::data_values_of_field(), oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >::data_values_of_field(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::data_values_of_field(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::data_values_of_field(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::data_values_of_field(), oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::data_values_of_field(), oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >::data_values_of_field(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::data_values_of_field(), oomph::ProjectablePoissonElement< POISSON_ELEMENT >::data_values_of_field(), oomph::ProjectablePVDElementWithContinuousPressure< PVD_ELEMENT >::data_values_of_field(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::data_values_of_field(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::data_values_of_field(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::data_values_of_field(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::data_values_of_field(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::data_values_of_field(), oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >::dc_dt_adv_diff_react(), oomph::SurfactantTransportInterfaceElement::dcdt_surface(), oomph::RefineableElement::deactivate_element(), oomph::TPVDElement< DIM, NNODE_1D >::describe_local_dofs(), describe_nodal_local_dofs(), oomph::SolidFiniteElement::describe_solid_local_dofs(), oomph::AdvectionDiffusionEquations< DIM >::dinterpolated_u_adv_diff_ddata(), oomph::RefineableAdvectionDiffusionEquations< DIM >::dinterpolated_u_adv_diff_ddata(), oomph::RefineableAxisymAdvectionDiffusionEquations::dinterpolated_u_adv_diff_ddata(), oomph::RefineableSphericalAdvectionDiffusionEquations::dinterpolated_u_adv_diff_ddata(), oomph::SphericalAdvectionDiffusionEquations::dinterpolated_u_adv_diff_ddata(), oomph::SteadyAxisymAdvectionDiffusionEquations::dinterpolated_u_adv_diff_ddata(), oomph::AxisymAdvectionDiffusionEquations::dinterpolated_u_axi_adv_diff_ddata(), oomph::AxisymmetricNavierStokesEquations::dinterpolated_u_axi_nst_ddata(), oomph::RefineableAxisymmetricNavierStokesEquations::dinterpolated_u_axi_nst_ddata(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::dinterpolated_u_axi_nst_ddata(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::dinterpolated_u_axi_nst_ddata(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::RefineableGeneralisedNewtonianNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::NavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::RefineableNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::SpaceTimeNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::RefineableSpaceTimeNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::RefineableSpaceTimeNavierStokesMixedOrderEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::DisplacementControlElement::DisplacementControlElement(), oomph::Mesh::distribute(), dnodal_position_dt(), dnodal_position_gen_dt(), oomph::Mesh::doc_boundary_coordinates(), oomph::Z2ErrorEstimator::doc_flux(), oomph::Mesh::doc_mesh_distribution(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::dposition_dt(), oomph::AxisymmetricPoroelasticityEquations::dq_edge_dt(), oomph::PoroelasticityEquations< DIM >::dq_edge_dt(), oomph::AxisymmetricPoroelasticityEquations::du_dt(), oomph::PoroelasticityEquations< DIM >::du_dt(), oomph::AdvectionDiffusionEquations< DIM >::du_dt_adv_diff(), oomph::AxisymAdvectionDiffusionEquations::du_dt_axi_adv_diff(), oomph::AxisymmetricNavierStokesEquations::du_dt_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::du_dt_axi_nst(), oomph::AxisymmetricLinearElasticityEquationsBase::du_dt_axisymmetric_linear_elasticity(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::du_dt_cons_adv_diff(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::du_dt_cons_axisym_adv_diff(), oomph::LinearWaveEquations< DIM >::du_dt_lin_wave(), oomph::LinearisedAxisymmetricNavierStokesEquations::du_dt_linearised_axi_nst(), oomph::LinearisedNavierStokesEquations::du_dt_linearised_nst(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::du_dt_nst(), oomph::NavierStokesEquations< DIM >::du_dt_nst(), oomph::PolarNavierStokesEquations::du_dt_pnst(), oomph::SphericalAdvectionDiffusionEquations::du_dt_spherical_adv_diff(), oomph::SphericalNavierStokesEquations::du_dt_spherical_nst(), oomph::UnsteadyHeatEquations< DIM >::du_dt_ust_heat(), oomph::WomersleyEquations< DIM >::du_dt_womersley(), oomph::DummyErrorEstimator::DummyErrorEstimator(), oomph::TAxisymmetricPoroelasticityElement< ORDER >::edge_flux_node_pt(), oomph::TRaviartThomasDarcyElement< ORDER >::edge_flux_node_pt(), oomph::EighthSphereMesh< ELEMENT >::EighthSphereMesh(), oomph::SolidMesh::element_node_pt(), oomph::SpineMesh::element_node_pt(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::extrapolated_strain_rate(), oomph::ClampedSlidingHermiteBeamBoundaryConditionElement::fill_in_contribution_to_residuals(), oomph::ClampedHermiteShellBoundaryConditionElement::fill_in_contribution_to_residuals(), oomph::RefineableYoungLaplaceEquations::fill_in_contribution_to_residuals(), oomph::AxisymmetricLinearElasticityEquations::fill_in_generic_contribution_to_residuals_axisymmetric_linear_elasticity(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::ImposeImpenetrabilityElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::ImposeParallelOutflowElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::AxisymmetricPoroelasticityEquations::fill_in_generic_residual_contribution(), oomph::RefineablePolarNavierStokesEquations::fill_in_generic_residual_contribution(), oomph::AxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::RefineableAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::BiharmonicFluidBoundaryElement::fill_in_generic_residual_contribution_biharmonic_boundary(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::FourierDecomposedHelmholtzDtNBoundaryElement< ELEMENT >::fill_in_generic_residual_contribution_fourier_decomposed_helmholtz_DtN_bc(), oomph::LinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::RefineableLinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::LinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::RefineableLinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::RefineableSphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::SphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::RefineableSphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::SphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::SolidFiniteElement::fill_in_jacobian_for_newmark_accel(), oomph::ElementWithMovingNodes::fill_in_jacobian_from_geometric_data(), fill_in_jacobian_from_nodal_by_fd(), oomph::RefineableElement::fill_in_jacobian_from_nodal_by_fd(), oomph::SolidFiniteElement::fill_in_jacobian_from_solid_position_by_fd(), oomph::RefineableSolidElement::fill_in_jacobian_from_solid_position_by_fd(), oomph::RefineableNavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_by_fd(), oomph::AxisymmetricQTaylorHoodElement::fix_pressure(), oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement::fix_pressure(), oomph::LinearisedAxisymmetricQTaylorHoodElement::fix_pressure(), oomph::LinearisedQTaylorHoodElement::fix_pressure(), oomph::AxisymmetricTTaylorHoodElement::fix_pressure(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::fix_pressure(), oomph::GeneralisedNewtonianQTaylorHoodElement< DIM >::fix_pressure(), oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >::fix_pressure(), oomph::QTaylorHoodElement< DIM >::fix_pressure(), oomph::TTaylorHoodElement< DIM >::fix_pressure(), oomph::PolarTaylorHoodElement::fix_pressure(), oomph::QTaylorHoodSpaceTimeElement< DIM >::fix_pressure(), oomph::QTaylorHoodMixedOrderSpaceTimeElement< DIM >::fix_pressure(), oomph::QSphericalTaylorHoodElement::fix_pressure(), oomph::QPVDElementWithContinuousPressure< DIM >::fix_solid_pressure(), oomph::TPVDElementWithContinuousPressure< DIM >::fix_solid_pressure(), oomph::FSIDrivenCavityMesh< ELEMENT >::FSIDrivenCavityMesh(), oomph::FullCircleMesh< ELEMENT >::FullCircleMesh(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::geom_data_pt(), oomph::SolidFiniteElement::geom_data_pt(), oomph::RefineableSolidElement::geom_data_pt(), oomph::GeompackQuadScaffoldMesh::GeompackQuadScaffoldMesh(), oomph::RefineableTriangleMesh< ELEMENT >::get_boundary_segment_nodes_helper(), oomph::Problem::get_data_to_be_sent_during_load_balancing(), oomph::ElementWithMovingNodes::get_dnodal_coordinates_dgeom_dofs(), oomph::AxisymmetricQCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::AxisymmetricQTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::AxisymmetricTCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::BiharmonicEquations< DIM >::get_dof_numbers_for_unknowns(), oomph::TDisplacementBasedFoepplvonKarmanElement< NNODE_1D >::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::get_dof_numbers_for_unknowns(), oomph::ImposeImpenetrabilityElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::ImposeParallelOutflowElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::ClampedHermiteShellBoundaryConditionElement::get_dof_numbers_for_unknowns(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::get_dof_numbers_for_unknowns(), oomph::BlockPrecQTaylorHoodSpaceTimeElement::get_dof_numbers_for_unknowns(), oomph::BlockPrecQTaylorHoodMixedOrderSpaceTimeElement::get_dof_numbers_for_unknowns(), oomph::QSphericalCrouzeixRaviartElement::get_dof_numbers_for_unknowns(), oomph::QSphericalTaylorHoodElement::get_dof_numbers_for_unknowns(), oomph::AxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), get_dresidual_dnodal_coordinates(), oomph::RefineableElement::get_dresidual_dnodal_coordinates(), oomph::TriangleMesh< ELEMENT >::get_element_edges_on_boundary(), oomph::Z2ErrorEstimator::get_element_errors(), oomph::DummyErrorEstimator::get_element_errors(), oomph::RefineableTriangleMesh< ELEMENT >::get_face_mesh_representation(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::get_field(), oomph::TriangleMesh< ELEMENT >::get_halo_elements_on_all_procs(), oomph::RefineablePolarTaylorHoodElement::get_interpolated_values(), oomph::RefineablePolarCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableAxisymmetricQTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableLinearisedQTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableQSphericalTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::DGFaceElement::get_interpolation_data(), oomph::PolarCrouzeixRaviartElement::get_load_data(), oomph::PolarTaylorHoodElement::get_load_data(), get_node_number(), oomph::Mesh::get_node_reordering(), oomph::Missing_masters_functions::get_required_master_nodal_information_helper(), oomph::Multi_domain_functions::get_required_master_nodal_information_helper(), oomph::RefineableTriangleMesh< ELEMENT >::get_required_nodal_information_load_balance_helper(), oomph::RefineableTriangleMesh< ELEMENT >::get_shared_boundary_elements_and_face_indexes(), oomph::RefineableTriangleMesh< ELEMENT >::get_shared_boundary_segment_nodes_helper(), oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >::get_wind_adv_diff_react(), get_x(), oomph::SpectralPeriodicOrbitElement< NNODE_1D >::get_Z2_flux(), oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >::global_power_contribution(), oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >::global_power_contribution(), has_hanging_nodes(), oomph::HelmholtzBCElementBase< ELEMENT >::HelmholtzBCElementBase(), oomph::HelmholtzFluxElement< ELEMENT >::HelmholtzFluxElement(), oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::HelmholtzFluxFromNormalDisplacementBCElement(), oomph::TriangleMesh< ELEMENT >::identify_boundary_segments_and_assign_initial_zeta_values(), identify_field_data_for_interactions(), oomph::RefineableElement::identify_field_data_for_interactions(), oomph::SolidFiniteElement::identify_geometric_data(), oomph::RefineableSolidElement::identify_geometric_data(), oomph::FSIAxisymmetricQTaylorHoodElement::identify_load_data(), oomph::AxisymmetricTCrouzeixRaviartElement::identify_load_data(), oomph::AxisymmetricTTaylorHoodElement::identify_load_data(), oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement::identify_load_data(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::identify_load_data(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::identify_load_data(), oomph::RefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::identify_load_data(), oomph::RefineableQTaylorHoodElement< DIM >::identify_load_data(), oomph::RefineableQCrouzeixRaviartElement< DIM >::identify_load_data(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::identify_load_data(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::identify_load_data(), oomph::QSphericalCrouzeixRaviartElement::identify_load_data(), oomph::QSphericalTaylorHoodElement::identify_load_data(), oomph::FSIAxisymmetricQTaylorHoodElement::identify_pressure_data(), oomph::AxisymmetricTTaylorHoodElement::identify_pressure_data(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::identify_pressure_data(), oomph::QSphericalTaylorHoodElement::identify_pressure_data(), oomph::RefineablePolarTaylorHoodElement::insert_load_data(), oomph::RefineablePolarCrouzeixRaviartElement::insert_load_data(), oomph::BiharmonicEquations< DIM >::interpolated_dudx(), oomph::DGFaceElement::interpolated_u(), oomph::BiharmonicEquations< DIM >::interpolated_u_biharmonic(), oomph::RefineableAxisymmetricQTaylorHoodElement::interpolating_node_pt(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::interpolating_node_pt(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::interpolating_node_pt(), oomph::RefineableLinearisedQTaylorHoodElement::interpolating_node_pt(), oomph::RefineableQSphericalTaylorHoodElement::interpolating_node_pt(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::interpolating_node_pt(), oomph::RefineableElement::interpolating_node_pt(), oomph::RefineableQTaylorHoodElement< DIM >::interpolating_node_pt(), oomph::RefineablePolarTaylorHoodElement::interpolating_node_pt(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::interpolating_node_pt(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::interpolating_node_pt(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::interpolating_node_pt(), oomph::SolidFiniteElement::lagrangian_position(), oomph::SolidFiniteElement::lagrangian_position_gen(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::LinearisedAxisymPoroelasticBJS_FSIElement(), oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >::LinearisedFSIAxisymmetricNStNoSlipBCElementElement(), oomph::LinearWaveFluxElement< ELEMENT >::LinearWaveFluxElement(), oomph::RefineableTriangleMesh< ELEMENT >::load_balance(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::local_equation(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::local_equation(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::local_equation(), oomph::RefineableElement::local_hang_eqn(), oomph::RefineableSolidElement::local_position_hang_eqn(), oomph::Multi_domain_functions::locate_zeta_for_missing_coordinates(), oomph::HelmholtzMGPreconditioner< DIM >::maximum_edge_width(), oomph::NavierStokesFluxControlElement< ELEMENT >::NavierStokesFluxControlElement(), oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >::NavierStokesMixedOrderSpaceTimeTractionElement(), oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >::NavierStokesSpaceTimeTractionElement(), oomph::NavierStokesSurfaceDragTorqueElement< ELEMENT >::NavierStokesSurfaceDragTorqueElement(), oomph::NavierStokesSurfacePowerElement< ELEMENT >::NavierStokesSurfacePowerElement(), oomph::NavierStokesTractionElement< ELEMENT >::NavierStokesTractionElement(), oomph::RefineableImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::ncont_interpolated_values(), oomph::RefineableFSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::ncont_interpolated_values(), oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::nfields_for_projection(), oomph::RefineableSolidElement::ngeom_data(), oomph::ProjectableAdvectionDiffusionReactionElement< ADR_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableAxisymLinearElasticityElement< AXISYM_LINEAR_ELAST_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableDisplacementBasedFoepplvonKarmanElement< FVK_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableFoepplvonKarmanElement< FVK_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::GeneralisedNewtonianProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectablePoissonElement< POISSON_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectablePVDElement< PVD_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectablePVDElementWithContinuousPressure< PVD_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::nhistory_values_for_coordinate_projection(), oomph::ProjectableAdvectionDiffusionReactionElement< ADR_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableAxisymLinearElasticityElement< AXISYM_LINEAR_ELAST_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableDisplacementBasedFoepplvonKarmanElement< FVK_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableFoepplvonKarmanElement< FVK_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::nhistory_values_for_projection(), oomph::GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nhistory_values_for_projection(), oomph::GeneralisedNewtonianProjectableAxisymmetricCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableGeneralisedNewtonianCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nhistory_values_for_projection(), oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableCrouzeixRaviartElement< CROUZEIX_RAVIART_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectablePoissonElement< POISSON_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::nhistory_values_for_projection(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::nhistory_values_for_projection(), nodal_local_eqn(), nodal_position(), nodal_position_gen(), nodal_value(), node_update(), oomph::Mesh::node_update(), oomph::RefineableElement::nodes_built(), oomph::PRefineableElement::nodes_built(), oomph::SpectralPeriodicOrbitElement< NNODE_1D >::num_Z2_flux_terms(), oomph::LinearElasticitySmoothMesh< LINEAR_ELASTICITY_ELEMENT >::operator()(), oomph::PoissonSmoothMesh< POISSON_ELEMENT >::operator()(), oomph::HermiteBeamElement::output(), oomph::DummyFaceElement< ELEMENT >::output(), oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >::output(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::output(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::output(), oomph::FSILinearisedAxisymPoroelasticTractionElement< POROELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::output(), oomph::ClampedHermiteShellBoundaryConditionElement::output(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::TriangleMesh< ELEMENT >::output_boundary_coordinates(), oomph::ElementWithExternalElement::output_external_elements(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::output_integration_points(), output_paraview(), oomph::TreeBasedRefineableMeshBase::p_adapt_mesh(), oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >::p_refine(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::p_refine(), oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >::p_refine(), oomph::Tree::p_refine_if_required(), oomph::ProjectionProblem< PROJECTABLE_ELEMENT >::pin_all(), oomph::AxisymmetricTTaylorHoodElement::pin_all_nodal_pressure_dofs(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::pin_all_nodal_pressure_dofs(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::pin_all_non_pressure_dofs(), oomph::NavierStokesEquations< DIM >::pin_all_non_pressure_dofs(), oomph::SpaceTimeNavierStokesEquations< DIM >::pin_all_non_pressure_dofs(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::pin_all_non_pressure_dofs(), oomph::RefineableAxisymmetricQTaylorHoodElement::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableLinearisedQTaylorHoodElement::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableQTaylorHoodElement< DIM >::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineablePolarTaylorHoodElement::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableQSphericalTaylorHoodElement::pin_elemental_redundant_nodal_pressure_dofs(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::pin_elemental_redundant_nodal_solid_pressures(), oomph::TAxisymmetricPoroelasticityElement< ORDER >::pin_q_edge_value(), oomph::LinearisedQCrouzeixRaviartElement::pin_real_or_imag(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::pin_superfluous_darcy_dofs(), oomph::MGSolver< DIM >::plot(), oomph::PMLQuadMeshBase< ELEMENT >::pml_locate_zeta(), oomph::PMLHelmholtzFluxElement< ELEMENT >::PMLHelmholtzFluxElement(), oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::PMLHelmholtzFluxFromNormalDisplacementBCElement(), oomph::PMLHelmholtzPowerElement< ELEMENT >::PMLHelmholtzPowerElement(), oomph::PoissonFluxElement< ELEMENT >::PoissonFluxElement(), oomph::PolarNavierStokesTractionElement< ELEMENT >::PolarNavierStokesTractionElement(), oomph::PolarStressIntegralElement< ELEMENT >::PolarStressIntegralElement(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::position(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::pre_build(), oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >::pre_build(), oomph::StorableShapeSolidElementBase::pre_compute_d2shape_lagrangian_at_knots(), oomph::StorableShapeSolidElementBase::pre_compute_dshape_lagrangian_at_knots(), oomph::RefineableAxisymmetricQTaylorHoodElement::pressure_node_pt(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::pressure_node_pt(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::pressure_node_pt(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::pressure_node_pt(), oomph::RefineableLinearisedQTaylorHoodElement::pressure_node_pt(), oomph::RefineableQTaylorHoodElement< DIM >::pressure_node_pt(), oomph::PolarTaylorHoodElement::pressure_node_pt(), oomph::RefineablePolarTaylorHoodElement::pressure_node_pt(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::pressure_node_pt(), oomph::QTaylorHoodMixedOrderSpaceTimeElement< DIM >::pressure_node_pt(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::pressure_node_pt(), oomph::RefineableQSphericalTaylorHoodElement::pressure_node_pt(), oomph::ProjectionProblem< PROJECTABLE_ELEMENT >::project(), oomph::Mesh::prune_halo_elements_and_nodes(), oomph::TAxisymmetricPoroelasticityElement< ORDER >::q_edge_data_pt(), oomph::TRaviartThomasDarcyElement< ORDER >::q_edge_data_pt(), oomph::QuarterCircleSectorMesh< ELEMENT >::QuarterCircleSectorMesh(), oomph::QuarterTubeMesh< ELEMENT >::QuarterTubeMesh(), raw_dnodal_position_dt(), raw_dnodal_position_gen_dt(), oomph::SolidFiniteElement::raw_lagrangian_position(), oomph::SolidFiniteElement::raw_lagrangian_position_gen(), raw_nodal_position(), raw_nodal_position_gen(), raw_nodal_value(), oomph::TriangleMesh< ELEMENT >::re_assign_initial_zeta_values_for_internal_boundary(), oomph::TriangleMesh< ELEMENT >::re_scale_re_assigned_initial_zeta_values_for_internal_boundary(), oomph::MacroElementNodeUpdateElement< ELEMENT >::rebuild_from_sons(), oomph::RectangleWithHoleMesh< ELEMENT >::RectangleWithHoleMesh(), oomph::TreeBasedRefineableMeshBase::refine_as_in_reference_mesh(), oomph::RefineableImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_displ_lagr_multiplier(), oomph::RefineableFSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::refineable_fill_in_generic_contribution_to_residuals_fsi_displ_lagr_multiplier(), oomph::RefineableNavierStokesFluxControlElement< ELEMENT >::refineable_fill_in_generic_residual_contribution_fluid_traction(), oomph::Problem::remove_duplicate_data(), oomph::RefineableTriangleMesh< ELEMENT >::reset_halo_haloed_scheme(), oomph::RefineableTriangleMesh< ELEMENT >::reset_halo_haloed_scheme_helper(), oomph::FaceElement::resize_nodes(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::scalar_value_paraview(), oomph::TAxisymmetricPoroelasticityElement< ORDER >::scale_basis(), oomph::TRaviartThomasDarcyElement< ORDER >::scale_basis(), oomph::TPoroelasticityElement< ORDER >::scale_basis(), oomph::TriangleMesh< ELEMENT >::select_boundary_face_elements(), oomph::Problem::send_data_to_be_sent_during_load_balancing(), oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::set_external_data_from_navier_stokes_outflow_mesh(), oomph::MacroElementNodeUpdateElement< ELEMENT >::set_node_update_info(), oomph::TAxisymmetricPoroelasticityElement< ORDER >::set_q_edge(), oomph::TRaviartThomasDarcyElement< ORDER >::set_q_edge(), oomph::MGSolver< DIM >::set_self_test_vector(), oomph::QPVDElementWithContinuousPressure< DIM >::set_solid_p(), oomph::TPVDElementWithContinuousPressure< DIM >::set_solid_p(), oomph::VolumeConstraintBoundingElement::set_volume_constraint_element(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::setup_algebraic_node_update(), oomph::AlgebraicFishMesh< ELEMENT >::setup_algebraic_node_update(), oomph::AlgebraicRefineableQuarterCircleSectorMesh< ELEMENT >::setup_algebraic_node_update(), oomph::AlgebraicRefineableQuarterTubeMesh< ELEMENT >::setup_algebraic_node_update(), oomph::AlgebraicElementBase::setup_algebraic_node_update(), oomph::XdaTetMesh< ELEMENT >::setup_boundary_coordinates(), oomph::UnstructuredTwoDMeshGeometryBase::setup_boundary_coordinates(), oomph::BrickMeshBase::setup_boundary_element_info(), oomph::LineMeshBase::setup_boundary_element_info(), oomph::QuadMeshBase::setup_boundary_element_info(), oomph::TetMeshBase::setup_boundary_element_info(), oomph::TriangleMeshBase::setup_boundary_element_info(), oomph::HermiteQuadMesh< ELEMENT >::setup_boundary_element_info(), oomph::FluidInterfaceAdditionalValues< SurfactantTransportInterfaceElement >::setup_equation_indices(), oomph::FourierDecomposedHelmholtzDtNMesh< ELEMENT >::setup_gamma(), oomph::HelmholtzDtNMesh< ELEMENT >::setup_gamma(), oomph::MGSolver< DIM >::setup_interpolation_matrices_unstructured(), oomph::HelmholtzMGPreconditioner< DIM >::setup_interpolation_matrices_unstructured(), oomph::Z2ErrorEstimator::setup_patches(), oomph::Mesh::setup_shared_node_scheme(), oomph::SimpleRectangularTriMesh< ELEMENT >::SimpleRectangularTriMesh(), oomph::RefineableTriangleMesh< ELEMENT >::snap_nodes_onto_boundary(), oomph::TetMeshBase::snap_nodes_onto_geometric_objects(), oomph::TetMeshBase::snap_to_quadratic_surface(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::solid_pressure_node_pt(), oomph::TetMeshBase::split_elements_in_corners(), oomph::Tree::split_if_required(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::square_of_l2_norm_of_error(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::strain_rate(), oomph::TreeBasedRefineableMeshBase::synchronise_nonhanging_nodes(), oomph::TriangleMesh< ELEMENT >::synchronize_boundary_coordinates(), oomph::TetgenScaffoldMesh::TetgenScaffoldMesh(), oomph::ThinLayerBrickOnTetMesh< ELEMENT >::ThinLayerBrickOnTetMesh(), oomph::TriangleScaffoldMesh::TriangleScaffoldMesh(), oomph::TubeMesh< ELEMENT >::TubeMesh(), oomph::FluidInterfaceElement::u(), oomph::BiharmonicElement< DIM >::u(), oomph::YoungLaplaceContactAngleElement< ELEMENT >::u(), oomph::RefineableElement::unbuild(), oomph::AxisymmetricTTaylorHoodElement::unpin_all_nodal_pressure_dofs(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::unpin_all_nodal_pressure_dofs(), oomph::RefineableAxisymmetricQTaylorHoodElement::unpin_elemental_pressure_dofs(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::unpin_elemental_pressure_dofs(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::unpin_elemental_pressure_dofs(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::unpin_elemental_pressure_dofs(), oomph::RefineableLinearisedQTaylorHoodElement::unpin_elemental_pressure_dofs(), oomph::RefineableQTaylorHoodElement< DIM >::unpin_elemental_pressure_dofs(), oomph::RefineablePolarTaylorHoodElement::unpin_elemental_pressure_dofs(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::unpin_elemental_pressure_dofs(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::unpin_elemental_pressure_dofs(), oomph::RefineableQSphericalTaylorHoodElement::unpin_elemental_pressure_dofs(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::unpin_elemental_solid_pressure_dofs(), oomph::QPVDElementWithContinuousPressure< DIM >::unpin_elemental_solid_pressure_dofs(), oomph::TPVDElementWithContinuousPressure< DIM >::unpin_elemental_solid_pressure_dofs(), oomph::AxisymmetricTTaylorHoodElement::unpin_proper_nodal_pressure_dofs(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::unpin_proper_nodal_pressure_dofs(), oomph::LinearisedQCrouzeixRaviartElement::unpin_real_or_imag(), oomph::UnsteadyHeatFluxElement< ELEMENT >::UnsteadyHeatFluxElement(), oomph::RefineableTetgenMesh< ELEMENT >::update_faceted_surface_using_face_mesh(), oomph::RefineableTriangleMesh< ELEMENT >::update_open_curve_after_restart(), oomph::RefineableTriangleMesh< ELEMENT >::update_open_curve_using_elements_area(), oomph::RefineableTriangleMesh< ELEMENT >::update_open_curve_using_face_mesh(), oomph::RefineableTriangleMesh< ELEMENT >::update_polygon_after_restart(), oomph::RefineableTriangleMesh< ELEMENT >::update_polygon_using_elements_area(), oomph::RefineableTriangleMesh< ELEMENT >::update_polygon_using_face_mesh(), oomph::RefineableTriangleMesh< ELEMENT >::update_shared_curve_after_restart(), oomph::RefineableTriangleMesh< ELEMENT >::update_shared_curve_using_elements_area(), oomph::AxisymFoepplvonKarmanEquations::use_linear_bending_model(), oomph::DisplacementBasedFoepplvonKarmanEquations::use_linear_bending_model(), oomph::FoepplvonKarmanEquations::use_linear_bending_model(), oomph::AxisymmetricTCrouzeixRaviartElement::vertex_node_pt(), oomph::AxisymmetricTTaylorHoodElement::vertex_node_pt(), oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement::vertex_node_pt(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::vertex_node_pt(), oomph::GeneralisedNewtonianTCrouzeixRaviartElement< DIM >::vertex_node_pt(), oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >::vertex_node_pt(), oomph::TCrouzeixRaviartElement< DIM >::vertex_node_pt(), oomph::TTaylorHoodElement< DIM >::vertex_node_pt(), oomph::WomersleyMesh< WOMERSLEY_ELEMENT >::WomersleyMesh(), oomph::YoungLaplaceContactAngleElement< ELEMENT >::YoungLaplaceContactAngleElement(), oomph::FaceElement::zeta_nodal(), and oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::zeta_nodal().

◆ node_pt() [2/2]

Node* const& oomph::FiniteElement::node_pt ( const unsigned &  n) const
inline

Return a pointer to the local node n (const version)

Definition at line 2192 of file elements.h.

References Nnode, and Node_pt.

◆ node_update()

void oomph::FiniteElement::node_update ( )
virtual

Update the positions of all nodes in the element using each node update function. The default implementation may be overloaded so that more efficient versions can be written.

Loop over all nodes in the element and update their positions using each node's (algebraic) update function.

Definition at line 5072 of file elements.cc.

References nnode(), node_pt(), and oomph::Node::node_update().

Referenced by oomph::ElementWithMovingNodes::fill_in_jacobian_from_geometric_data(), oomph::ElementWithMovingNodes::get_dnodal_coordinates_dgeom_dofs(), oomph::FSIWallElement::node_update_adjacent_fluid_elements(), oomph::ImmersedRigidBodyElement::node_update_adjacent_fluid_elements(), oomph::FluidInterfaceBoundingElement::reset_after_external_fd(), and oomph::FluidInterfaceBoundingElement::update_in_external_fd().

◆ nplot_points()

virtual unsigned oomph::FiniteElement::nplot_points ( const unsigned &  nplot) const
inlinevirtual

Return total number of plot points (when plotting nplot points in each "coordinate direction")

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, and oomph::QHermiteElement< DIM - 1 >.

Definition at line 3186 of file elements.h.

Referenced by oomph::Mesh::doc_boundary_coordinates(), oomph::Z2ErrorEstimator::doc_flux(), oomph::PolarNavierStokesEquations::full_output(), oomph::SphericalNavierStokesEquations::full_output(), locate_zeta(), oomph::AxisymFoepplvonKarmanEquations::output(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::output(), oomph::AxisymmetricLinearElasticityEquations::output(), oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >::output(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::output(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::output(), oomph::FluidInterfaceElement::output(), oomph::SurfactantTransportInterfaceElement::output(), oomph::DisplacementBasedFoepplvonKarmanEquations::output(), oomph::FoepplvonKarmanEquations::output(), oomph::FourierDecomposedHelmholtzEquations::output(), oomph::NavierStokesSurfaceDragTorqueElement< ELEMENT >::output(), oomph::PMLFourierDecomposedHelmholtzEquations::output(), oomph::SolidTractionElement< ELEMENT >::output(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::output(), oomph::YoungLaplaceEquations::output(), oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::output(), oomph::AxisymAdvectionDiffusionEquations::output(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::output(), oomph::AxisymmetricNavierStokesEquations::output(), oomph::AxisymmetricPoroelasticityEquations::output(), oomph::BiharmonicEquations< DIM >::output(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output(), oomph::LinearisedAxisymmetricNavierStokesEquations::output(), oomph::LinearisedNavierStokesEquations::output(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::output(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::output(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::PoissonFluxElement< ELEMENT >::output(), oomph::PolarNavierStokesEquations::output(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::SphericalAdvectionDiffusionEquations::output(), oomph::SphericalNavierStokesEquations::output(), oomph::SteadyAxisymAdvectionDiffusionEquations::output(), oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::AxisymFoepplvonKarmanEquations::output_fct(), oomph::DisplacementBasedFoepplvonKarmanEquations::output_fct(), oomph::FoepplvonKarmanEquations::output_fct(), oomph::FourierDecomposedHelmholtzEquations::output_fct(), oomph::PMLFourierDecomposedHelmholtzEquations::output_fct(), oomph::YoungLaplaceEquations::output_fct(), oomph::AxisymAdvectionDiffusionEquations::output_fct(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::output_fct(), oomph::AxisymmetricLinearElasticityEquations::output_fct(), oomph::AxisymmetricNavierStokesEquations::output_fct(), oomph::AxisymmetricPoroelasticityEquations::output_fct(), oomph::BiharmonicEquations< DIM >::output_fct(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_fct(), oomph::PolarNavierStokesEquations::output_fct(), oomph::SphericalAdvectionDiffusionEquations::output_fct(), oomph::SphericalNavierStokesEquations::output_fct(), oomph::SteadyAxisymAdvectionDiffusionEquations::output_fct(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::output_fct(), oomph::BiharmonicEquations< DIM >::output_fluid_velocity(), oomph::FourierDecomposedHelmholtzEquations::output_real(), oomph::PMLFourierDecomposedHelmholtzEquations::output_real(), oomph::FourierDecomposedHelmholtzEquations::output_real_fct(), oomph::PMLFourierDecomposedHelmholtzEquations::output_real_fct(), oomph::AxisymmetricNavierStokesEquations::output_veloc(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedNavierStokesEquations::output_veloc(), oomph::PolarNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_vorticity(), oomph::FaceElement::output_zeta(), and oomph::Multi_domain_functions::setup_bulk_elements_adjacent_to_face_mesh().

◆ nplot_points_paraview()

virtual unsigned oomph::FiniteElement::nplot_points_paraview ( const unsigned &  nplot) const
inlinevirtual

Return the number of actual plot points for paraview plot with parameter nplot. Broken virtual; can be overloaded in specific elements.

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, and oomph::QElement< 1, NNODE_1D >.

Definition at line 2862 of file elements.h.

Referenced by oomph::Mesh::output_fct_paraview(), output_paraview(), oomph::Mesh::output_paraview(), oomph::NavierStokesEquations< DIM >::scalar_value_fct_paraview(), oomph::SpaceTimeNavierStokesEquations< DIM >::scalar_value_fct_paraview(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::scalar_value_fct_paraview(), oomph::PMLHelmholtzEquations< DIM >::scalar_value_fct_paraview(), oomph::PoissonEquations< DIM >::scalar_value_fct_paraview(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::scalar_value_fct_paraview(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::scalar_value_fct_paraview(), oomph::AdvectionDiffusionEquations< DIM >::scalar_value_paraview(), oomph::AxisymAdvectionDiffusionEquations::scalar_value_paraview(), oomph::AxisymmetricNavierStokesEquations::scalar_value_paraview(), oomph::AxisymmetricPoroelasticityEquations::scalar_value_paraview(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::scalar_value_paraview(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::scalar_value_paraview(), oomph::HelmholtzEquations< DIM >::scalar_value_paraview(), oomph::NavierStokesEquations< DIM >::scalar_value_paraview(), oomph::PMLHelmholtzEquations< DIM >::scalar_value_paraview(), oomph::PoissonEquations< DIM >::scalar_value_paraview(), oomph::SpaceTimeNavierStokesEquations< DIM >::scalar_value_paraview(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::scalar_value_paraview(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::scalar_value_paraview(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::scalar_value_paraview(), and oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::scalar_value_paraview().

◆ nscalar_paraview()

virtual unsigned oomph::FiniteElement::nscalar_paraview ( ) const
inlinevirtual

◆ nsub_elements_paraview()

virtual unsigned oomph::FiniteElement::nsub_elements_paraview ( const unsigned &  nplot) const
inlinevirtual

Return the number of local sub-elements for paraview plot with parameter nplot. Broken virtual; can be overloaded in specific elements.

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, and oomph::QElement< 1, NNODE_1D >.

Definition at line 2876 of file elements.h.

Referenced by oomph::Mesh::output_fct_paraview(), and oomph::Mesh::output_paraview().

◆ nvertex_node()

virtual unsigned oomph::FiniteElement::nvertex_node ( ) const
inlinevirtual

Return the number of vertex nodes in this element. Broken virtual function in "pure" finite elements.

Reimplemented in oomph::BrickElementBase, oomph::QuadElementBase, oomph::LineElementBase, oomph::ElementWithZ2ErrorEstimator, oomph::RefineableQYoungLaplaceElement< NNODE_1D >, oomph::TUnsteadyHeatElement< DIM, NNODE_1D >, oomph::RefineableQUnsteadyHeatElement< DIM, NNODE_1D >, oomph::TTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::RefineableQTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::TTimeHarmonicFourierDecomposedLinearElasticityElement< NNODE_1D >, oomph::RefineableQSphericalCrouzeixRaviartElement, oomph::RefineableQSphericalTaylorHoodElement, oomph::RefineableQSphericalAdvectionDiffusionElement< NNODE_1D >, oomph::RefineableQUnsteadyHeatMixedOrderSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::RefineableQUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::RefineableQUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >, oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >, oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >, oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >, oomph::TPVDElementWithContinuousPressure< DIM >, oomph::TPVDBubbleEnrichedElement< DIM, NNODE_1D >, oomph::TPVDElement< DIM, NNODE_1D >, oomph::RefineableQPVDElementWithContinuousPressure< DIM >, oomph::RefineableQPVDElementWithPressure< DIM >, oomph::RefineableQPVDElement< DIM, NNODE_1D >, oomph::RefineablePolarCrouzeixRaviartElement, oomph::RefineablePolarTaylorHoodElement, oomph::TPoissonElement< DIM, NNODE_1D >, oomph::RefineableQSpectralPoissonElement< DIM, NNODE_1D >, oomph::PRefineableQPoissonElement< DIM >, oomph::RefineableQPoissonElement< DIM, NNODE_1D >, oomph::TPMLTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::TPMLHelmholtzElement< DIM, NNODE_1D >, oomph::RefineableQPMLHelmholtzElement< DIM, NNODE_1D >, oomph::RefineableQPMLHelmholtzElement< 2, NNODE_1D >, oomph::TPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::TTaylorHoodElement< DIM >, oomph::TCrouzeixRaviartElement< DIM >, oomph::PRefineableQCrouzeixRaviartElement< DIM >, oomph::RefineableQCrouzeixRaviartElement< DIM >, oomph::RefineableQTaylorHoodElement< DIM >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::RefineableLinearisedQTaylorHoodElement, oomph::RefineableLinearisedQCrouzeixRaviartElement, oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement, oomph::RefineableLinearisedAxisymmetricQCrouzeixRaviartElement, oomph::RefineableQLinearWaveElement< DIM, NNODE_1D >, oomph::TLinearElasticityElement< DIM, NNODE_1D >, oomph::PRefineableQLinearElasticityElement< DIM >, oomph::RefineableQLinearElasticityElement< DIM, NNODE_1D >, oomph::THelmholtzElement< DIM, NNODE_1D >, oomph::RefineableQHelmholtzElement< DIM, NNODE_1D >, oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::SpectralPeriodicOrbitElement< NNODE_1D >, oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianTCrouzeixRaviartElement< DIM >, oomph::PRefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >, oomph::RefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >, oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement, oomph::RefineableGeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement, oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement, oomph::TFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::TFoepplvonKarmanElement< NNODE_1D >, oomph::TDisplacementBasedFoepplvonKarmanElement< NNODE_1D >, oomph::TRaviartThomasDarcyElement< ORDER >, oomph::TAxisymmetricPoroelasticityElement< ORDER >, oomph::AxisymmetricTTaylorHoodElement, oomph::AxisymmetricTCrouzeixRaviartElement, oomph::RefineableAxisymmetricQCrouzeixRaviartElement, oomph::RefineableAxisymmetricQTaylorHoodElement, oomph::TAxisymmetricLinearElasticityElement< NNODE_1D >, oomph::RefineableQGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::RefineableQAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::TAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::RefineableQAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::RefineableQSUPGAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::RefineableQGeneralisedAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::RefineableQAdvectionDiffusionElement< DIM, NNODE_1D >, and oomph::RefineableQAdvectionDiffusionElement< DIM, 3 >.

Definition at line 2491 of file elements.h.

References oomph::Global_string_for_annotation::string().

Referenced by oomph::RefineableQAdvectionDiffusionElement< DIM, NNODE_1D >::nvertex_node(), oomph::RefineableQSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::nvertex_node(), oomph::RefineableQAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >::nvertex_node(), oomph::RefineableAxisymmetricQTaylorHoodElement::nvertex_node(), oomph::RefineableAxisymmetricQCrouzeixRaviartElement::nvertex_node(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::nvertex_node(), oomph::RefineableGeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement::nvertex_node(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::nvertex_node(), oomph::RefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::nvertex_node(), oomph::PRefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::nvertex_node(), oomph::RefineableQHelmholtzElement< DIM, NNODE_1D >::nvertex_node(), oomph::RefineableQLinearElasticityElement< DIM, NNODE_1D >::nvertex_node(), oomph::PRefineableQLinearElasticityElement< DIM >::nvertex_node(), oomph::RefineableQLinearWaveElement< DIM, NNODE_1D >::nvertex_node(), oomph::RefineableLinearisedAxisymmetricQCrouzeixRaviartElement::nvertex_node(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::nvertex_node(), oomph::RefineableLinearisedQCrouzeixRaviartElement::nvertex_node(), oomph::RefineableLinearisedQTaylorHoodElement::nvertex_node(), oomph::RefineableQTaylorHoodElement< DIM >::nvertex_node(), oomph::RefineableQCrouzeixRaviartElement< DIM >::nvertex_node(), oomph::PRefineableQCrouzeixRaviartElement< DIM >::nvertex_node(), oomph::RefineableQPMLHelmholtzElement< DIM, NNODE_1D >::nvertex_node(), oomph::RefineableQPoissonElement< DIM, NNODE_1D >::nvertex_node(), oomph::PRefineableQPoissonElement< DIM >::nvertex_node(), oomph::RefineableQSpectralPoissonElement< DIM, NNODE_1D >::nvertex_node(), oomph::RefineablePolarTaylorHoodElement::nvertex_node(), oomph::RefineablePolarCrouzeixRaviartElement::nvertex_node(), oomph::RefineableQPVDElement< DIM, NNODE_1D >::nvertex_node(), oomph::RefineableQPVDElementWithPressure< DIM >::nvertex_node(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::nvertex_node(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::nvertex_node(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::nvertex_node(), oomph::RefineableQSphericalTaylorHoodElement::nvertex_node(), oomph::RefineableQSphericalCrouzeixRaviartElement::nvertex_node(), and oomph::RefineableQUnsteadyHeatElement< DIM, NNODE_1D >::nvertex_node().

◆ output() [1/5]

virtual void oomph::FiniteElement::output ( const unsigned &  t,
std::ostream &  outfile,
const unsigned &  n_plot 
) const
inlinevirtual

Output the element data at time step t. This is const because it is newly added and so can be done easily. Really all the output(...) functions should be const!

Reimplemented in oomph::HermiteBeamElement.

Definition at line 3071 of file elements.h.

◆ output() [2/5]

virtual void oomph::FiniteElement::output ( FILE *  file_pt)
inlinevirtual

Output the element data — typically the values at the nodes in a format suitable for post-processing. (C style output)

Reimplemented in oomph::YoungLaplaceContactAngleElement< ELEMENT >, oomph::QWomersleyElement< DIM, NNODE_1D >, oomph::WomersleyEquations< DIM >, oomph::TWomersleyElement< DIM, NNODE_1D >, oomph::UnsteadyHeatFluxElement< ELEMENT >, oomph::QUnsteadyHeatElement< DIM, NNODE_1D >, oomph::UnsteadyHeatEquations< DIM >, oomph::TUnsteadyHeatElement< DIM, NNODE_1D >, oomph::TTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >, oomph::QTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::TimeHarmonicLinearElasticityEquations< DIM >, oomph::TimeHarmonicFourierDecomposedLinearElasticityTractionElement< ELEMENT >, oomph::TTimeHarmonicFourierDecomposedLinearElasticityElement< NNODE_1D >, oomph::QTimeHarmonicFourierDecomposedLinearElasticityElement< NNODE_1D >, oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations, oomph::QSteadyAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::SteadyAxisymAdvectionDiffusionEquations, oomph::QSphericalTaylorHoodElement, oomph::QSphericalCrouzeixRaviartElement, oomph::SphericalNavierStokesEquations, oomph::QSphericalAdvectionDiffusionElement< NNODE_1D >, oomph::SphericalAdvectionDiffusionEquations, oomph::QUnsteadyHeatMixedOrderSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::QTaylorHoodMixedOrderSpaceTimeElement< DIM >, oomph::QTaylorHoodMixedOrderSpaceTimeElement< 2 >, oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SolidTractionElement< ELEMENT >, oomph::TPVDElementWithContinuousPressure< DIM >, oomph::TPVDBubbleEnrichedElement< DIM, NNODE_1D >, oomph::TPVDElement< DIM, NNODE_1D >, oomph::QPVDElementWithContinuousPressure< DIM >, oomph::QPVDElementWithPressure< DIM >, oomph::PVDEquationsWithPressure< DIM >, oomph::HermitePVDElement< DIM >, oomph::QPVDElement< DIM, NNODE_1D >, oomph::PVDEquations< DIM >, oomph::ClampedHermiteShellBoundaryConditionElement, oomph::HermiteShellElement, oomph::KirchhoffLoveShellEquations, oomph::PoroelasticityFaceElement< ELEMENT >, oomph::PolarTaylorHoodElement, oomph::PolarCrouzeixRaviartElement, oomph::PolarNavierStokesEquations, oomph::TPoissonElement< DIM, NNODE_1D >, oomph::QSpectralPoissonElement< DIM, NNODE_1D >, oomph::PoissonFluxElement< ELEMENT >, oomph::QPoissonElement< DIM, NNODE_1D >, oomph::QPoissonElement< DIM, 2 >, oomph::PoissonEquations< DIM >, oomph::TPMLTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >, oomph::QPMLTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::QPMLTimeHarmonicLinearElasticityElement< 2, NNODE_1D >, oomph::PMLTimeHarmonicLinearElasticityEquations< DIM >, oomph::TPMLHelmholtzElement< DIM, NNODE_1D >, oomph::PMLHelmholtzFluxElement< ELEMENT >, oomph::QPMLHelmholtzElement< DIM, NNODE_1D >, oomph::QPMLHelmholtzElement< 2, NNODE_1D >, oomph::PMLHelmholtzEquations< DIM >, oomph::TPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >, oomph::PMLFourierDecomposedHelmholtzFluxElement< ELEMENT >, oomph::QPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::PMLFourierDecomposedHelmholtzEquations, oomph::TTaylorHoodElement< DIM >, oomph::TCrouzeixRaviartElement< DIM >, oomph::QTaylorHoodElement< DIM >, oomph::QCrouzeixRaviartElement< DIM >, oomph::NavierStokesEquations< DIM >, oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >, oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >, oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, oomph::LinearisedQTaylorHoodElement, oomph::LinearisedQCrouzeixRaviartElement, oomph::LinearisedNavierStokesEquations, oomph::LinearisedAxisymmetricQTaylorHoodElement, oomph::LinearisedAxisymmetricQCrouzeixRaviartElement, oomph::LinearisedAxisymmetricNavierStokesEquations, oomph::LinearWaveFluxElement< ELEMENT >, oomph::QLinearWaveElement< DIM, NNODE_1D >, oomph::LinearWaveEquations< DIM >, oomph::TLinearElasticityElement< DIM, NNODE_1D >, oomph::LinearElasticityTractionElement< ELEMENT >, oomph::QLinearElasticityElement< DIM, NNODE_1D >, oomph::QLinearElasticityElement< DIM, 2 >, oomph::LinearElasticityEquations< DIM >, oomph::THelmholtzElement< DIM, NNODE_1D >, oomph::HelmholtzFluxElement< ELEMENT >, oomph::QHelmholtzElement< DIM, NNODE_1D >, oomph::HelmholtzEquations< DIM >, oomph::HelmholtzBCElementBase< ELEMENT >, oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::SolidQElement< 3, NNODE_1D >, oomph::SolidQElement< 2, NNODE_1D >, oomph::SolidQElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::SpectralPeriodicOrbitElement< NNODE_1D >, oomph::SolidQHermiteElement< DIM >, oomph::SolidQHermiteElement< 1 >, oomph::SolidQHermiteElement< 2 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::DummyFaceElement< ELEMENT >, oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianTCrouzeixRaviartElement< DIM >, oomph::GeneralisedNewtonianQTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianQCrouzeixRaviartElement< DIM >, oomph::GeneralisedNewtonianNavierStokesEquations< DIM >, oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement, oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement, oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations, oomph::TFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::FourierDecomposedHelmholtzFluxElement< ELEMENT >, oomph::QFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::FourierDecomposedHelmholtzEquations, oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >, oomph::TFoepplvonKarmanElement< NNODE_1D >, oomph::TDisplacementBasedFoepplvonKarmanElement< NNODE_1D >, oomph::QFoepplvonKarmanElement< NNODE_1D >, oomph::FoepplvonKarmanEquations, oomph::DisplacementBasedFoepplvonKarmanEquations, oomph::SurfactantTransportInterfaceElement, oomph::ElasticLineFluidInterfaceBoundingElement< ELEMENT >, oomph::ElasticPointFluidInterfaceBoundingElement< ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >, oomph::SpineLineFluidInterfaceBoundingElement< ELEMENT >, oomph::SpinePointFluidInterfaceBoundingElement< ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< EQUATION_CLASS, DERIVATIVE_CLASS, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, LineDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >, oomph::FluidInterfaceElement, oomph::FluidInterfaceBoundingElement, oomph::DarcyFaceElement< ELEMENT >, oomph::BiharmonicFluidBoundaryElement, oomph::BiharmonicFluxElement< DIM >, oomph::BiharmonicElement< DIM >, oomph::BiharmonicEquations< DIM >, oomph::ClampedSlidingHermiteBeamBoundaryConditionElement, oomph::HermiteBeamElement, oomph::AxisymmetricSolidTractionElement< ELEMENT >, oomph::AxisymQPVDElementWithPressure, oomph::AxisymmetricPVDEquationsWithPressure, oomph::AxisymDiagHermitePVDElement, oomph::AxisymQPVDElement, oomph::AxisymmetricPVDEquations, oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >, oomph::AxisymmetricPoroelasticityTractionElement< POROELASTICITY_BULK_ELEMENT >, oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >, oomph::AxisymmetricTTaylorHoodElement, oomph::AxisymmetricTCrouzeixRaviartElement, oomph::AxisymmetricQTaylorHoodElement, oomph::AxisymmetricQCrouzeixRaviartElement, oomph::AxisymmetricNavierStokesEquations, oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >, oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >, oomph::TAxisymmetricLinearElasticityElement< NNODE_1D >, oomph::FSIAxisymmetricLinearElasticityTractionElement< ELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >, oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >, oomph::QAxisymmetricLinearElasticityElement< NNODE_1D >, oomph::AxisymmetricLinearElasticityEquations, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanEquations, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanEquations, oomph::QGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::GeneralisedAxisymAdvectionDiffusionEquations, oomph::QAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::AxisymAdvectionDiffusionEquations, oomph::TAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::QAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >, oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::QGeneralisedAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::GeneralisedAdvectionDiffusionEquations< DIM >, oomph::QAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::QAdvectionDiffusionElement< DIM, 3 >, and oomph::AdvectionDiffusionEquations< DIM >.

Definition at line 3084 of file elements.h.

◆ output() [3/5]

virtual void oomph::FiniteElement::output ( FILE *  file_pt,
const unsigned &  n_plot 
)
inlinevirtual

Output the element data — pass (some measure of) the number of plot points per element (C style output)

Reimplemented in oomph::QSphericalTaylorHoodElement, oomph::QSphericalCrouzeixRaviartElement, oomph::SphericalNavierStokesEquations, oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::QTaylorHoodMixedOrderSpaceTimeElement< DIM >, oomph::QTaylorHoodMixedOrderSpaceTimeElement< 2 >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::PolarTaylorHoodElement, oomph::PolarCrouzeixRaviartElement, oomph::PolarNavierStokesEquations, oomph::QTaylorHoodElement< DIM >, oomph::QCrouzeixRaviartElement< DIM >, oomph::NavierStokesEquations< DIM >, oomph::LinearisedNavierStokesEquations, oomph::LinearisedAxisymmetricNavierStokesEquations, oomph::LinearWaveEquations< DIM >, oomph::GeneralisedNewtonianQTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianQCrouzeixRaviartElement< DIM >, oomph::GeneralisedNewtonianNavierStokesEquations< DIM >, oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations, oomph::AxisymmetricNavierStokesEquations, oomph::YoungLaplaceContactAngleElement< ELEMENT >, oomph::QWomersleyElement< DIM, NNODE_1D >, oomph::WomersleyEquations< DIM >, oomph::TWomersleyElement< DIM, NNODE_1D >, oomph::UnsteadyHeatFluxElement< ELEMENT >, oomph::QUnsteadyHeatElement< DIM, NNODE_1D >, oomph::UnsteadyHeatEquations< DIM >, oomph::TUnsteadyHeatElement< DIM, NNODE_1D >, oomph::TTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >, oomph::QTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::TimeHarmonicLinearElasticityEquations< DIM >, oomph::TimeHarmonicFourierDecomposedLinearElasticityTractionElement< ELEMENT >, oomph::TTimeHarmonicFourierDecomposedLinearElasticityElement< NNODE_1D >, oomph::QTimeHarmonicFourierDecomposedLinearElasticityElement< NNODE_1D >, oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations, oomph::QSteadyAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::SteadyAxisymAdvectionDiffusionEquations, oomph::QSphericalAdvectionDiffusionElement< NNODE_1D >, oomph::SphericalAdvectionDiffusionEquations, oomph::QUnsteadyHeatMixedOrderSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SolidTractionElement< ELEMENT >, oomph::TPVDElementWithContinuousPressure< DIM >, oomph::TPVDBubbleEnrichedElement< DIM, NNODE_1D >, oomph::TPVDElement< DIM, NNODE_1D >, oomph::QPVDElementWithContinuousPressure< DIM >, oomph::QPVDElementWithPressure< DIM >, oomph::PVDEquationsWithPressure< DIM >, oomph::HermitePVDElement< DIM >, oomph::QPVDElement< DIM, NNODE_1D >, oomph::PVDEquations< DIM >, oomph::ClampedHermiteShellBoundaryConditionElement, oomph::HermiteShellElement, oomph::KirchhoffLoveShellEquations, oomph::PoroelasticityFaceElement< ELEMENT >, oomph::TPoissonElement< DIM, NNODE_1D >, oomph::QSpectralPoissonElement< DIM, NNODE_1D >, oomph::PoissonFluxElement< ELEMENT >, oomph::QPoissonElement< DIM, NNODE_1D >, oomph::QPoissonElement< DIM, 2 >, oomph::PoissonEquations< DIM >, oomph::TPMLTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >, oomph::QPMLTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::QPMLTimeHarmonicLinearElasticityElement< 2, NNODE_1D >, oomph::PMLTimeHarmonicLinearElasticityEquations< DIM >, oomph::TPMLHelmholtzElement< DIM, NNODE_1D >, oomph::PMLHelmholtzFluxElement< ELEMENT >, oomph::QPMLHelmholtzElement< DIM, NNODE_1D >, oomph::QPMLHelmholtzElement< 2, NNODE_1D >, oomph::PMLHelmholtzEquations< DIM >, oomph::TPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >, oomph::PMLFourierDecomposedHelmholtzFluxElement< ELEMENT >, oomph::QPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::PMLFourierDecomposedHelmholtzEquations, oomph::TTaylorHoodElement< DIM >, oomph::TCrouzeixRaviartElement< DIM >, oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >, oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >, oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, oomph::LinearisedQTaylorHoodElement, oomph::LinearisedQCrouzeixRaviartElement, oomph::LinearisedAxisymmetricQTaylorHoodElement, oomph::LinearisedAxisymmetricQCrouzeixRaviartElement, oomph::LinearWaveFluxElement< ELEMENT >, oomph::QLinearWaveElement< DIM, NNODE_1D >, oomph::TLinearElasticityElement< DIM, NNODE_1D >, oomph::LinearElasticityTractionElement< ELEMENT >, oomph::QLinearElasticityElement< DIM, NNODE_1D >, oomph::QLinearElasticityElement< DIM, 2 >, oomph::LinearElasticityEquations< DIM >, oomph::THelmholtzElement< DIM, NNODE_1D >, oomph::HelmholtzFluxElement< ELEMENT >, oomph::QHelmholtzElement< DIM, NNODE_1D >, oomph::HelmholtzEquations< DIM >, oomph::HelmholtzBCElementBase< ELEMENT >, oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::SolidQElement< 3, NNODE_1D >, oomph::SolidQElement< 2, NNODE_1D >, oomph::SolidQElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::SpectralPeriodicOrbitElement< NNODE_1D >, oomph::SolidQHermiteElement< DIM >, oomph::SolidQHermiteElement< 1 >, oomph::SolidQHermiteElement< 2 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::SolidQHermiteElement< DIM >, oomph::SolidQHermiteElement< 1 >, oomph::SolidQHermiteElement< 2 >, oomph::SolidQHermiteElement< DIM >, oomph::SolidQHermiteElement< 1 >, oomph::SolidQHermiteElement< 2 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::DummyFaceElement< ELEMENT >, oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianTCrouzeixRaviartElement< DIM >, oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement, oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement, oomph::TFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::FourierDecomposedHelmholtzFluxElement< ELEMENT >, oomph::QFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::FourierDecomposedHelmholtzEquations, oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >, oomph::TFoepplvonKarmanElement< NNODE_1D >, oomph::TDisplacementBasedFoepplvonKarmanElement< NNODE_1D >, oomph::QFoepplvonKarmanElement< NNODE_1D >, oomph::FoepplvonKarmanEquations, oomph::DisplacementBasedFoepplvonKarmanEquations, oomph::SurfactantTransportInterfaceElement, oomph::ElasticLineFluidInterfaceBoundingElement< ELEMENT >, oomph::ElasticPointFluidInterfaceBoundingElement< ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >, oomph::SpineLineFluidInterfaceBoundingElement< ELEMENT >, oomph::SpinePointFluidInterfaceBoundingElement< ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< EQUATION_CLASS, DERIVATIVE_CLASS, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, LineDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >, oomph::FluidInterfaceElement, oomph::FluidInterfaceBoundingElement, oomph::DarcyFaceElement< ELEMENT >, oomph::BiharmonicFluidBoundaryElement, oomph::BiharmonicFluxElement< DIM >, oomph::BiharmonicElement< DIM >, oomph::BiharmonicEquations< DIM >, oomph::ClampedSlidingHermiteBeamBoundaryConditionElement, oomph::HermiteBeamElement, oomph::AxisymmetricSolidTractionElement< ELEMENT >, oomph::AxisymQPVDElementWithPressure, oomph::AxisymmetricPVDEquationsWithPressure, oomph::AxisymDiagHermitePVDElement, oomph::AxisymQPVDElement, oomph::AxisymmetricPVDEquations, oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >, oomph::AxisymmetricPoroelasticityTractionElement< POROELASTICITY_BULK_ELEMENT >, oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >, oomph::AxisymmetricTTaylorHoodElement, oomph::AxisymmetricTCrouzeixRaviartElement, oomph::AxisymmetricQTaylorHoodElement, oomph::AxisymmetricQCrouzeixRaviartElement, oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >, oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >, oomph::TAxisymmetricLinearElasticityElement< NNODE_1D >, oomph::FSIAxisymmetricLinearElasticityTractionElement< ELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >, oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >, oomph::QAxisymmetricLinearElasticityElement< NNODE_1D >, oomph::AxisymmetricLinearElasticityEquations, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanEquations, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanEquations, oomph::QGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::GeneralisedAxisymAdvectionDiffusionEquations, oomph::QAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::AxisymAdvectionDiffusionEquations, oomph::TAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::QAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >, oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::QGeneralisedAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::GeneralisedAdvectionDiffusionEquations< DIM >, oomph::QAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::QAdvectionDiffusionElement< DIM, 3 >, and oomph::AdvectionDiffusionEquations< DIM >.

Definition at line 3095 of file elements.h.

◆ output() [4/5]

virtual void oomph::FiniteElement::output ( std::ostream &  outfile)
inlinevirtual

Output the element data — typically the values at the nodes in a format suitable for post-processing.

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QYoungLaplaceElement< NNODE_1D >, oomph::YoungLaplaceEquations, oomph::YoungLaplaceContactAngleElement< ELEMENT >, oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >, oomph::QWomersleyElement< DIM, NNODE_1D >, oomph::WomersleyEquations< DIM >, oomph::TWomersleyElement< DIM, NNODE_1D >, oomph::UnsteadyHeatFluxElement< ELEMENT >, oomph::QUnsteadyHeatElement< DIM, NNODE_1D >, oomph::UnsteadyHeatEquations< DIM >, oomph::TUnsteadyHeatElement< DIM, NNODE_1D >, oomph::TTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >, oomph::QTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::TimeHarmonicLinearElasticityEquations< DIM >, oomph::TimeHarmonicFourierDecomposedLinearElasticityTractionElement< ELEMENT >, oomph::TTimeHarmonicFourierDecomposedLinearElasticityElement< NNODE_1D >, oomph::QTimeHarmonicFourierDecomposedLinearElasticityElement< NNODE_1D >, oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations, oomph::SteadyAxisymAdvectionDiffusionFluxElement< ELEMENT >, oomph::QSteadyAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::SteadyAxisymAdvectionDiffusionEquations, oomph::QSphericalTaylorHoodElement, oomph::QSphericalCrouzeixRaviartElement, oomph::SphericalNavierStokesEquations, oomph::SphericalAdvectionDiffusionFluxElement< ELEMENT >, oomph::QSphericalAdvectionDiffusionElement< NNODE_1D >, oomph::SphericalAdvectionDiffusionEquations, oomph::QUnsteadyHeatMixedOrderSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::QTaylorHoodMixedOrderSpaceTimeElement< DIM >, oomph::QTaylorHoodMixedOrderSpaceTimeElement< 2 >, oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::FpPressureAdvDiffRobinBCMixedOrderSpaceTimeElement< ELEMENT >, oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >, oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >, oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >, oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >, oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >, oomph::SolidTractionElement< ELEMENT >, oomph::TPVDElementWithContinuousPressure< DIM >, oomph::TPVDBubbleEnrichedElement< DIM, NNODE_1D >, oomph::TPVDElement< DIM, NNODE_1D >, oomph::QPVDElementWithContinuousPressure< DIM >, oomph::QPVDElementWithPressure< DIM >, oomph::PVDEquationsWithPressure< DIM >, oomph::HermitePVDElement< DIM >, oomph::QPVDElement< DIM, NNODE_1D >, oomph::PVDEquations< DIM >, oomph::ClampedHermiteShellBoundaryConditionElement, oomph::HermiteShellElement, oomph::KirchhoffLoveShellEquations, oomph::TPoroelasticityElement< ORDER >, oomph::PoroelasticityFaceElement< ELEMENT >, oomph::PoroelasticityEquations< DIM >, oomph::PoroelasticityEquations< 2 >, oomph::PolarStressIntegralElement< ELEMENT >, oomph::PolarTaylorHoodElement, oomph::PolarCrouzeixRaviartElement, oomph::PolarNavierStokesEquations, oomph::PolarNavierStokesTractionElement< ELEMENT >, oomph::TPoissonElement< DIM, NNODE_1D >, oomph::QSpectralPoissonElement< DIM, NNODE_1D >, oomph::PoissonFluxElement< ELEMENT >, oomph::QPoissonElement< DIM, NNODE_1D >, oomph::QPoissonElement< DIM, 2 >, oomph::PoissonEquations< DIM >, oomph::TPMLTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >, oomph::QPMLTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::QPMLTimeHarmonicLinearElasticityElement< 2, NNODE_1D >, oomph::PMLTimeHarmonicLinearElasticityEquations< DIM >, oomph::TPMLHelmholtzElement< DIM, NNODE_1D >, oomph::PMLHelmholtzFluxElement< ELEMENT >, oomph::QPMLHelmholtzElement< DIM, NNODE_1D >, oomph::QPMLHelmholtzElement< 2, NNODE_1D >, oomph::PMLHelmholtzEquations< DIM >, oomph::TPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >, oomph::PMLFourierDecomposedHelmholtzFluxElement< ELEMENT >, oomph::QPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::PMLFourierDecomposedHelmholtzEquations, oomph::TTaylorHoodElement< DIM >, oomph::TCrouzeixRaviartElement< DIM >, oomph::QTaylorHoodElement< DIM >, oomph::QCrouzeixRaviartElement< DIM >, oomph::NavierStokesEquations< DIM >, oomph::FpPressureAdvDiffRobinBCElement< ELEMENT >, oomph::ImposeParallelOutflowElement< ELEMENT >, oomph::ImposeImpenetrabilityElement< ELEMENT >, oomph::NavierStokesTractionElement< ELEMENT >, oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >, oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >, oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, oomph::LinearisedQTaylorHoodElement, oomph::LinearisedQCrouzeixRaviartElement, oomph::LinearisedNavierStokesEquations, oomph::LinearisedAxisymmetricQTaylorHoodElement, oomph::LinearisedAxisymmetricQCrouzeixRaviartElement, oomph::LinearisedAxisymmetricNavierStokesEquations, oomph::LinearWaveFluxElement< ELEMENT >, oomph::QLinearWaveElement< DIM, NNODE_1D >, oomph::LinearWaveEquations< DIM >, oomph::TLinearElasticityElement< DIM, NNODE_1D >, oomph::LinearElasticityTractionElement< ELEMENT >, oomph::QLinearElasticityElement< DIM, NNODE_1D >, oomph::QLinearElasticityElement< DIM, 2 >, oomph::LinearElasticityEquations< DIM >, oomph::THelmholtzElement< DIM, NNODE_1D >, oomph::HelmholtzFluxElement< ELEMENT >, oomph::QHelmholtzElement< DIM, NNODE_1D >, oomph::HelmholtzEquations< DIM >, oomph::HelmholtzBCElementBase< ELEMENT >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::SolidQElement< 3, NNODE_1D >, oomph::SolidQElement< 2, NNODE_1D >, oomph::SolidQElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::SpectralPeriodicOrbitElement< NNODE_1D >, oomph::SolidQHermiteElement< DIM >, oomph::SolidQHermiteElement< 1 >, oomph::SolidQHermiteElement< 2 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::DummyFaceElement< ELEMENT >, oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianTCrouzeixRaviartElement< DIM >, oomph::GeneralisedNewtonianQTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianQCrouzeixRaviartElement< DIM >, oomph::GeneralisedNewtonianNavierStokesEquations< DIM >, oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement, oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement, oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations, oomph::TFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::FourierDecomposedHelmholtzFluxElement< ELEMENT >, oomph::QFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::FourierDecomposedHelmholtzEquations, oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >, oomph::TFoepplvonKarmanElement< NNODE_1D >, oomph::TDisplacementBasedFoepplvonKarmanElement< NNODE_1D >, oomph::QFoepplvonKarmanElement< NNODE_1D >, oomph::FoepplvonKarmanEquations, oomph::DisplacementBasedFoepplvonKarmanEquations, oomph::QScalarAdvectionElement< DIM, NNODE_1D >, oomph::QScalarAdvectionElement< 1, NNODE_1D >, oomph::QScalarAdvectionElement< 2, NNODE_1D >, oomph::QSpectralScalarAdvectionElement< DIM, NNODE_1D >, oomph::QSpectralScalarAdvectionElement< 1, NNODE_1D >, oomph::QSpectralScalarAdvectionElement< 2, NNODE_1D >, oomph::FluxTransportEquations< DIM >, oomph::QSpectralEulerElement< DIM, NNODE_1D >, oomph::QSpectralEulerElement< 1, NNODE_1D >, oomph::QSpectralEulerElement< 2, NNODE_1D >, oomph::EulerEquations< DIM >, oomph::SurfactantTransportInterfaceElement, oomph::ElasticLineFluidInterfaceBoundingElement< ELEMENT >, oomph::ElasticPointFluidInterfaceBoundingElement< ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >, oomph::SpineLineFluidInterfaceBoundingElement< ELEMENT >, oomph::SpinePointFluidInterfaceBoundingElement< ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< EQUATION_CLASS, DERIVATIVE_CLASS, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, LineDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >, oomph::FluidInterfaceElement, oomph::FluidInterfaceBoundingElement, oomph::TRaviartThomasDarcyElement< ORDER >, oomph::DarcyFaceElement< ELEMENT >, oomph::DarcyEquations< DIM >, oomph::DarcyEquations< 2 >, oomph::BiharmonicFluidBoundaryElement, oomph::BiharmonicFluxElement< DIM >, oomph::BiharmonicElement< DIM >, oomph::BiharmonicEquations< DIM >, oomph::ClampedSlidingHermiteBeamBoundaryConditionElement, oomph::HermiteBeamElement, oomph::AxisymmetricSolidTractionElement< ELEMENT >, oomph::AxisymQPVDElementWithPressure, oomph::AxisymmetricPVDEquationsWithPressure, oomph::AxisymDiagHermitePVDElement, oomph::AxisymQPVDElement, oomph::AxisymmetricPVDEquations, oomph::TAxisymmetricPoroelasticityElement< ORDER >, oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >, oomph::AxisymmetricPoroelasticityTractionElement< POROELASTICITY_BULK_ELEMENT >, oomph::AxisymmetricPoroelasticityEquations, oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >, oomph::AxisymmetricTTaylorHoodElement, oomph::AxisymmetricTCrouzeixRaviartElement, oomph::AxisymmetricQTaylorHoodElement, oomph::AxisymmetricQCrouzeixRaviartElement, oomph::AxisymmetricNavierStokesEquations, oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >, oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >, oomph::TAxisymmetricLinearElasticityElement< NNODE_1D >, oomph::FSIAxisymmetricLinearElasticityTractionElement< ELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >, oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >, oomph::QAxisymmetricLinearElasticityElement< NNODE_1D >, oomph::AxisymmetricLinearElasticityEquations, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanEquations, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanEquations, oomph::QGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::GeneralisedAxisymAdvectionDiffusionEquations, oomph::QAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::AxisymAdvectionDiffusionEquations, oomph::TAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::QAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >, oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::QGeneralisedAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::GeneralisedAdvectionDiffusionEquations< DIM >, oomph::AdvectionDiffusionFluxElement< ELEMENT >, oomph::QAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::QAdvectionDiffusionElement< DIM, 3 >, and oomph::AdvectionDiffusionEquations< DIM >.

Definition at line 3050 of file elements.h.

Referenced by oomph::Multi_domain_functions::aux_setup_multi_domain_interaction(), oomph::Mesh::check_inverted_elements(), oomph::Mesh::distribute(), oomph::Mesh::doc_mesh_distribution(), oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >::output(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::output(), oomph::QSpectralElement< 1, NNODE_1D >::output(), oomph::QSpectralElement< 2, NNODE_1D >::output(), oomph::QSpectralElement< 3, NNODE_1D >::output(), oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::PoissonFluxElement< ELEMENT >::output(), oomph::SolidTractionElement< ELEMENT >::output(), oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::AdvectionDiffusionFluxElement< ELEMENT >::output(), oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::output(), oomph::AxisymmetricPVDEquations::output(), oomph::AxisymQPVDElement::output(), oomph::AxisymDiagHermitePVDElement::output(), oomph::AxisymmetricPVDEquationsWithPressure::output(), oomph::AxisymQPVDElementWithPressure::output(), oomph::AxisymmetricSolidTractionElement< ELEMENT >::output(), oomph::ClampedSlidingHermiteBeamBoundaryConditionElement::output(), oomph::BiharmonicEquations< DIM >::output(), oomph::FluidInterfaceBoundingElement::output(), oomph::FluidInterfaceElement::output(), oomph::SpinePointFluidInterfaceBoundingElement< ELEMENT >::output(), oomph::SpineLineFluidInterfaceBoundingElement< ELEMENT >::output(), oomph::ElasticPointFluidInterfaceBoundingElement< ELEMENT >::output(), oomph::ElasticLineFluidInterfaceBoundingElement< ELEMENT >::output(), oomph::SurfactantTransportInterfaceElement::output(), oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >::output(), oomph::FourierDecomposedHelmholtzFluxElement< ELEMENT >::output(), oomph::Mesh::output(), oomph::SpectralPeriodicOrbitElement< NNODE_1D >::output(), oomph::SolidQElement< 1, NNODE_1D >::output(), oomph::SolidQElement< 2, NNODE_1D >::output(), oomph::SolidQElement< 3, NNODE_1D >::output(), oomph::HelmholtzBCElementBase< ELEMENT >::output(), oomph::HelmholtzFluxElement< ELEMENT >::output(), oomph::LinearElasticityTractionElement< ELEMENT >::output(), oomph::LinearWaveFluxElement< ELEMENT >::output(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::output(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::output(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::NavierStokesTractionElement< ELEMENT >::output(), oomph::ImposeImpenetrabilityElement< ELEMENT >::output(), oomph::ImposeParallelOutflowElement< ELEMENT >::output(), oomph::FpPressureAdvDiffRobinBCElement< ELEMENT >::output(), oomph::PMLFourierDecomposedHelmholtzFluxElement< ELEMENT >::output(), oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >::output(), oomph::PMLHelmholtzFluxElement< ELEMENT >::output(), oomph::PolarNavierStokesTractionElement< ELEMENT >::output(), oomph::PolarStressIntegralElement< ELEMENT >::output(), oomph::PoroelasticityFaceElement< ELEMENT >::output(), oomph::KirchhoffLoveShellEquations::output(), oomph::ClampedHermiteShellBoundaryConditionElement::output(), oomph::QPVDElementWithPressure< DIM >::output(), oomph::QPVDElementWithContinuousPressure< DIM >::output(), oomph::TPVDElementWithContinuousPressure< DIM >::output(), oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >::output(), oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >::output(), oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >::output(), oomph::FpPressureAdvDiffRobinBCMixedOrderSpaceTimeElement< ELEMENT >::output(), oomph::SphericalAdvectionDiffusionFluxElement< ELEMENT >::output(), oomph::SteadyAxisymAdvectionDiffusionFluxElement< ELEMENT >::output(), oomph::TimeHarmonicFourierDecomposedLinearElasticityTractionElement< ELEMENT >::output(), oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::output(), oomph::YoungLaplaceContactAngleElement< ELEMENT >::output(), oomph::DummyFaceElement< ELEMENT >::output(), oomph::Mesh::output_external_halo_elements(), oomph::Mesh::output_external_haloed_elements(), oomph::DGElement::output_faces(), oomph::Problem::remove_duplicate_data(), oomph::TetMeshBase::setup_boundary_element_info(), and oomph::TetMeshBase::snap_nodes_onto_geometric_objects().

◆ output() [5/5]

virtual void oomph::FiniteElement::output ( std::ostream &  outfile,
const unsigned &  n_plot 
)
inlinevirtual

Output the element data — pass (some measure of) the number of plot points per element.

Reimplemented in oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >, oomph::WomersleyEquations< DIM >, oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >, oomph::UnsteadyHeatEquations< DIM >, oomph::TTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >, oomph::SteadyAxisymAdvectionDiffusionFluxElement< ELEMENT >, oomph::SteadyAxisymAdvectionDiffusionEquations, oomph::QSphericalTaylorHoodElement, oomph::QSphericalCrouzeixRaviartElement, oomph::SphericalNavierStokesEquations, oomph::SphericalAdvectionDiffusionFluxElement< ELEMENT >, oomph::SphericalAdvectionDiffusionEquations, oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >, oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >, oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::QTaylorHoodMixedOrderSpaceTimeElement< DIM >, oomph::QTaylorHoodMixedOrderSpaceTimeElement< 2 >, oomph::FpPressureAdvDiffRobinBCMixedOrderSpaceTimeElement< ELEMENT >, oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >, oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >, oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::FpPressureAdvDiffRobinBCSpaceTimeElement< ELEMENT >, oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::TPoroelasticityElement< ORDER >, oomph::PoroelasticityEquations< DIM >, oomph::PoroelasticityEquations< 2 >, oomph::PolarStressIntegralElement< ELEMENT >, oomph::PolarTaylorHoodElement, oomph::PolarCrouzeixRaviartElement, oomph::PolarNavierStokesEquations, oomph::PolarNavierStokesTractionElement< ELEMENT >, oomph::PoissonFluxElement< ELEMENT >, oomph::TPMLTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >, oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >, oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >, oomph::TTaylorHoodElement< DIM >, oomph::TCrouzeixRaviartElement< DIM >, oomph::QTaylorHoodElement< DIM >, oomph::QCrouzeixRaviartElement< DIM >, oomph::NavierStokesEquations< DIM >, oomph::FpPressureAdvDiffRobinBCElement< ELEMENT >, oomph::ImposeParallelOutflowElement< ELEMENT >, oomph::ImposeImpenetrabilityElement< ELEMENT >, oomph::NavierStokesTractionElement< ELEMENT >, oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >, oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, oomph::LinearisedNavierStokesEquations, oomph::LinearisedAxisymmetricNavierStokesEquations, oomph::LinearWaveEquations< DIM >, oomph::TLinearElasticityElement< DIM, NNODE_1D >, oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >, oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianTCrouzeixRaviartElement< DIM >, oomph::GeneralisedNewtonianQTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianQCrouzeixRaviartElement< DIM >, oomph::GeneralisedNewtonianNavierStokesEquations< DIM >, oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement, oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations, oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >, oomph::FluxTransportEquations< DIM >, oomph::TRaviartThomasDarcyElement< ORDER >, oomph::ProjectableDarcyElement< DARCY_ELEMENT >, oomph::DarcyEquations< DIM >, oomph::DarcyEquations< 2 >, oomph::BiharmonicEquations< DIM >, oomph::TAxisymmetricPoroelasticityElement< ORDER >, oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >, oomph::AxisymmetricPoroelasticityEquations, oomph::AxisymmetricTTaylorHoodElement, oomph::AxisymmetricTCrouzeixRaviartElement, oomph::AxisymmetricNavierStokesEquations, oomph::TAxisymmetricLinearElasticityElement< NNODE_1D >, oomph::GeneralisedAxisymAdvectionDiffusionEquations, oomph::AxisymAdvectionDiffusionEquations, oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >, oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::GeneralisedAdvectionDiffusionEquations< DIM >, oomph::AdvectionDiffusionFluxElement< ELEMENT >, oomph::AdvectionDiffusionEquations< DIM >, oomph::QYoungLaplaceElement< NNODE_1D >, oomph::YoungLaplaceEquations, oomph::YoungLaplaceContactAngleElement< ELEMENT >, oomph::QWomersleyElement< DIM, NNODE_1D >, oomph::TWomersleyElement< DIM, NNODE_1D >, oomph::UnsteadyHeatFluxElement< ELEMENT >, oomph::QUnsteadyHeatElement< DIM, NNODE_1D >, oomph::TUnsteadyHeatElement< DIM, NNODE_1D >, oomph::QTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::TimeHarmonicLinearElasticityEquations< DIM >, oomph::TimeHarmonicFourierDecomposedLinearElasticityTractionElement< ELEMENT >, oomph::TTimeHarmonicFourierDecomposedLinearElasticityElement< NNODE_1D >, oomph::QTimeHarmonicFourierDecomposedLinearElasticityElement< NNODE_1D >, oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations, oomph::QSteadyAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::QSphericalAdvectionDiffusionElement< NNODE_1D >, oomph::QUnsteadyHeatMixedOrderSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >, oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >, oomph::FSISolidTractionElement< ELEMENT, DIM >, oomph::SolidTractionElement< ELEMENT >, oomph::TPVDElementWithContinuousPressure< DIM >, oomph::TPVDBubbleEnrichedElement< DIM, NNODE_1D >, oomph::TPVDElement< DIM, NNODE_1D >, oomph::QPVDElementWithContinuousPressure< DIM >, oomph::QPVDElementWithPressure< DIM >, oomph::PVDEquationsWithPressure< DIM >, oomph::HermitePVDElement< DIM >, oomph::QPVDElement< DIM, NNODE_1D >, oomph::PVDEquations< DIM >, oomph::ClampedHermiteShellBoundaryConditionElement, oomph::HermiteShellElement, oomph::KirchhoffLoveShellEquations, oomph::PoroelasticityFaceElement< ELEMENT >, oomph::TPoissonElement< DIM, NNODE_1D >, oomph::QSpectralPoissonElement< DIM, NNODE_1D >, oomph::QPoissonElement< DIM, NNODE_1D >, oomph::QPoissonElement< DIM, 2 >, oomph::PoissonEquations< DIM >, oomph::QPMLTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::QPMLTimeHarmonicLinearElasticityElement< 2, NNODE_1D >, oomph::PMLTimeHarmonicLinearElasticityEquations< DIM >, oomph::TPMLHelmholtzElement< DIM, NNODE_1D >, oomph::PMLHelmholtzFluxElement< ELEMENT >, oomph::QPMLHelmholtzElement< DIM, NNODE_1D >, oomph::QPMLHelmholtzElement< 2, NNODE_1D >, oomph::PMLHelmholtzEquations< DIM >, oomph::TPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >, oomph::PMLFourierDecomposedHelmholtzFluxElement< ELEMENT >, oomph::QPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::PMLFourierDecomposedHelmholtzEquations, oomph::NavierStokesSurfaceDragTorqueElement< ELEMENT >, oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >, oomph::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >, oomph::LinearisedQTaylorHoodElement, oomph::LinearisedQCrouzeixRaviartElement, oomph::LinearisedAxisymmetricQTaylorHoodElement, oomph::LinearisedAxisymmetricQCrouzeixRaviartElement, oomph::LinearWaveFluxElement< ELEMENT >, oomph::QLinearWaveElement< DIM, NNODE_1D >, oomph::LinearElasticityTractionElement< ELEMENT >, oomph::QLinearElasticityElement< DIM, NNODE_1D >, oomph::QLinearElasticityElement< DIM, 2 >, oomph::LinearElasticityEquations< DIM >, oomph::THelmholtzElement< DIM, NNODE_1D >, oomph::HelmholtzFluxElement< ELEMENT >, oomph::QHelmholtzElement< DIM, NNODE_1D >, oomph::HelmholtzEquations< DIM >, oomph::HelmholtzBCElementBase< ELEMENT >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::SolidQElement< 3, NNODE_1D >, oomph::SolidQElement< 2, NNODE_1D >, oomph::SolidQElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::SpectralPeriodicOrbitElement< NNODE_1D >, oomph::SolidQHermiteElement< DIM >, oomph::SolidQHermiteElement< 1 >, oomph::SolidQHermiteElement< 2 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::SolidQHermiteElement< DIM >, oomph::SolidQHermiteElement< 1 >, oomph::SolidQHermiteElement< 2 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::DummyFaceElement< ELEMENT >, oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement, oomph::TFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::FourierDecomposedHelmholtzFluxElement< ELEMENT >, oomph::QFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::FourierDecomposedHelmholtzEquations, oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >, oomph::TFoepplvonKarmanElement< NNODE_1D >, oomph::TDisplacementBasedFoepplvonKarmanElement< NNODE_1D >, oomph::QFoepplvonKarmanElement< NNODE_1D >, oomph::FoepplvonKarmanEquations, oomph::DisplacementBasedFoepplvonKarmanEquations, oomph::QScalarAdvectionElement< DIM, NNODE_1D >, oomph::QScalarAdvectionElement< 1, NNODE_1D >, oomph::QScalarAdvectionElement< 2, NNODE_1D >, oomph::QSpectralScalarAdvectionElement< DIM, NNODE_1D >, oomph::QSpectralScalarAdvectionElement< 1, NNODE_1D >, oomph::QSpectralScalarAdvectionElement< 2, NNODE_1D >, oomph::QSpectralEulerElement< DIM, NNODE_1D >, oomph::QSpectralEulerElement< 1, NNODE_1D >, oomph::QSpectralEulerElement< 2, NNODE_1D >, oomph::EulerEquations< DIM >, oomph::SurfactantTransportInterfaceElement, oomph::ElasticLineFluidInterfaceBoundingElement< ELEMENT >, oomph::ElasticPointFluidInterfaceBoundingElement< ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >, oomph::SpineLineFluidInterfaceBoundingElement< ELEMENT >, oomph::SpinePointFluidInterfaceBoundingElement< ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< EQUATION_CLASS, DERIVATIVE_CLASS, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, LineDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >, oomph::FluidInterfaceElement, oomph::FluidInterfaceBoundingElement, oomph::DarcyFaceElement< ELEMENT >, oomph::BiharmonicFluidBoundaryElement, oomph::BiharmonicFluxElement< DIM >, oomph::BiharmonicElement< DIM >, oomph::ClampedSlidingHermiteBeamBoundaryConditionElement, oomph::HermiteBeamElement, oomph::AxisymmetricSolidTractionElement< ELEMENT >, oomph::AxisymQPVDElementWithPressure, oomph::AxisymmetricPVDEquationsWithPressure, oomph::AxisymDiagHermitePVDElement, oomph::AxisymQPVDElement, oomph::AxisymmetricPVDEquations, oomph::FSILinearisedAxisymPoroelasticTractionElement< POROELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >, oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >, oomph::AxisymmetricPoroelasticityTractionElement< POROELASTICITY_BULK_ELEMENT >, oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >, oomph::AxisymmetricQTaylorHoodElement, oomph::AxisymmetricQCrouzeixRaviartElement, oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >, oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >, oomph::FSIAxisymmetricLinearElasticityTractionElement< ELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >, oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >, oomph::QAxisymmetricLinearElasticityElement< NNODE_1D >, oomph::AxisymmetricLinearElasticityEquations, oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanEquations, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanEquations, oomph::QGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::QAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::TAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::QAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::QGeneralisedAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::QAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::QAdvectionDiffusionElement< DIM, 3 >, oomph::SolidQHermiteElement< DIM >, oomph::SolidQHermiteElement< 1 >, and oomph::SolidQHermiteElement< 2 >.

Definition at line 3060 of file elements.h.

◆ output_fct() [1/3]

virtual void oomph::FiniteElement::output_fct ( std::ostream &  outfile,
const unsigned &  n_plot,
const double &  time,
const SolutionFunctorBase exact_soln 
) const
inlinevirtual

Output a time-dependent exact solution over the element.

Definition at line 3130 of file elements.h.

◆ output_fct() [2/3]

virtual void oomph::FiniteElement::output_fct ( std::ostream &  outfile,
const unsigned &  n_plot,
const double &  time,
FiniteElement::UnsteadyExactSolutionFctPt  exact_soln_pt 
)
inlinevirtual

Output a time-dependent exact solution over the element.

Reimplemented in oomph::WomersleyEquations< DIM >, oomph::UnsteadyHeatEquations< DIM >, oomph::SphericalNavierStokesEquations, oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::PoroelasticityEquations< DIM >, oomph::PoroelasticityEquations< 2 >, oomph::PolarNavierStokesEquations, oomph::NavierStokesEquations< DIM >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, oomph::LinearWaveEquations< DIM >, oomph::LinearElasticityEquations< DIM >, oomph::GeneralisedNewtonianNavierStokesEquations< DIM >, oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations, oomph::BiharmonicElement< DIM >, oomph::BiharmonicEquations< DIM >, oomph::AxisymmetricPoroelasticityEquations, oomph::AxisymmetricNavierStokesEquations, oomph::AxisymmetricLinearElasticityEquations, oomph::GeneralisedAxisymAdvectionDiffusionEquations, oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >, oomph::GeneralisedAdvectionDiffusionEquations< DIM >, oomph::AdvectionDiffusionEquations< DIM >, oomph::QYoungLaplaceElement< NNODE_1D >, oomph::YoungLaplaceEquations, oomph::QWomersleyElement< DIM, NNODE_1D >, oomph::TWomersleyElement< DIM, NNODE_1D >, oomph::QUnsteadyHeatElement< DIM, NNODE_1D >, oomph::TUnsteadyHeatElement< DIM, NNODE_1D >, oomph::QUnsteadyHeatMixedOrderSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::TPoissonElement< DIM, NNODE_1D >, oomph::QSpectralPoissonElement< DIM, NNODE_1D >, oomph::QPoissonElement< DIM, NNODE_1D >, oomph::QPoissonElement< DIM, 2 >, oomph::PoissonEquations< DIM >, oomph::TPMLHelmholtzElement< DIM, NNODE_1D >, oomph::QPMLHelmholtzElement< DIM, NNODE_1D >, oomph::QPMLHelmholtzElement< 2, NNODE_1D >, oomph::PMLHelmholtzEquations< DIM >, oomph::TPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::QPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::PMLFourierDecomposedHelmholtzEquations, oomph::QLinearWaveElement< DIM, NNODE_1D >, oomph::THelmholtzElement< DIM, NNODE_1D >, oomph::QHelmholtzElement< DIM, NNODE_1D >, oomph::HelmholtzEquations< DIM >, oomph::TFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::QFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::FourierDecomposedHelmholtzEquations, oomph::TFoepplvonKarmanElement< NNODE_1D >, oomph::TDisplacementBasedFoepplvonKarmanElement< NNODE_1D >, oomph::QFoepplvonKarmanElement< NNODE_1D >, oomph::FoepplvonKarmanEquations, oomph::DisplacementBasedFoepplvonKarmanEquations, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanEquations, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanEquations, oomph::QGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::TAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::QAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::QGeneralisedAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::QAdvectionDiffusionElement< DIM, NNODE_1D >, and oomph::QAdvectionDiffusionElement< DIM, 3 >.

Definition at line 3117 of file elements.h.

◆ output_fct() [3/3]

virtual void oomph::FiniteElement::output_fct ( std::ostream &  outfile,
const unsigned &  n_plot,
FiniteElement::SteadyExactSolutionFctPt  exact_soln_pt 
)
inlinevirtual

Output an exact solution over the element.

Reimplemented in oomph::WomersleyEquations< DIM >, oomph::UnsteadyHeatEquations< DIM >, oomph::TimeHarmonicLinearElasticityEquations< DIM >, oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations, oomph::SteadyAxisymAdvectionDiffusionEquations, oomph::SphericalNavierStokesEquations, oomph::SphericalAdvectionDiffusionEquations, oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::SpaceTimeNavierStokesEquations< DIM >, oomph::PoroelasticityEquations< DIM >, oomph::PoroelasticityEquations< 2 >, oomph::PolarNavierStokesEquations, oomph::PMLTimeHarmonicLinearElasticityEquations< DIM >, oomph::NavierStokesEquations< DIM >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, oomph::LinearWaveEquations< DIM >, oomph::QLinearElasticityElement< DIM, NNODE_1D >, oomph::QLinearElasticityElement< DIM, 2 >, oomph::LinearElasticityEquations< DIM >, oomph::GeneralisedNewtonianNavierStokesEquations< DIM >, oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations, oomph::DarcyEquations< DIM >, oomph::DarcyEquations< 2 >, oomph::BiharmonicFluxElement< DIM >, oomph::BiharmonicElement< DIM >, oomph::BiharmonicEquations< DIM >, oomph::AxisymmetricPoroelasticityEquations, oomph::AxisymmetricNavierStokesEquations, oomph::AxisymmetricLinearElasticityEquations, oomph::GeneralisedAxisymAdvectionDiffusionEquations, oomph::AxisymAdvectionDiffusionEquations, oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >, oomph::GeneralisedAdvectionDiffusionEquations< DIM >, oomph::AdvectionDiffusionEquations< DIM >, oomph::QYoungLaplaceElement< NNODE_1D >, oomph::YoungLaplaceEquations, oomph::QWomersleyElement< DIM, NNODE_1D >, oomph::TWomersleyElement< DIM, NNODE_1D >, oomph::QUnsteadyHeatElement< DIM, NNODE_1D >, oomph::TUnsteadyHeatElement< DIM, NNODE_1D >, oomph::QSteadyAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::QSphericalAdvectionDiffusionElement< NNODE_1D >, oomph::QUnsteadyHeatMixedOrderSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::TPoissonElement< DIM, NNODE_1D >, oomph::QSpectralPoissonElement< DIM, NNODE_1D >, oomph::QPoissonElement< DIM, NNODE_1D >, oomph::QPoissonElement< DIM, 2 >, oomph::PoissonEquations< DIM >, oomph::TPMLHelmholtzElement< DIM, NNODE_1D >, oomph::QPMLHelmholtzElement< DIM, NNODE_1D >, oomph::QPMLHelmholtzElement< 2, NNODE_1D >, oomph::PMLHelmholtzEquations< DIM >, oomph::TPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::QPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::PMLFourierDecomposedHelmholtzEquations, oomph::QLinearWaveElement< DIM, NNODE_1D >, oomph::THelmholtzElement< DIM, NNODE_1D >, oomph::QHelmholtzElement< DIM, NNODE_1D >, oomph::HelmholtzEquations< DIM >, oomph::TFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::QFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::FourierDecomposedHelmholtzEquations, oomph::TFoepplvonKarmanElement< NNODE_1D >, oomph::TDisplacementBasedFoepplvonKarmanElement< NNODE_1D >, oomph::QFoepplvonKarmanElement< NNODE_1D >, oomph::FoepplvonKarmanEquations, oomph::DisplacementBasedFoepplvonKarmanEquations, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanEquations, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanEquations, oomph::QGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::QAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::TAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::QAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::QGeneralisedAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::QAdvectionDiffusionElement< DIM, NNODE_1D >, and oomph::QAdvectionDiffusionElement< DIM, 3 >.

Definition at line 3104 of file elements.h.

Referenced by oomph::Mesh::output_fct(), oomph::BiharmonicEquations< DIM >::output_fct(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::output_fct(), and oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::output_fct().

◆ output_paraview()

void oomph::FiniteElement::output_paraview ( std::ofstream &  file_out,
const unsigned &  nplot 
) const
inline

Paraview output – this outputs the coordinates at the plot points (for parameter nplot) to specified output file.

Definition at line 2889 of file elements.h.

References get_s_plot(), i, interpolated_x(), oomph::Node::ndim(), nnode(), node_pt(), nplot_points_paraview(), and s.

Referenced by oomph::Mesh::output_fct_paraview(), and oomph::Mesh::output_paraview().

◆ point_output()

void oomph::FiniteElement::point_output ( std::ostream &  outfile,
const Vector< double > &  s 
)
inline

Output solution (as defined by point_output_data()) at local cordinates s.

Definition at line 2845 of file elements.h.

References i, and point_output_data().

◆ point_output_data()

virtual void oomph::FiniteElement::point_output_data ( const Vector< double > &  s,
Vector< double > &  data 
)
inlinevirtual

◆ position() [1/2]

void oomph::FiniteElement::position ( const unsigned &  t,
const Vector< double > &  zeta,
Vector< double > &  r 
) const
inlinevirtual

Return the parametrised position of the FiniteElement in its GeomObject incarnation: r(zeta). The position is given by the Eulerian coordinate and the intrinsic coordinate (zeta) is the local coordinate of the element (s) This version of the function returns the position as a function of time t=0: current time; t>0: previous timestep. Works for t=0 but needs to be overloaded if genuine time-dependence is required.

Reimplemented from oomph::GeomObject.

Definition at line 2689 of file elements.h.

References interpolated_x().

◆ position() [2/2]

void oomph::FiniteElement::position ( const Vector< double > &  zeta,
Vector< double > &  r 
) const
inlinevirtual

Return the parametrised position of the FiniteElement in its incarnation as a GeomObject, r(zeta). The position is given by the Eulerian coordinate and the intrinsic coordinate (zeta) is the local coordinate of the element (s).

Implements oomph::GeomObject.

Reimplemented in oomph::YoungLaplaceEquations.

Definition at line 2676 of file elements.h.

References interpolated_x().

◆ raw_dnodal_position_dt() [1/2]

double oomph::FiniteElement::raw_dnodal_position_dt ( const unsigned &  n,
const unsigned &  i 
) const
inline

◆ raw_dnodal_position_dt() [2/2]

double oomph::FiniteElement::raw_dnodal_position_dt ( const unsigned &  n,
const unsigned &  j,
const unsigned &  i 
) const
inline

Return the i-th component of j-th derivative of nodal position: d^jx/dt^j at node n. Do not use the hanging node representation.

Definition at line 2263 of file elements.h.

References oomph::Node::dx_dt(), i, and node_pt().

◆ raw_dnodal_position_gen_dt() [1/2]

double oomph::FiniteElement::raw_dnodal_position_gen_dt ( const unsigned &  j,
const unsigned &  n,
const unsigned &  k,
const unsigned &  i 
) const
inline

i-th component of j-th time derivative of the generalised position, dx(k,i)/dt at local node n. ‘Type’: k; Coordinate direction: i. Do not use the hanging node representation.

Definition at line 2305 of file elements.h.

References oomph::Node::dx_gen_dt(), i, and node_pt().

◆ raw_dnodal_position_gen_dt() [2/2]

double oomph::FiniteElement::raw_dnodal_position_gen_dt ( const unsigned &  n,
const unsigned &  k,
const unsigned &  i 
) const
inline

i-th component of time derivative (velocity) of the generalised position, dx(k,i)/dt at local node n. ‘Type’: k; Coordinate direction: i. Do not use the hanging node representation.

Definition at line 2294 of file elements.h.

References oomph::Node::dx_gen_dt(), i, and node_pt().

Referenced by oomph::KirchhoffLoveBeamEquations::fill_in_contribution_to_residuals_beam(), oomph::KirchhoffLoveShellEquations::fill_in_contribution_to_residuals_shell(), oomph::KirchhoffLoveBeamEquations::get_energy(), oomph::KirchhoffLoveShellEquations::get_strain_and_bend(), and oomph::HermiteBeamElement::output().

◆ raw_nodal_position() [1/2]

double oomph::FiniteElement::raw_nodal_position ( const unsigned &  n,
const unsigned &  i 
) const

Return the i-th coordinate at local node n. Do not use the hanging node representation. NOTE: Moved to cc file because of a possible compiler bug in gcc (yes, really!). The move to the cc file avoids inlining which appears to cause problems (only) when compiled with gcc and -O3; offensive "illegal read" is in optimised-out section of code and data that is allegedly illegal is readily readable (by other means) just before this function is called so I can't really see how we could possibly be responsible for this...

////////////////////////////////////////////////////////////////////////

//////////////////////////////////////////////////////////////////////// Return the i-th coordinate at local node n. Do not use the hanging node representation. NOTE: Moved to cc file because of a possible compiler bug in gcc (yes, really!). The move to the cc file avoids inlining which appears to cause problems (only) when compiled with gcc and -O3; offensive "illegal read" is in optimised-out section of code and data that is allegedly illegal is readily readable (by other means) just before this function is called so I can't really see how we could possibly be responsible for this...

Definition at line 1686 of file elements.cc.

References i, node_pt(), and oomph::Node::x().

Referenced by oomph::AxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::AxisymFoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::FoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::AxisymmetricLinearElasticityEquations::fill_in_generic_contribution_to_residuals_axisymmetric_linear_elasticity(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::fill_in_generic_contribution_to_residuals_fourier_decomp_time_harmonic_linear_elasticity(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::SteadyAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_adv_diff(), oomph::AxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::FourierDecomposedHelmholtzEquations::fill_in_generic_residual_contribution_fourier_decomposed_helmholtz(), oomph::LinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::LinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::PeriodicOrbitEquations::fill_in_generic_residual_contribution_orbit(), oomph::PMLFourierDecomposedHelmholtzEquations::fill_in_generic_residual_contribution_pml_fourier_decomposed_helmholtz(), oomph::SphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::SphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::AxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::AxisymmetricLinearElasticityEquations::get_strain(), oomph::AxisymFoepplvonKarmanEquations::interpolated_stress(), and oomph::PeriodicOrbitEquations::orbit_output().

◆ raw_nodal_position() [2/2]

double oomph::FiniteElement::raw_nodal_position ( const unsigned &  t,
const unsigned &  n,
const unsigned &  i 
) const
inline

Return the i-th coordinate at local node n, at time level t (t=0: present; t>0: previous time level). Do not use the hanging node representation.

Definition at line 2247 of file elements.h.

References i, node_pt(), t, and oomph::Node::x().

◆ raw_nodal_position_gen() [1/2]

double oomph::FiniteElement::raw_nodal_position_gen ( const unsigned &  n,
const unsigned &  k,
const unsigned &  i 
) const
inline

◆ raw_nodal_position_gen() [2/2]

double oomph::FiniteElement::raw_nodal_position_gen ( const unsigned &  t,
const unsigned &  n,
const unsigned &  k,
const unsigned &  i 
) const
inline

Return the generalised nodal position (type k, i-th variable) at previous timesteps at local node n. Do not use the hanging node representation.

Definition at line 2282 of file elements.h.

References i, node_pt(), t, and oomph::Node::x_gen().

◆ raw_nodal_value() [1/2]

double oomph::FiniteElement::raw_nodal_value ( const unsigned &  n,
const unsigned &  i 
) const
inline

Return the i-th value stored at local node n but do NOT take hanging nodes into account.

Definition at line 2576 of file elements.h.

References i, node_pt(), and oomph::Node::raw_value().

Referenced by oomph::AxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::AxisymFoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::FoepplvonKarmanEquations::fill_in_contribution_to_residuals(), oomph::AxisymmetricLinearElasticityEquations::fill_in_generic_contribution_to_residuals_axisymmetric_linear_elasticity(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::fill_in_generic_contribution_to_residuals_fourier_decomp_time_harmonic_linear_elasticity(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::AxisymmetricPoroelasticityEquations::fill_in_generic_residual_contribution(), oomph::SteadyAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_adv_diff(), oomph::AxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_axi_adv_diff(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::FourierDecomposedHelmholtzEquations::fill_in_generic_residual_contribution_fourier_decomposed_helmholtz(), oomph::LinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_linearised_axi_nst(), oomph::LinearisedNavierStokesEquations::fill_in_generic_residual_contribution_linearised_nst(), oomph::PMLFourierDecomposedHelmholtzEquations::fill_in_generic_residual_contribution_pml_fourier_decomposed_helmholtz(), oomph::SphericalAdvectionDiffusionEquations::fill_in_generic_residual_contribution_spherical_adv_diff(), oomph::SphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::FoepplvonKarmanEquations::get_bounded_volume(), oomph::AxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::AxisymmetricLinearElasticityEquations::get_strain(), oomph::AxisymFoepplvonKarmanEquations::interpolated_stress(), oomph::FoepplvonKarmanEquations::interpolated_stress(), and oomph::LinearisedNavierStokesEquations::strain_rate().

◆ raw_nodal_value() [2/2]

double oomph::FiniteElement::raw_nodal_value ( const unsigned &  t,
const unsigned &  n,
const unsigned &  i 
) const
inline

Return the i-th value stored at local node n, at time level t (t=0: present; t>0 previous timesteps), but do NOT take hanging nodes into account.

Definition at line 2584 of file elements.h.

References i, node_pt(), oomph::Node::raw_value(), and t.

◆ required_nvalue()

virtual unsigned oomph::FiniteElement::required_nvalue ( const unsigned &  n) const
inlinevirtual

Number of values that must be stored at local node n by the element. The default is 0, until over-ridden by a particular element. For example, a Poisson equation requires only one value to be stored at each node; 2D Navier–Stokes equations require two values (velocity components) to be stored at each Node (provided that the pressure interpolation is discontinuous).

Reimplemented in oomph::PoroelasticityEquations< 2 >, oomph::DarcyEquations< 2 >, oomph::PoroelasticityEquations< DIM >, oomph::DarcyEquations< DIM >, oomph::AxisymmetricPoroelasticityEquations, oomph::QYoungLaplaceElement< NNODE_1D >, oomph::QWomersleyElement< DIM, NNODE_1D >, oomph::TWomersleyElement< DIM, NNODE_1D >, oomph::QUnsteadyHeatElement< DIM, NNODE_1D >, oomph::TUnsteadyHeatElement< DIM, NNODE_1D >, oomph::TimeHarmonicLinearElasticityEquations< DIM >, oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations, oomph::QSteadyAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::QSphericalTaylorHoodElement, oomph::QSphericalCrouzeixRaviartElement, oomph::RefineableQSphericalTaylorHoodElement, oomph::QSphericalAdvectionDiffusionElement< NNODE_1D >, oomph::QUnsteadyHeatMixedOrderSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::QUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >, oomph::QTaylorHoodMixedOrderSpaceTimeElement< DIM >, oomph::QTaylorHoodMixedOrderSpaceTimeElement< 2 >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >, oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >, oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::QTaylorHoodSpaceTimeElement< DIM >, oomph::QTaylorHoodSpaceTimeElement< 2 >, oomph::TPVDElementWithContinuousPressure< DIM >, oomph::QPVDElementWithContinuousPressure< DIM >, oomph::RefineableQPVDElementWithContinuousPressure< DIM >, oomph::TPoroelasticityElement< ORDER >, oomph::RefineablePolarTaylorHoodElement, oomph::PolarTaylorHoodElement, oomph::PolarCrouzeixRaviartElement, oomph::TPoissonElement< DIM, NNODE_1D >, oomph::QSpectralPoissonElement< DIM, NNODE_1D >, oomph::QPoissonElement< DIM, NNODE_1D >, oomph::QPoissonElement< DIM, 2 >, oomph::PMLTimeHarmonicLinearElasticityEquations< DIM >, oomph::TPMLHelmholtzElement< DIM, NNODE_1D >, oomph::QPMLHelmholtzElement< DIM, NNODE_1D >, oomph::QPMLHelmholtzElement< 2, NNODE_1D >, oomph::TPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::QPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::TTaylorHoodElement< DIM >, oomph::TCrouzeixRaviartElement< DIM >, oomph::PRefineableQCrouzeixRaviartElement< DIM >, oomph::RefineableQTaylorHoodElement< DIM >, oomph::QTaylorHoodElement< DIM >, oomph::QCrouzeixRaviartElement< DIM >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::BuoyantQCrouzeixRaviartElement< DIM >, oomph::RefineableLinearisedQTaylorHoodElement, oomph::LinearisedQTaylorHoodElement, oomph::LinearisedQCrouzeixRaviartElement, oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement, oomph::LinearisedAxisymmetricQTaylorHoodElement, oomph::LinearisedAxisymmetricQCrouzeixRaviartElement, oomph::QLinearWaveElement< DIM, NNODE_1D >, oomph::LinearElasticityEquations< DIM >, oomph::THelmholtzElement< DIM, NNODE_1D >, oomph::QHelmholtzElement< DIM, NNODE_1D >, oomph::SpectralPeriodicOrbitElement< NNODE_1D >, oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianTCrouzeixRaviartElement< DIM >, oomph::PRefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >, oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianQTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianQCrouzeixRaviartElement< DIM >, oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement, oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricQTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement, oomph::TFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::QFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::TFoepplvonKarmanElement< NNODE_1D >, oomph::TDisplacementBasedFoepplvonKarmanElement< NNODE_1D >, oomph::QFoepplvonKarmanElement< NNODE_1D >, oomph::QScalarAdvectionElement< DIM, NNODE_1D >, oomph::QScalarAdvectionElement< 1, NNODE_1D >, oomph::QScalarAdvectionElement< 2, NNODE_1D >, oomph::QSpectralScalarAdvectionElement< DIM, NNODE_1D >, oomph::QSpectralScalarAdvectionElement< 1, NNODE_1D >, oomph::QSpectralScalarAdvectionElement< 2, NNODE_1D >, oomph::ScalarAdvectionEquations< DIM >, oomph::EulerEquations< DIM >, oomph::TRaviartThomasDarcyElement< ORDER >, oomph::ProjectableDarcyElement< DARCY_ELEMENT >, oomph::BiharmonicElement< DIM >, oomph::TAxisymmetricPoroelasticityElement< ORDER >, oomph::AxisymmetricTTaylorHoodElement, oomph::AxisymmetricTCrouzeixRaviartElement, oomph::RefineableAxisymmetricQTaylorHoodElement, oomph::AxisymmetricQTaylorHoodElement, oomph::AxisymmetricQCrouzeixRaviartElement, oomph::AxisymmetricLinearElasticityEquations, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::AxisymFoepplvonKarmanElement< NNODE_1D >, oomph::QGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::QAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::TAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::QAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::QGeneralisedAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::QAdvectionDiffusionElement< DIM, NNODE_1D >, and oomph::QAdvectionDiffusionElement< DIM, 3 >.

Definition at line 2455 of file elements.h.

References Default_Initial_Nvalue.

Referenced by oomph::GeneralisedElement::assign_local_eqn_numbers(), build_face_element(), oomph::ElementWithSpecificMovingNodes< ELEMENT, NODE_TYPE >::construct_boundary_node(), construct_boundary_node(), oomph::SolidFiniteElement::construct_boundary_node(), oomph::ElementWithSpecificMovingNodes< ELEMENT, NODE_TYPE >::construct_node(), construct_node(), oomph::SolidFiniteElement::construct_node(), and oomph::BiharmonicEquations< DIM >::ndof_types().

◆ reset_after_nodal_fd()

virtual void oomph::FiniteElement::reset_after_nodal_fd ( )
inlineprotectedvirtual

Function that is call after the finite differencing of the nodal data. This may be overloaded to reset any dependent variables that may have changed during the finite differencing.

Reimplemented in oomph::FSIWallElement.

Definition at line 1714 of file elements.h.

Referenced by fill_in_jacobian_from_nodal_by_fd(), and oomph::RefineableElement::fill_in_jacobian_from_nodal_by_fd().

◆ reset_in_nodal_fd()

virtual void oomph::FiniteElement::reset_in_nodal_fd ( const unsigned &  i)
inlineprotectedvirtual

Function called within the finite difference loop for nodal data after the i-th nodal values is reset. The default behaviour is to call the update function.

Reimplemented in oomph::FSIWallElement.

Definition at line 1723 of file elements.h.

References i, and update_in_nodal_fd().

Referenced by fill_in_jacobian_from_nodal_by_fd(), and oomph::RefineableElement::fill_in_jacobian_from_nodal_by_fd().

◆ s_max()

virtual double oomph::FiniteElement::s_max ( ) const
inlinevirtual

◆ s_min()

virtual double oomph::FiniteElement::s_min ( ) const
inlinevirtual

◆ scalar_name_paraview()

virtual std::string oomph::FiniteElement::scalar_name_paraview ( const unsigned &  i) const
inlinevirtual

◆ scalar_value_fct_paraview() [1/2]

virtual void oomph::FiniteElement::scalar_value_fct_paraview ( std::ofstream &  file_out,
const unsigned &  i,
const unsigned &  nplot,
const double &  time,
FiniteElement::UnsteadyExactSolutionFctPt  exact_soln_pt 
) const
inlinevirtual

◆ scalar_value_fct_paraview() [2/2]

virtual void oomph::FiniteElement::scalar_value_fct_paraview ( std::ofstream &  file_out,
const unsigned &  i,
const unsigned &  nplot,
FiniteElement::SteadyExactSolutionFctPt  exact_soln_pt 
) const
inlinevirtual

Write values of the i-th scalar field at the plot points. Broken virtual. Needs to be implemented for each new specific element type.

Reimplemented in oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::PoissonEquations< DIM >, and oomph::PMLHelmholtzEquations< DIM >.

Definition at line 3013 of file elements.h.

Referenced by oomph::Mesh::output_fct_paraview().

◆ scalar_value_paraview()

virtual void oomph::FiniteElement::scalar_value_paraview ( std::ofstream &  file_out,
const unsigned &  i,
const unsigned &  nplot 
) const
inlinevirtual

◆ self_test()

unsigned oomph::FiniteElement::self_test ( )
virtual

Self-test: Check inversion of element & do self-test for GeneralisedElement. Return 0 if OK.

Self-test: Have all internal values been classified as pinned/unpinned? Has pointer to spatial integration scheme been set? Return 0 if OK.

Reimplemented from oomph::GeneralisedElement.

Reimplemented in oomph::YoungLaplaceEquations, oomph::WomersleyEquations< DIM >, oomph::UnsteadyHeatEquations< DIM >, oomph::SteadyAxisymAdvectionDiffusionEquations, oomph::SphericalAdvectionDiffusionEquations, oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >, oomph::PoroelasticityEquations< DIM >, oomph::PoroelasticityEquations< 2 >, oomph::PoissonEquations< DIM >, oomph::PMLHelmholtzEquations< DIM >, oomph::PMLFourierDecomposedHelmholtzEquations, oomph::LinearWaveEquations< DIM >, oomph::HelmholtzEquations< DIM >, oomph::FourierDecomposedHelmholtzEquations, oomph::FoepplvonKarmanEquations, oomph::DisplacementBasedFoepplvonKarmanEquations, oomph::DarcyEquations< DIM >, oomph::DarcyEquations< 2 >, oomph::BiharmonicEquations< DIM >, oomph::AxisymmetricPoroelasticityEquations, oomph::AxisymFoepplvonKarmanEquations, oomph::AxisymFoepplvonKarmanEquations, oomph::GeneralisedAxisymAdvectionDiffusionEquations, oomph::AxisymAdvectionDiffusionEquations, oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >, oomph::GeneralisedAdvectionDiffusionEquations< DIM >, and oomph::AdvectionDiffusionEquations< DIM >.

Definition at line 4440 of file elements.cc.

References Accept_negative_jacobian, dim(), dshape_eulerian_at_knot(), i, integral_pt(), J_eulerian(), oomph::Integral::knot(), nnodal_position_type(), nnode(), oomph::Integral::nweight(), s, and oomph::GeneralisedElement::self_test().

Referenced by oomph::AdvectionDiffusionEquations< DIM >::self_test(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::self_test(), oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >::self_test(), oomph::AxisymAdvectionDiffusionEquations::self_test(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::self_test(), oomph::AxisymFoepplvonKarmanEquations::self_test(), oomph::BiharmonicEquations< DIM >::self_test(), oomph::DisplacementBasedFoepplvonKarmanEquations::self_test(), oomph::FoepplvonKarmanEquations::self_test(), oomph::FourierDecomposedHelmholtzEquations::self_test(), oomph::HelmholtzEquations< DIM >::self_test(), oomph::LinearWaveEquations< DIM >::self_test(), oomph::PMLFourierDecomposedHelmholtzEquations::self_test(), oomph::PMLHelmholtzEquations< DIM >::self_test(), oomph::PoissonEquations< DIM >::self_test(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::self_test(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::self_test(), oomph::SphericalAdvectionDiffusionEquations::self_test(), oomph::SteadyAxisymAdvectionDiffusionEquations::self_test(), oomph::UnsteadyHeatEquations< DIM >::self_test(), oomph::WomersleyEquations< DIM >::self_test(), and oomph::YoungLaplaceEquations::self_test().

◆ set_dimension()

void oomph::FiniteElement::set_dimension ( const unsigned &  dim)
inline

Set the dimension of the element and initially set the dimension of the nodes to be the same as the dimension of the element.

Definition at line 1380 of file elements.h.

References dim(), Elemental_dimension, and Nodal_dimension.

Referenced by oomph::QHermiteElement< DIM >::QHermiteElement().

◆ set_integration_scheme()

void oomph::FiniteElement::set_integration_scheme ( Integral *const &  integral_pt)
virtual

◆ set_macro_elem_pt()

virtual void oomph::FiniteElement::set_macro_elem_pt ( MacroElement macro_elem_pt)
inlinevirtual

◆ set_n_node()

void oomph::FiniteElement::set_n_node ( const unsigned &  n)
inline

Set the number of nodes in the element to n, by resizing the storage for pointers to the Node objects.

Definition at line 1404 of file elements.h.

References i, Nnode, and Node_pt.

Referenced by oomph::PointElement::PointElement(), and oomph::QHermiteElement< DIM >::QHermiteElement().

◆ set_nnodal_position_type()

void oomph::FiniteElement::set_nnodal_position_type ( const unsigned &  nposition_type)
inline

◆ set_nodal_dimension()

void oomph::FiniteElement::set_nodal_dimension ( const unsigned &  nodal_dim)
inline

◆ shape()

virtual void oomph::FiniteElement::shape ( const Vector< double > &  s,
Shape psi 
) const
pure virtual

Calculate the geometric shape functions at local coordinate s. This function must be overloaded for each specific geometric element.

Implemented in oomph::ClampedHermiteShellBoundaryConditionElement, oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >, oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >, oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, and oomph::PointElement.

Referenced by oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::add_element_contribution_to_aux_integral(), oomph::AdvectionDiffusionEquations< DIM >::dinterpolated_u_adv_diff_ddata(), oomph::RefineableAdvectionDiffusionEquations< DIM >::dinterpolated_u_adv_diff_ddata(), oomph::RefineableAxisymAdvectionDiffusionEquations::dinterpolated_u_adv_diff_ddata(), oomph::RefineableSphericalAdvectionDiffusionEquations::dinterpolated_u_adv_diff_ddata(), oomph::SphericalAdvectionDiffusionEquations::dinterpolated_u_adv_diff_ddata(), oomph::SteadyAxisymAdvectionDiffusionEquations::dinterpolated_u_adv_diff_ddata(), oomph::AxisymAdvectionDiffusionEquations::dinterpolated_u_axi_adv_diff_ddata(), oomph::AxisymmetricNavierStokesEquations::dinterpolated_u_axi_nst_ddata(), oomph::RefineableAxisymmetricNavierStokesEquations::dinterpolated_u_axi_nst_ddata(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::dinterpolated_u_axi_nst_ddata(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::dinterpolated_u_axi_nst_ddata(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::RefineableGeneralisedNewtonianNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::NavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::RefineableNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::SpaceTimeNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::RefineableSpaceTimeNavierStokesEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::RefineableSpaceTimeNavierStokesMixedOrderEquations< DIM >::dinterpolated_u_nst_ddata(), oomph::Z2ErrorEstimator::doc_flux(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::dposition_dt(), oomph::SolidFiniteElement::fill_in_generic_jacobian_for_solid_ic(), oomph::Z2ErrorEstimator::get_element_errors(), oomph::ProjectableAdvectionDiffusionReactionElement< ADR_ELEMENT >::get_field(), oomph::ProjectableAxisymLinearElasticityElement< AXISYM_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::ProjectableDisplacementBasedFoepplvonKarmanElement< FVK_ELEMENT >::get_field(), oomph::ProjectableFoepplvonKarmanElement< FVK_ELEMENT >::get_field(), oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::get_field(), oomph::GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::ProjectableGeneralisedNewtonianTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::get_field(), oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >::get_field(), oomph::ProjectableLinearElasticityElement< LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableTaylorHoodElement< TAYLOR_HOOD_ELEMENT >::get_field(), oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::get_field(), oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >::get_field(), oomph::ProjectablePMLTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectablePoissonElement< POISSON_ELEMENT >::get_field(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::get_field(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::get_field(), oomph::ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableTimeHarmonicLinearElasticityElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >::get_field(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::get_field(), oomph::RefineableAxisymmetricQTaylorHoodElement::get_interpolated_values(), oomph::RefineableAxisymmetricQCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::get_interpolated_values(), oomph::RefineableGeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::get_interpolated_values(), oomph::RefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::get_interpolated_values(), oomph::PRefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::get_interpolated_values(), oomph::RefineableLinearElasticityEquations< DIM >::get_interpolated_values(), oomph::RefineableLinearisedAxisymmetricQCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::get_interpolated_values(), oomph::RefineableLinearisedQCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableLinearisedQTaylorHoodElement::get_interpolated_values(), oomph::RefineableQTaylorHoodElement< DIM >::get_interpolated_values(), oomph::RefineableQCrouzeixRaviartElement< DIM >::get_interpolated_values(), oomph::PRefineableQCrouzeixRaviartElement< DIM >::get_interpolated_values(), oomph::RefineablePolarTaylorHoodElement::get_interpolated_values(), oomph::RefineablePolarCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableQSphericalTaylorHoodElement::get_interpolated_values(), oomph::RefineableQSphericalCrouzeixRaviartElement::get_interpolated_values(), oomph::RefineableTimeHarmonicLinearElasticityEquations< DIM >::get_interpolated_values(), oomph::RefineableAdvectionDiffusionEquations< DIM >::get_interpolated_values(), oomph::RefineableGeneralisedAdvectionDiffusionEquations< DIM >::get_interpolated_values(), oomph::RefineableAdvectionDiffusionReactionEquations< NREAGENT, DIM >::get_interpolated_values(), oomph::RefineableAxisymAdvectionDiffusionEquations::get_interpolated_values(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::get_interpolated_values(), oomph::RefineableHelmholtzEquations< DIM >::get_interpolated_values(), oomph::RefineableLinearWaveEquations< DIM >::get_interpolated_values(), oomph::RefineablePMLHelmholtzEquations< DIM >::get_interpolated_values(), oomph::RefineablePoissonEquations< DIM >::get_interpolated_values(), oomph::RefineableSpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::get_interpolated_values(), oomph::RefineableSpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::get_interpolated_values(), oomph::RefineableSphericalAdvectionDiffusionEquations::get_interpolated_values(), oomph::RefineableUnsteadyHeatEquations< DIM >::get_interpolated_values(), oomph::RefineableYoungLaplaceEquations::get_interpolated_values(), oomph::PMLHelmholtzPowerElement< ELEMENT >::global_flux_contribution(), oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >::global_power_contribution(), oomph::HelmholtzBCElementBase< ELEMENT >::global_power_contribution(), oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >::global_power_contribution(), oomph::PMLHelmholtzPowerElement< ELEMENT >::global_power_contribution(), oomph::SurfactantTransportInterfaceElement::interpolated_C(), oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >::interpolated_c_adv_diff_react(), oomph::AxisymmetricLinearElasticityEquationsBase::interpolated_d2u_dt2_axisymmetric_linear_elasticity(), oomph::LinearWaveEquations< DIM >::interpolated_d2u_dt2_lin_wave(), oomph::AxisymmetricPoroelasticityEquations::interpolated_du_dt(), oomph::AxisymmetricLinearElasticityEquationsBase::interpolated_du_dt_axisymmetric_linear_elasticity(), oomph::LinearWaveEquations< DIM >::interpolated_du_dt_lin_wave(), oomph::UnsteadyHeatEquations< DIM >::interpolated_du_dt_ust_heat(), oomph::AxisymmetricNavierStokesEquations::interpolated_dudt_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_dudt_axi_nst(), interpolated_dxdt(), oomph::YoungLaplaceEquations::interpolated_u(), oomph::FluidInterfaceElement::interpolated_u(), oomph::AxisymmetricPoroelasticityEquations::interpolated_u(), oomph::PoroelasticityEquations< DIM >::interpolated_u(), oomph::DGFaceElement::interpolated_u(), oomph::AdvectionDiffusionEquations< DIM >::interpolated_u_adv_diff(), oomph::SteadyAxisymAdvectionDiffusionEquations::interpolated_u_adv_diff(), oomph::AxisymAdvectionDiffusionEquations::interpolated_u_axi_adv_diff(), oomph::AxisymmetricNavierStokesEquations::interpolated_u_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::interpolated_u_axi_nst(), oomph::AxisymmetricLinearElasticityEquationsBase::interpolated_u_axisymmetric_linear_elasticity(), oomph::BiharmonicEquations< DIM >::interpolated_u_biharmonic(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::interpolated_u_cons_adv_diff(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::interpolated_u_cons_axisym_adv_diff(), oomph::FourierDecomposedHelmholtzEquations::interpolated_u_fourier_decomposed_helmholtz(), oomph::AxisymFoepplvonKarmanEquations::interpolated_u_fvk(), oomph::HelmholtzEquations< DIM >::interpolated_u_helmholtz(), oomph::LinearWaveEquations< DIM >::interpolated_u_lin_wave(), oomph::LinearElasticityEquationsBase< DIM >::interpolated_u_linear_elasticity(), oomph::LinearisedAxisymmetricNavierStokesEquations::interpolated_u_linearised_axi_nst(), oomph::LinearisedNavierStokesEquations::interpolated_u_linearised_nst(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::interpolated_u_nst(), oomph::NavierStokesEquations< DIM >::interpolated_u_nst(), oomph::SpaceTimeNavierStokesEquations< DIM >::interpolated_u_nst(), oomph::PMLFourierDecomposedHelmholtzEquations::interpolated_u_pml_fourier_decomposed_helmholtz(), oomph::PMLHelmholtzEquations< DIM >::interpolated_u_pml_helmholtz(), oomph::PolarNavierStokesEquations::interpolated_u_pnst(), oomph::PoissonEquations< DIM >::interpolated_u_poisson(), oomph::SphericalAdvectionDiffusionEquations::interpolated_u_spherical_adv_diff(), oomph::SphericalNavierStokesEquations::interpolated_u_spherical_nst(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquationsBase::interpolated_u_time_harmonic_fourier_decomposed_linear_elasticity(), oomph::PMLTimeHarmonicLinearElasticityEquationsBase< DIM >::interpolated_u_time_harmonic_linear_elasticity(), oomph::TimeHarmonicLinearElasticityEquationsBase< DIM >::interpolated_u_time_harmonic_linear_elasticity(), oomph::SpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::interpolated_u_ust_heat(), oomph::UnsteadyHeatEquations< DIM >::interpolated_u_ust_heat(), oomph::WomersleyEquations< DIM >::interpolated_u_womersley(), oomph::AxisymFoepplvonKarmanEquations::interpolated_w_fvk(), oomph::DisplacementBasedFoepplvonKarmanEquations::interpolated_w_fvk(), oomph::FoepplvonKarmanEquations::interpolated_w_fvk(), interpolated_x(), oomph::SolidFiniteElement::interpolated_xi(), interpolated_zeta(), oomph::RefineableAxisymmetricQTaylorHoodElement::interpolating_basis(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::interpolating_basis(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::interpolating_basis(), oomph::RefineableLinearisedQTaylorHoodElement::interpolating_basis(), oomph::RefineableQSphericalTaylorHoodElement::interpolating_basis(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::interpolating_basis(), oomph::RefineableElement::interpolating_basis(), oomph::RefineableQTaylorHoodElement< DIM >::interpolating_basis(), oomph::RefineablePolarTaylorHoodElement::interpolating_basis(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::interpolating_basis(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::interpolating_basis(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::interpolating_basis(), oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >::jacobian_and_shape_of_field(), oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >::output(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::output(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::output_integration_points(), oomph::AxisymmetricNavierStokesEquations::output_veloc(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedNavierStokesEquations::output_veloc(), oomph::PolarNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_veloc(), oomph::FSIAxisymFoepplvonKarmanElement< NNODE_1D, FLUID_ELEMENT >::position(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::residual_for_projection(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::residual_for_projection(), oomph::ProjectableElement< ELEMENT >::residual_for_projection(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::scalar_value_paraview(), oomph::AlgebraicElementBase::setup_algebraic_node_update(), oomph::MGSolver< DIM >::setup_interpolation_matrices_unstructured(), oomph::HelmholtzMGPreconditioner< DIM >::setup_interpolation_matrices_unstructured(), oomph::AdvectionDiffusionFluxElement< ELEMENT >::shape_and_test(), oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >::shape_and_test(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::shape_and_test(), oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >::shape_and_test(), oomph::FourierDecomposedHelmholtzFluxElement< ELEMENT >::shape_and_test(), oomph::HelmholtzFluxElement< ELEMENT >::shape_and_test(), oomph::LinearWaveFluxElement< ELEMENT >::shape_and_test(), oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::shape_and_test(), oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::shape_and_test(), oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::shape_and_test(), oomph::PMLFourierDecomposedHelmholtzFluxElement< ELEMENT >::shape_and_test(), oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >::shape_and_test(), oomph::PMLHelmholtzFluxElement< ELEMENT >::shape_and_test(), oomph::PoissonFluxElement< ELEMENT >::shape_and_test(), oomph::SphericalAdvectionDiffusionFluxElement< ELEMENT >::shape_and_test(), oomph::SteadyAxisymAdvectionDiffusionFluxElement< ELEMENT >::shape_and_test(), oomph::UnsteadyHeatFluxElement< ELEMENT >::shape_and_test(), shape_at_knot(), oomph::SurfactantTransportInterfaceElement::sigma(), and oomph::HelmholtzBCElementBase< ELEMENT >::test_only().

◆ shape_at_knot()

void oomph::FiniteElement::shape_at_knot ( const unsigned &  ipt,
Shape psi 
) const
virtual

Return the geometric shape function at the ipt-th integration point.

Return the shape function stored at the ipt-th integration point.

Reimplemented in oomph::StorableShapeElementBase.

Definition at line 3220 of file elements.cc.

References dim(), i, integral_pt(), oomph::Integral::knot(), s, and shape().

Referenced by oomph::DGFaceElement::add_flux_contributions(), oomph::ImposeImpenetrabilityElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::ImposeParallelOutflowElement< ELEMENT >::fill_in_generic_contribution_to_residuals_parall_lagr_multiplier(), oomph::AxisymmetricNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::SphericalNavierStokesEquations::get_pressure_and_velocity_mass_matrix_diagonal(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::integrate_u(), oomph::StorableShapeElementBase::pre_compute_shape_at_knots(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::set_boundary_shape_geom_object_pt(), oomph::AdvectionDiffusionFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >::shape_and_test_at_knot(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::shape_and_test_at_knot(), oomph::FourierDecomposedHelmholtzFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::HelmholtzFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::shape_and_test_at_knot(), oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::shape_and_test_at_knot(), oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::shape_and_test_at_knot(), oomph::NavierStokesTractionElement< ELEMENT >::shape_and_test_at_knot(), oomph::NavierStokesFluxControlElement< ELEMENT >::shape_and_test_at_knot(), oomph::PMLFourierDecomposedHelmholtzFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::PMLHelmholtzFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::PoissonFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::PolarNavierStokesTractionElement< ELEMENT >::shape_and_test_at_knot(), oomph::PolarStressIntegralElement< ELEMENT >::shape_and_test_at_knot(), oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >::shape_and_test_at_knot(), oomph::SphericalAdvectionDiffusionFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::SteadyAxisymAdvectionDiffusionFluxElement< ELEMENT >::shape_and_test_at_knot(), oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::shape_and_test_at_knot(), and oomph::StorableShapeElementBase::shape_at_knot().

◆ size()

double oomph::FiniteElement::size ( ) const

Calculate the size of the element (length, area, volume,...) in Eulerian computational coordinates. Use suitably overloaded compute_physical_size() function to compute the actual size (taking into account factors such as 2pi or radii the integrand) – such function can only be implemented on an equation-by-equation basis.

Calculate the size of the element (in Eulerian computational coordinates. Use suitably overloaded compute_physical_size() function to compute the actual size (taking into account factors such as 2pi or radii the integrand). Such function can only be implemented on an equation-by-equation basis.

Definition at line 4290 of file elements.cc.

References integral_pt(), J_eulerian_at_knot(), oomph::Integral::nweight(), and oomph::Integral::weight().

Referenced by oomph::RefineableTetgenMesh< ELEMENT >::adapt(), oomph::RefineableTriangleMesh< ELEMENT >::adapt(), oomph::RefineableTriangleMesh< ELEMENT >::compute_area_target(), oomph::RefineableTetMeshBase::compute_volume_target(), oomph::FaceElement::continuous_tangent_and_outer_unit_normal(), oomph::GmshTetScaffoldMesh::create_mesh_from_msh_file(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::pin_all_non_pressure_dofs(), oomph::NavierStokesEquations< DIM >::pin_all_non_pressure_dofs(), oomph::SpaceTimeNavierStokesEquations< DIM >::pin_all_non_pressure_dofs(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::pin_all_non_pressure_dofs(), oomph::Mesh::prune_halo_elements_and_nodes(), oomph::RefineableTriangleMesh< ELEMENT >::snap_nodes_onto_boundary(), and oomph::Mesh::total_size().

◆ tecplot_zone_string()

virtual std::string oomph::FiniteElement::tecplot_zone_string ( const unsigned &  nplot) const
inlinevirtual

Return string for tecplot zone header (when plotting nplot points in each "coordinate direction")

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, oomph::QHermiteElement< DIM - 1 >, oomph::QHermiteElement< DIM >, and oomph::QHermiteElement< DIM - 1 >.

Definition at line 3161 of file elements.h.

Referenced by oomph::BiharmonicEquations< DIM >::compute_error(), oomph::Mesh::doc_boundary_coordinates(), oomph::Z2ErrorEstimator::doc_flux(), oomph::PolarNavierStokesEquations::full_output(), oomph::SphericalNavierStokesEquations::full_output(), oomph::AxisymFoepplvonKarmanEquations::output(), oomph::AxisymmetricLinearElasticityEquations::output(), oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >::output(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::output(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::output(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::output(), oomph::FSILinearisedAxisymPoroelasticTractionElement< POROELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::output(), oomph::FluidInterfaceElement::output(), oomph::SurfactantTransportInterfaceElement::output(), oomph::DisplacementBasedFoepplvonKarmanEquations::output(), oomph::FoepplvonKarmanEquations::output(), oomph::FourierDecomposedHelmholtzEquations::output(), oomph::NavierStokesSurfaceDragTorqueElement< ELEMENT >::output(), oomph::PMLFourierDecomposedHelmholtzEquations::output(), oomph::SolidTractionElement< ELEMENT >::output(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::output(), oomph::YoungLaplaceEquations::output(), oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::output(), oomph::AxisymAdvectionDiffusionEquations::output(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::output(), oomph::AxisymmetricNavierStokesEquations::output(), oomph::AxisymmetricPoroelasticityEquations::output(), oomph::BiharmonicEquations< DIM >::output(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output(), oomph::LinearisedAxisymmetricNavierStokesEquations::output(), oomph::LinearisedNavierStokesEquations::output(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::output(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::output(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::PoissonFluxElement< ELEMENT >::output(), oomph::PolarNavierStokesEquations::output(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::SphericalAdvectionDiffusionEquations::output(), oomph::SphericalNavierStokesEquations::output(), oomph::SteadyAxisymAdvectionDiffusionEquations::output(), oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::AxisymFoepplvonKarmanEquations::output_fct(), oomph::DisplacementBasedFoepplvonKarmanEquations::output_fct(), oomph::FoepplvonKarmanEquations::output_fct(), oomph::FourierDecomposedHelmholtzEquations::output_fct(), oomph::PMLFourierDecomposedHelmholtzEquations::output_fct(), oomph::YoungLaplaceEquations::output_fct(), oomph::AxisymAdvectionDiffusionEquations::output_fct(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::output_fct(), oomph::AxisymmetricLinearElasticityEquations::output_fct(), oomph::AxisymmetricNavierStokesEquations::output_fct(), oomph::AxisymmetricPoroelasticityEquations::output_fct(), oomph::BiharmonicEquations< DIM >::output_fct(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_fct(), oomph::PolarNavierStokesEquations::output_fct(), oomph::SphericalAdvectionDiffusionEquations::output_fct(), oomph::SphericalNavierStokesEquations::output_fct(), oomph::SteadyAxisymAdvectionDiffusionEquations::output_fct(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::output_fct(), oomph::BiharmonicEquations< DIM >::output_fluid_velocity(), oomph::FourierDecomposedHelmholtzEquations::output_real(), oomph::PMLFourierDecomposedHelmholtzEquations::output_real(), oomph::FourierDecomposedHelmholtzEquations::output_real_fct(), oomph::PMLFourierDecomposedHelmholtzEquations::output_real_fct(), oomph::AxisymmetricNavierStokesEquations::output_veloc(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedNavierStokesEquations::output_veloc(), oomph::PolarNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_vorticity(), oomph::FaceElement::output_zeta(), oomph::MGSolver< DIM >::plot(), and oomph::Multi_domain_functions::setup_bulk_elements_adjacent_to_face_mesh().

◆ transform_derivatives()

void oomph::FiniteElement::transform_derivatives ( const DenseMatrix< double > &  inverse_jacobian,
DShape dbasis 
) const
protectedvirtual

Convert derivative w.r.t.local coordinates to derivatives w.r.t the coordinates used to assemble the inverse_jacobian passed in the mapping. On entry, dbasis must contain the basis function derivatives w.r.t. the local coordinates; it will contain the derivatives w.r.t. the new coordinates on exit. This is virtual so that it may be overloaded if desired for efficiency reasons.

Convert derivatives w.r.t local coordinates to derivatives w.r.t the coordinates used to assemble the inverse jacobian mapping passed as inverse_jacobian. The derivatives passed in dbasis will be modified in this function from dbasisds to dbasisdX.

Reimplemented in oomph::DiagQHermiteElement< DIM >.

Definition at line 2833 of file elements.cc.

References dim(), i, oomph::DShape::nindex1(), and oomph::DShape::nindex2().

Referenced by oomph::AxisymmetricTCrouzeixRaviartElement::dpshape_and_dptest_eulerian_axi_nst(), oomph::AxisymmetricTTaylorHoodElement::dpshape_and_dptest_eulerian_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement::dpshape_and_dptest_eulerian_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement::dpshape_and_dptest_eulerian_axi_nst(), dshape_eulerian(), dshape_eulerian_at_knot(), oomph::SolidFiniteElement::dshape_lagrangian(), oomph::SolidFiniteElement::dshape_lagrangian_at_knot(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::get_flux(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::interpolated_du_dt_nst(), oomph::SpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::interpolated_du_dt_ust_heat(), oomph::AxisymmetricPoroelasticityEquations::transform_basis(), and transform_second_derivatives_template().

◆ transform_derivatives_diagonal()

void oomph::FiniteElement::transform_derivatives_diagonal ( const DenseMatrix< double > &  inverse_jacobian,
DShape dbasis 
) const
protected

Convert derivative w.r.t local coordinates to derivatives w.r.t the coordinates used to assemble the inverse jacobian passed in the mapping, assuming that the coordinates are aligned in the direction of the local coordinates. On entry dbasis must contain the derivatives of the basis functions w.r.t. the local coordinates; it will contain the derivatives w.r.t. the new coordinates. are converted into the new using the mapping inverse_jacobian.

Convert derivatives w.r.t local coordinates to derivatives w.r.t the coordinates used to assemble the inverse jacobian mapping passed as inverse_jacobian, assuming that the mapping is diagonal. This merely saves a few loops, but is probably worth it.

Definition at line 2877 of file elements.cc.

References dim(), oomph::DShape::nindex1(), and oomph::DShape::nindex2().

Referenced by oomph::DiagQHermiteElement< DIM >::transform_derivatives(), and transform_second_derivatives_diagonal().

◆ transform_second_derivatives()

void oomph::FiniteElement::transform_second_derivatives ( const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  inverse_jacobian,
const DenseMatrix< double > &  jacobian2,
DShape dbasis,
DShape d2basis 
) const
protectedvirtual

Convert derivatives and second derivatives w.r.t. local coordiantes to derivatives and second derivatives w.r.t. the coordinates used to assemble the jacobian, inverse jacobian and jacobian2 passed to the function. By default this function will call transform_second_derivatives_template<>(...) using the dimension of the element as the template parameter. It is virtual so that it can be overloaded by a specific element to save using a switch statement. Optionally, the element writer may wish to use the transform_second_derivatives_diagonal<>(...) function On entry dbasis and d2basis must contain the derivatives w.r.t. the local coordinates; on exit they will be the derivatives w.r.t. the transformed coordinates.

Convert derivatives and second derivatives w.r.t. local coordiantes to derivatives and second derivatives w.r.t. the coordinates used to assemble the jacobian, inverse jacobian and jacobian2 passed to the function. This is a template-free general interface, that should be overloaded for efficiency.

Reimplemented in oomph::DiagQHermiteElement< DIM >, oomph::QHermiteElement< DIM >, and oomph::QHermiteElement< DIM - 1 >.

Definition at line 3125 of file elements.cc.

References dim().

Referenced by d2shape_eulerian(), d2shape_eulerian_at_knot(), oomph::SolidFiniteElement::d2shape_lagrangian(), and oomph::SolidFiniteElement::d2shape_lagrangian_at_knot().

◆ transform_second_derivatives_diagonal() [1/3]

template<>
void oomph::FiniteElement::transform_second_derivatives_diagonal ( const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  inverse_jacobian,
const DenseMatrix< double > &  jacobian2,
DShape dbasis,
DShape d2basis 
) const
protected

Convert derivatives and second derivatives w.r.t local coordinates to derivatives w.r.t. the coordinates used to assemble the jacobian, inverse_jacobian and jacobian 2 passed. This must be specialised for each dimension, otherwise it gets very ugly Specialisation to one dimension.

Definition at line 3060 of file elements.cc.

◆ transform_second_derivatives_diagonal() [2/3]

template<>
void oomph::FiniteElement::transform_second_derivatives_diagonal ( const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  inverse_jacobian,
const DenseMatrix< double > &  jacobian2,
DShape dbasis,
DShape d2basis 
) const
protected

Convert second derivatives w.r.t. local coordinates to second derivatives w.r.t. the coordinates passed in the tensor coordinate. Specialised to two spatial dimension.

Definition at line 3078 of file elements.cc.

References oomph::DShape::nindex1(), oomph::DShape::nindex2(), and transform_derivatives_diagonal().

◆ transform_second_derivatives_diagonal() [3/3]

template<unsigned DIM>
void oomph::FiniteElement::transform_second_derivatives_diagonal ( const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  inverse_jacobian,
const DenseMatrix< double > &  jacobian2,
DShape dbasis,
DShape d2basis 
) const
protected

Convert derivatives and second derivatives w.r.t. local coordinates to derivatives and second derivatives w.r.t. the coordinates used to asssmble the jacobian, inverse jacobian and jacobian2 passed in the mapping. This version of the function assumes that the local coordinates are aligned with the global coordinates, i.e. the jacobians are diagonal On entry dbasis and d2basis must contain the derivatives w.r.t. the local coordinates; on exit they will be the derivatives w.r.t. the transformed coordinates.

◆ transform_second_derivatives_template() [1/3]

template<>
void oomph::FiniteElement::transform_second_derivatives_template ( const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  inverse_jacobian,
const DenseMatrix< double > &  jacobian2,
DShape dbasis,
DShape d2basis 
) const
protected

Convert derivatives and second derivatives w.r.t local coordinates to derivatives w.r.t. the coordinates used to assemble the jacobian, inverse_jacobian and jacobian 2 passed. This must be specialised for each dimension, otherwise it gets very ugly Specialisation to one dimension.

Definition at line 2909 of file elements.cc.

References oomph::DShape::nindex1(), oomph::DShape::nindex2(), and transform_derivatives().

◆ transform_second_derivatives_template() [2/3]

template<>
void oomph::FiniteElement::transform_second_derivatives_template ( const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  inverse_jacobian,
const DenseMatrix< double > &  jacobian2,
DShape dbasis,
DShape d2basis 
) const
protected

Convert derivatives and second derivatives w.r.t local coordinates to derivatives w.r.t. the coordinates used to assemble the jacobian, inverse_jacobian and jacobian 2 passed. This must be specialised for each dimension, otherwise it gets very ugly. Specialisation to two spatial dimensions.

Definition at line 2948 of file elements.cc.

References i, oomph::DShape::nindex1(), oomph::DShape::nindex2(), and transform_derivatives().

◆ transform_second_derivatives_template() [3/3]

template<unsigned DIM>
void oomph::FiniteElement::transform_second_derivatives_template ( const DenseMatrix< double > &  jacobian,
const DenseMatrix< double > &  inverse_jacobian,
const DenseMatrix< double > &  jacobian2,
DShape dbasis,
DShape d2basis 
) const
protected

Convert derivatives and second derivatives w.r.t. local coordinates to derivatives and second derivatives w.r.t. the coordinates used to asssmble the jacobian, inverse jacobian and jacobian2 passed in the mapping. This is templated by dimension because the method of calculation varies significantly with the dimension. On entry dbasis and d2basis must contain the derivatives w.r.t. the local coordinates; on exit they will be the derivatives w.r.t. the transformed coordinates.

◆ update_before_nodal_fd()

virtual void oomph::FiniteElement::update_before_nodal_fd ( )
inlineprotectedvirtual

Function that is called before the finite differencing of any nodal data. This may be overloaded to update any dependent data before finite differencing takes place.

Definition at line 1709 of file elements.h.

Referenced by fill_in_jacobian_from_nodal_by_fd(), and oomph::RefineableElement::fill_in_jacobian_from_nodal_by_fd().

◆ update_in_nodal_fd()

virtual void oomph::FiniteElement::update_in_nodal_fd ( const unsigned &  i)
inlineprotectedvirtual

Function called within the finite difference loop for nodal data after a change in the i-th nodal value.

Reimplemented in oomph::FSIWallElement.

Definition at line 1718 of file elements.h.

Referenced by fill_in_jacobian_from_nodal_by_fd(), oomph::RefineableElement::fill_in_jacobian_from_nodal_by_fd(), and reset_in_nodal_fd().

◆ vertex_node_pt()

virtual Node* oomph::FiniteElement::vertex_node_pt ( const unsigned &  j) const
inlinevirtual

Pointer to the j-th vertex node in the element. Broken virtual function in "pure" finite elements.

Reimplemented in oomph::BrickElementBase, oomph::QuadElementBase, oomph::LineElementBase, oomph::ElementWithZ2ErrorEstimator, oomph::RefineableQYoungLaplaceElement< NNODE_1D >, oomph::TUnsteadyHeatElement< DIM, NNODE_1D >, oomph::RefineableQUnsteadyHeatElement< DIM, NNODE_1D >, oomph::TTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::RefineableQTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::TTimeHarmonicFourierDecomposedLinearElasticityElement< NNODE_1D >, oomph::RefineableQSphericalCrouzeixRaviartElement, oomph::RefineableQSphericalTaylorHoodElement, oomph::RefineableQSphericalAdvectionDiffusionElement< NNODE_1D >, oomph::RefineableQUnsteadyHeatMixedOrderSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::RefineableQUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::RefineableQUnsteadyHeatSpaceTimeElement< SPATIAL_DIM, NNODE_1D >, oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >, oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >, oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >, oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >, oomph::TPVDElementWithContinuousPressure< DIM >, oomph::TPVDBubbleEnrichedElement< DIM, NNODE_1D >, oomph::TPVDElement< DIM, NNODE_1D >, oomph::RefineableQPVDElementWithContinuousPressure< DIM >, oomph::RefineableQPVDElementWithPressure< DIM >, oomph::RefineableQPVDElement< DIM, NNODE_1D >, oomph::RefineablePolarCrouzeixRaviartElement, oomph::RefineablePolarTaylorHoodElement, oomph::TPoissonElement< DIM, NNODE_1D >, oomph::RefineableQSpectralPoissonElement< DIM, NNODE_1D >, oomph::PRefineableQPoissonElement< DIM >, oomph::RefineableQPoissonElement< DIM, NNODE_1D >, oomph::TPMLTimeHarmonicLinearElasticityElement< DIM, NNODE_1D >, oomph::TPMLHelmholtzElement< DIM, NNODE_1D >, oomph::RefineableQPMLHelmholtzElement< DIM, NNODE_1D >, oomph::RefineableQPMLHelmholtzElement< 2, NNODE_1D >, oomph::TPMLFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::TTaylorHoodElement< DIM >, oomph::TCrouzeixRaviartElement< DIM >, oomph::PRefineableQCrouzeixRaviartElement< DIM >, oomph::RefineableQCrouzeixRaviartElement< DIM >, oomph::RefineableQTaylorHoodElement< DIM >, oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >, oomph::RefineableLinearisedQTaylorHoodElement, oomph::RefineableLinearisedQCrouzeixRaviartElement, oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement, oomph::RefineableLinearisedAxisymmetricQCrouzeixRaviartElement, oomph::RefineableQLinearWaveElement< DIM, NNODE_1D >, oomph::TLinearElasticityElement< DIM, NNODE_1D >, oomph::PRefineableQLinearElasticityElement< DIM >, oomph::RefineableQLinearElasticityElement< DIM, NNODE_1D >, oomph::THelmholtzElement< DIM, NNODE_1D >, oomph::RefineableQHelmholtzElement< DIM, NNODE_1D >, oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QSpectralElement< 3, NNODE_1D >, oomph::QSpectralElement< 2, NNODE_1D >, oomph::QSpectralElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, oomph::QElement< 1, NNODE_1D >, oomph::SpectralPeriodicOrbitElement< NNODE_1D >, oomph::GeneralisedNewtonianTTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianTCrouzeixRaviartElement< DIM >, oomph::PRefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >, oomph::RefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >, oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >, oomph::GeneralisedNewtonianAxisymmetricTTaylorHoodElement, oomph::GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement, oomph::RefineableGeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement, oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement, oomph::TFourierDecomposedHelmholtzElement< NNODE_1D >, oomph::TFoepplvonKarmanElement< NNODE_1D >, oomph::TDisplacementBasedFoepplvonKarmanElement< NNODE_1D >, oomph::TRaviartThomasDarcyElement< ORDER >, oomph::TAxisymmetricPoroelasticityElement< ORDER >, oomph::AxisymmetricTTaylorHoodElement, oomph::AxisymmetricTCrouzeixRaviartElement, oomph::RefineableAxisymmetricQCrouzeixRaviartElement, oomph::RefineableAxisymmetricQTaylorHoodElement, oomph::TAxisymmetricLinearElasticityElement< NNODE_1D >, oomph::RefineableQGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::RefineableQAxisymAdvectionDiffusionElement< NNODE_1D >, oomph::TAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::RefineableQAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >, oomph::RefineableQSUPGAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::RefineableQGeneralisedAdvectionDiffusionElement< DIM, NNODE_1D >, oomph::RefineableQAdvectionDiffusionElement< DIM, NNODE_1D >, and oomph::RefineableQAdvectionDiffusionElement< DIM, 3 >.

Definition at line 2500 of file elements.h.

References oomph::Global_string_for_annotation::string().

Referenced by oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::compute_stabilisation_parameter(), oomph::RefineableQAdvectionDiffusionElement< DIM, NNODE_1D >::vertex_node_pt(), oomph::RefineableQSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::vertex_node_pt(), oomph::RefineableQAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >::vertex_node_pt(), oomph::RefineableAxisymmetricQTaylorHoodElement::vertex_node_pt(), oomph::RefineableAxisymmetricQCrouzeixRaviartElement::vertex_node_pt(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::vertex_node_pt(), oomph::RefineableGeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement::vertex_node_pt(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::vertex_node_pt(), oomph::RefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::vertex_node_pt(), oomph::PRefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM >::vertex_node_pt(), oomph::RefineableQHelmholtzElement< DIM, NNODE_1D >::vertex_node_pt(), oomph::RefineableQLinearElasticityElement< DIM, NNODE_1D >::vertex_node_pt(), oomph::PRefineableQLinearElasticityElement< DIM >::vertex_node_pt(), oomph::RefineableQLinearWaveElement< DIM, NNODE_1D >::vertex_node_pt(), oomph::RefineableLinearisedAxisymmetricQCrouzeixRaviartElement::vertex_node_pt(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::vertex_node_pt(), oomph::RefineableLinearisedQCrouzeixRaviartElement::vertex_node_pt(), oomph::RefineableLinearisedQTaylorHoodElement::vertex_node_pt(), oomph::RefineableQTaylorHoodElement< DIM >::vertex_node_pt(), oomph::RefineableQCrouzeixRaviartElement< DIM >::vertex_node_pt(), oomph::PRefineableQCrouzeixRaviartElement< DIM >::vertex_node_pt(), oomph::RefineableQPMLHelmholtzElement< DIM, NNODE_1D >::vertex_node_pt(), oomph::RefineableQPoissonElement< DIM, NNODE_1D >::vertex_node_pt(), oomph::PRefineableQPoissonElement< DIM >::vertex_node_pt(), oomph::RefineableQSpectralPoissonElement< DIM, NNODE_1D >::vertex_node_pt(), oomph::RefineablePolarTaylorHoodElement::vertex_node_pt(), oomph::RefineablePolarCrouzeixRaviartElement::vertex_node_pt(), oomph::RefineableQPVDElement< DIM, NNODE_1D >::vertex_node_pt(), oomph::RefineableQPVDElementWithPressure< DIM >::vertex_node_pt(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::vertex_node_pt(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::vertex_node_pt(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::vertex_node_pt(), oomph::RefineableQUnsteadyHeatMixedOrderSpaceTimeElement< SPATIAL_DIM, NNODE_1D >::vertex_node_pt(), oomph::RefineableQSphericalTaylorHoodElement::vertex_node_pt(), oomph::RefineableQSphericalCrouzeixRaviartElement::vertex_node_pt(), and oomph::RefineableQUnsteadyHeatElement< DIM, NNODE_1D >::vertex_node_pt().

◆ write_paraview_offsets()

virtual void oomph::FiniteElement::write_paraview_offsets ( std::ofstream &  file_out,
const unsigned &  nplot,
unsigned &  offset_sum 
) const
inlinevirtual

Return the offsets for the paraview sub-elements. Broken virtual. Needs to be implemented for each new geometric element type; see http://www.vtk.org/VTK/img/file-formats.pdf.

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, and oomph::QElement< 1, NNODE_1D >.

Definition at line 2976 of file elements.h.

Referenced by oomph::Mesh::output_fct_paraview(), and oomph::Mesh::output_paraview().

◆ write_paraview_output_offset_information()

virtual void oomph::FiniteElement::write_paraview_output_offset_information ( std::ofstream &  file_out,
const unsigned &  nplot,
unsigned &  counter 
) const
inlinevirtual

Fill in the offset information for paraview plot. Broken virtual. Needs to be implemented for each new geometric element type; see http://www.vtk.org/VTK/img/file-formats.pdf.

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, and oomph::QElement< 1, NNODE_1D >.

Definition at line 2952 of file elements.h.

Referenced by oomph::Mesh::output_fct_paraview(), and oomph::Mesh::output_paraview().

◆ write_paraview_type()

virtual void oomph::FiniteElement::write_paraview_type ( std::ofstream &  file_out,
const unsigned &  nplot 
) const
inlinevirtual

Return the paraview element type. Broken virtual. Needs to be implemented for each new geometric element type; see http://www.vtk.org/VTK/img/file-formats.pdf.

Reimplemented in oomph::TElement< 3, NNODE_1D >, oomph::TElement< 2, NNODE_1D >, oomph::TElement< 1, NNODE_1D >, oomph::QElement< 3, NNODE_1D >, oomph::QElement< 2, NNODE_1D >, and oomph::QElement< 1, NNODE_1D >.

Definition at line 2964 of file elements.h.

Referenced by oomph::Mesh::output_fct_paraview(), and oomph::Mesh::output_paraview().

◆ write_tecplot_zone_footer() [1/2]

virtual void oomph::FiniteElement::write_tecplot_zone_footer ( FILE *  file_pt,
const unsigned &  nplot 
) const
inlinevirtual

Add tecplot zone "footer" to C-style output. (when plotting nplot points in each "coordinate direction"). Empty by default – can be used, e.g., to add FE connectivity lists to elements that need it.

Reimplemented in oomph::TElement< 3, NNODE_1D >, and oomph::TElement< 2, NNODE_1D >.

Definition at line 3181 of file elements.h.

◆ write_tecplot_zone_footer() [2/2]

virtual void oomph::FiniteElement::write_tecplot_zone_footer ( std::ostream &  outfile,
const unsigned &  nplot 
) const
inlinevirtual

Add tecplot zone "footer" to output stream (when plotting nplot points in each "coordinate direction"). Empty by default – can be used, e.g., to add FE connectivity lists to elements that need it.

Reimplemented in oomph::TElement< 3, NNODE_1D >, and oomph::TElement< 2, NNODE_1D >.

Definition at line 3174 of file elements.h.

Referenced by oomph::BiharmonicEquations< DIM >::compute_error(), oomph::Mesh::doc_boundary_coordinates(), oomph::Z2ErrorEstimator::doc_flux(), oomph::SphericalNavierStokesEquations::full_output(), oomph::AxisymFoepplvonKarmanEquations::output(), oomph::AxisymmetricLinearElasticityEquations::output(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::output(), oomph::FSILinearisedAxisymPoroelasticTractionElement< POROELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::output(), oomph::FluidInterfaceElement::output(), oomph::DisplacementBasedFoepplvonKarmanEquations::output(), oomph::FoepplvonKarmanEquations::output(), oomph::FourierDecomposedHelmholtzEquations::output(), oomph::NavierStokesSurfaceDragTorqueElement< ELEMENT >::output(), oomph::PMLFourierDecomposedHelmholtzEquations::output(), oomph::SolidTractionElement< ELEMENT >::output(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::output(), oomph::YoungLaplaceEquations::output(), oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::output(), oomph::AxisymAdvectionDiffusionEquations::output(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::output(), oomph::AxisymmetricNavierStokesEquations::output(), oomph::AxisymmetricPoroelasticityEquations::output(), oomph::BiharmonicEquations< DIM >::output(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output(), oomph::LinearisedAxisymmetricNavierStokesEquations::output(), oomph::LinearisedNavierStokesEquations::output(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::output(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::output(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output(), oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::PoissonFluxElement< ELEMENT >::output(), oomph::ProjectableUnsteadyHeatSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::ProjectableUnsteadyHeatMixedOrderSpaceTimeElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::SphericalAdvectionDiffusionEquations::output(), oomph::SphericalNavierStokesEquations::output(), oomph::SteadyAxisymAdvectionDiffusionEquations::output(), oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::ProjectableUnsteadyHeatElement< UNSTEADY_HEAT_ELEMENT >::output(), oomph::AxisymFoepplvonKarmanEquations::output_fct(), oomph::DisplacementBasedFoepplvonKarmanEquations::output_fct(), oomph::FoepplvonKarmanEquations::output_fct(), oomph::FourierDecomposedHelmholtzEquations::output_fct(), oomph::PMLFourierDecomposedHelmholtzEquations::output_fct(), oomph::YoungLaplaceEquations::output_fct(), oomph::AxisymAdvectionDiffusionEquations::output_fct(), oomph::GeneralisedAxisymAdvectionDiffusionEquations::output_fct(), oomph::AxisymmetricLinearElasticityEquations::output_fct(), oomph::AxisymmetricNavierStokesEquations::output_fct(), oomph::AxisymmetricPoroelasticityEquations::output_fct(), oomph::BiharmonicEquations< DIM >::output_fct(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_fct(), oomph::PolarNavierStokesEquations::output_fct(), oomph::SphericalAdvectionDiffusionEquations::output_fct(), oomph::SphericalNavierStokesEquations::output_fct(), oomph::SteadyAxisymAdvectionDiffusionEquations::output_fct(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::output_fct(), oomph::BiharmonicEquations< DIM >::output_fluid_velocity(), oomph::FourierDecomposedHelmholtzEquations::output_real(), oomph::PMLFourierDecomposedHelmholtzEquations::output_real(), oomph::FourierDecomposedHelmholtzEquations::output_real_fct(), oomph::PMLFourierDecomposedHelmholtzEquations::output_real_fct(), oomph::AxisymmetricNavierStokesEquations::output_veloc(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedAxisymmetricNavierStokesEquations::output_veloc(), oomph::LinearisedNavierStokesEquations::output_veloc(), oomph::PolarNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_veloc(), oomph::SphericalNavierStokesEquations::output_vorticity(), oomph::FaceElement::output_zeta(), and oomph::Multi_domain_functions::setup_bulk_elements_adjacent_to_face_mesh().

◆ zeta_nodal()

virtual double oomph::FiniteElement::zeta_nodal ( const unsigned &  n,
const unsigned &  k,
const unsigned &  i 
) const
inlinevirtual

Specify the values of the "global" intrinsic coordinate, zeta, of a compound geometric object (a mesh of elements) when the element is viewied as a sub-geometric object. The default assumption is that the element will be treated as a sub-geometric object in a bulk Mesh of other elements (geometric objects). The "global" coordinate of the compound geometric object is simply the Eulerian coordinate, x. The second default assumption is that the coordinate zeta will be stored at the nodes and interpolated using the shape functions of the element. This function returns the value of zeta stored at local node n, where k is the type of coordinate and i is the coordinate direction. The function is virtual so that it can be overloaded by different types of element: FaceElements and SolidFiniteElements.

Reimplemented in oomph::YoungLaplaceContactAngleElement< ELEMENT >, oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >, oomph::UnsteadyHeatFluxElement< ELEMENT >, oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >, oomph::TimeHarmonicFourierDecomposedLinearElasticityTractionElement< ELEMENT >, oomph::SteadyAxisymAdvectionDiffusionFluxElement< ELEMENT >, oomph::SphericalAdvectionDiffusionFluxElement< ELEMENT >, oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >, oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >, oomph::PoroelasticityFaceElement< ELEMENT >, oomph::PoissonFluxElement< ELEMENT >, oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >, oomph::PMLHelmholtzFluxElement< ELEMENT >, oomph::PMLHelmholtzPowerElement< ELEMENT >, oomph::PMLFourierDecomposedHelmholtzPowerMonitorElement< ELEMENT >, oomph::NavierStokesSurfacePowerElement< ELEMENT >, oomph::NavierStokesSurfaceDragTorqueElement< ELEMENT >, oomph::ImposeParallelOutflowElement< ELEMENT >, oomph::ImposeImpenetrabilityElement< ELEMENT >, oomph::NavierStokesTractionElement< ELEMENT >, oomph::LinearWaveFluxElement< ELEMENT >, oomph::LinearElasticityTractionElement< ELEMENT >, oomph::HelmholtzFluxElement< ELEMENT >, oomph::HelmholtzBCElementBase< ELEMENT >, oomph::ProjectableElement< ELEMENT >, oomph::ProjectableElement< FVK_ELEMENT >, oomph::ProjectableElement< AXISYM_LINEAR_ELAST_ELEMENT >, oomph::ProjectableElement< UNSTEADY_HEAT_ELEMENT >, oomph::ProjectableElement< LINEAR_ELAST_ELEMENT >, oomph::ProjectableElement< CROUZEIX_RAVIART_ELEMENT >, oomph::ProjectableElement< HELMHOLTZ_ELEMENT >, oomph::ProjectableElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >, oomph::ProjectableElement< TAYLOR_HOOD_ELEMENT >, oomph::ProjectableElement< PVD_ELEMENT >, oomph::ProjectableElement< ADR_ELEMENT >, oomph::ProjectableElement< DARCY_ELEMENT >, oomph::ProjectableElement< POISSON_ELEMENT >, oomph::ProjectableElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >, oomph::ProjectableElement< TIME_HARMONIC_LINEAR_ELAST_ELEMENT >, oomph::GenericLagrangeInterpolatedProjectableElement< ELEMENT >, oomph::FaceElementAsGeomObject< ELEMENT >, oomph::DummyFaceElement< ELEMENT >, oomph::SolidFaceElement, oomph::FaceElement, oomph::SolidFiniteElement, oomph::FourierDecomposedHelmholtzBCElementBase< ELEMENT >, oomph::DGEulerFaceReflectionElement< ELEMENT >, oomph::DGEulerFaceElement< ELEMENT >, oomph::ElasticLineFluidInterfaceBoundingElement< ELEMENT >, oomph::ElasticPointFluidInterfaceBoundingElement< ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT >, oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >, oomph::SpineSurfaceVolumeConstraintBoundingElement< ELEMENT >, oomph::ElasticSurfaceVolumeConstraintBoundingElement< ELEMENT >, oomph::SpineAxisymmetricVolumeConstraintBoundingElement< ELEMENT >, oomph::ElasticAxisymmetricVolumeConstraintBoundingElement< ELEMENT >, oomph::SpineLineVolumeConstraintBoundingElement< ELEMENT >, oomph::ElasticLineVolumeConstraintBoundingElement< ELEMENT >, oomph::DarcyFaceElement< ELEMENT >, oomph::BiharmonicFluxElement< DIM >, oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >, oomph::AxisymmetricPoroelasticityTractionElement< POROELASTICITY_BULK_ELEMENT >, oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >, oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >, and oomph::AdvectionDiffusionFluxElement< ELEMENT >.

Definition at line 2722 of file elements.h.

References i, and nodal_position_gen().

Referenced by get_centre_of_gravity_and_max_radius_in_terms_of_zeta(), interpolated_zeta(), and locate_zeta().

Member Data Documentation

◆ Accept_negative_jacobian

bool oomph::FiniteElement::Accept_negative_jacobian = false
static

Boolean that if set to true allows a negative jacobian in the transform between global and local coordinates (negative surface area = left-handed coordinate system).

Set the default value of the Accept_negative_jacobian flag to be false.

Definition at line 1775 of file elements.h.

Referenced by check_J_eulerian_at_knots(), check_jacobian(), and self_test().

◆ Default_Initial_Nvalue

const unsigned oomph::FiniteElement::Default_Initial_Nvalue = 0
staticprotected

Default return value for required_nvalue(n) which gives the number of "data" values required by the element at node n; for example, solving a Poisson equation would required only one "data" value at each node. The defaults is set to zero, because a general element is problem-less.

Default value for the number of values at a node.

Definition at line 1370 of file elements.h.

Referenced by required_nvalue().

◆ Elemental_dimension

unsigned oomph::FiniteElement::Elemental_dimension
private

The spatial dimension of the element, i.e. the number of local coordinates used to parametrize it.

Definition at line 1330 of file elements.h.

Referenced by assemble_local_to_eulerian_jacobian(), dim(), get_centre_of_gravity_and_max_radius_in_terms_of_zeta(), local_to_eulerian_mapping_diagonal(), and set_dimension().

◆ Integral_pt

Integral* oomph::FiniteElement::Integral_pt
private

Pointer to the spatial integration scheme.

Definition at line 1316 of file elements.h.

Referenced by integral_pt(), and set_integration_scheme().

◆ Macro_elem_pt

MacroElement* oomph::FiniteElement::Macro_elem_pt
protected

◆ N2deriv

const unsigned oomph::FiniteElement::N2deriv = {0, 1, 3, 6}
staticprotected

Static array that holds the number of second derivatives as a function of the dimension of the element.

Static array that holds the number of rows in the second derivative matrix as a function of spatial dimension. In one-dimension, there is only one possible second derivative. In two-dimensions, there are three, the two second derivatives and the mixed derivatives. In three dimensions there are six.

Definition at line 1483 of file elements.h.

Referenced by assemble_local_to_eulerian_jacobian2(), oomph::RefineableElement::assemble_local_to_eulerian_jacobian2(), oomph::SolidFiniteElement::assemble_local_to_lagrangian_jacobian2(), oomph::RefineableSolidElement::assemble_local_to_lagrangian_jacobian2(), d2shape_eulerian(), d2shape_eulerian_at_knot(), oomph::SolidFiniteElement::d2shape_lagrangian(), and oomph::SolidFiniteElement::d2shape_lagrangian_at_knot().

◆ Nnodal_position_type

unsigned oomph::FiniteElement::Nnodal_position_type
private

The number of coordinate types required to interpolate the element's geometry between the nodes. For Lagrange elements it is 1 (the default). It must be over-ridden by using the set_nposition_type() function in the constructors of elements that use generalised coordinate, e.g. for 1D Hermite elements Nnodal_position_types =2.

Definition at line 1344 of file elements.h.

Referenced by construct_boundary_node(), construct_node(), nnodal_position_type(), and set_nnodal_position_type().

◆ Nnode

unsigned oomph::FiniteElement::Nnode
private

Number of nodes in the element.

Definition at line 1326 of file elements.h.

Referenced by nnode(), nodal_local_eqn(), node_pt(), and set_n_node().

◆ Nodal_dimension

unsigned oomph::FiniteElement::Nodal_dimension
private

The spatial dimension of the nodes in the element. We assume that nodes have the same spatial dimension, because we cannot think of any "real" problems for which that would not be the case.

Definition at line 1336 of file elements.h.

Referenced by assemble_local_to_eulerian_jacobian(), construct_boundary_node(), construct_node(), local_to_eulerian_mapping_diagonal(), nodal_dimension(), set_dimension(), and set_nodal_dimension().

◆ Nodal_local_eqn

int** oomph::FiniteElement::Nodal_local_eqn
private

Storage for the local equation numbers associated with the values stored at the nodes.

Definition at line 1323 of file elements.h.

Referenced by assign_nodal_local_eqn_numbers(), nodal_local_eqn(), and ~FiniteElement().

◆ Node_location_tolerance

const double oomph::FiniteElement::Node_location_tolerance = 1.0e-14
staticprotected

Default value for the tolerance to be used when locating nodes via local coordinates.

Default value that is used for the tolerance required when locating nodes via local coordinates.

Definition at line 1374 of file elements.h.

Referenced by oomph::RefineableAxisymmetricQTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableLinearisedAxisymmetricQTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableLinearisedQTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableQSphericalTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableGeneralisedNewtonianQTaylorHoodElement< DIM >::get_interpolating_node_at_local_coordinate(), oomph::RefineableQTaylorHoodElement< DIM >::get_interpolating_node_at_local_coordinate(), oomph::RefineablePolarTaylorHoodElement::get_interpolating_node_at_local_coordinate(), oomph::RefineableQPVDElementWithContinuousPressure< DIM >::get_interpolating_node_at_local_coordinate(), oomph::RefineableQTaylorHoodSpaceTimeElement< DIM >::get_interpolating_node_at_local_coordinate(), oomph::RefineableQTaylorHoodMixedOrderSpaceTimeElement< DIM >::get_interpolating_node_at_local_coordinate(), oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >::get_node_at_local_coordinate(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::get_node_at_local_coordinate(), oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >::get_node_at_local_coordinate(), oomph::QElement< 1, NNODE_1D >::get_node_at_local_coordinate(), oomph::QElement< 2, NNODE_1D >::get_node_at_local_coordinate(), and oomph::QElement< 3, NNODE_1D >::get_node_at_local_coordinate().

◆ Node_pt

Node** oomph::FiniteElement::Node_pt
private

Storage for pointers to the nodes in the element.

Definition at line 1319 of file elements.h.

Referenced by assign_nodal_local_eqn_numbers(), node_pt(), set_n_node(), and ~FiniteElement().

◆ Suppress_output_while_checking_for_inverted_elements

bool oomph::FiniteElement::Suppress_output_while_checking_for_inverted_elements
static
Initial value:
=
false

Static boolean to suppress output while checking for inverted elements.

Set default for static boolean to suppress output while checking for inverted elements.

Definition at line 1779 of file elements.h.

Referenced by oomph::Mesh::check_inverted_elements(), and check_jacobian().

◆ Tolerance_for_singular_jacobian

double oomph::FiniteElement::Tolerance_for_singular_jacobian = 1.0e-16
static

Tolerance below which the jacobian is considered singular.

Set the default tolerance for a singular jacobian.

Definition at line 1770 of file elements.h.

Referenced by check_jacobian().


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