27 #ifndef OOMPH_TFOEPPLVONKARMAN_DISPLACEMENT_ELEMENTS_HEADER
28 #define OOMPH_TFOEPPLVONKARMAN_DISPLACEMENT_ELEMENTS_HEADER
33 #include <oomph-lib-config.h>
38 #include "../generic/nodes.h"
39 #include "../generic/oomph_utilities.h"
40 #include "../generic/Telements.h"
41 #include "../generic/error_estimator.h"
66 template<
unsigned NNODE_1D>
68 :
public virtual TElement<2, NNODE_1D>,
125 std::list<std::pair<unsigned long, unsigned>>& dof_lookup_list)
const
128 const unsigned n_node = this->
nnode();
131 std::pair<unsigned, unsigned> dof_lookup;
134 for (
unsigned n = 0; n < n_node; n++)
148 dof_lookup.first = this->
eqn_number(local_eqn_number);
151 dof_lookup.second = 2;
154 dof_lookup_list.push_front(dof_lookup);
169 dof_lookup.first = this->
eqn_number(local_eqn_number);
172 if (
node_pt(n)->is_on_boundary(0) ||
node_pt(n)->is_on_boundary(1))
174 dof_lookup.second = 1;
179 dof_lookup.second = 0;
183 dof_lookup_list.push_front(dof_lookup);
198 dof_lookup.first = this->
eqn_number(local_eqn_number);
201 dof_lookup.second = 3;
204 dof_lookup_list.push_front(dof_lookup);
219 dof_lookup.first = this->
eqn_number(local_eqn_number);
222 dof_lookup.second = 4;
225 dof_lookup_list.push_front(dof_lookup);
240 void output(std::ostream& outfile,
const unsigned& n_plot)
256 void output(FILE* file_pt,
const unsigned& n_plot)
265 const unsigned& n_plot,
269 outfile, n_plot, exact_soln_pt);
276 const unsigned& n_plot,
281 outfile, n_plot, time, exact_soln_pt);
306 return (NNODE_1D - 1);
348 template<
unsigned NNODE_1D>
356 unsigned n_node = this->nnode();
359 double J = this->dshape_eulerian(
s, psi, dpsidx);
363 for (
unsigned i = 0;
i < n_node;
i++)
366 dtestdx(
i, 0) = dpsidx(
i, 0);
367 dtestdx(
i, 1) = dpsidx(
i, 1);
381 template<
unsigned NNODE_1D>
383 NNODE_1D>::dshape_and_dtest_eulerian_at_knot_fvk(
const unsigned& ipt,
390 double J = this->dshape_eulerian_at_knot(ipt, psi, dpsidx);
407 template<
unsigned NNODE_1D>
409 :
public virtual TElement<1, NNODE_1D>
A Class for the derivatives of shape functions The class design is essentially the same as Shape,...
A class for all isoparametric elements that solve the Foeppl von Karman equations.
void output_fct(std::ostream &outfile, const unsigned &n_plot, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt)
Output exact soln: x,y,w_exact at n_plot^DIM plot points.
void output(std::ostream &outfile)
Output with default number of plot points.
void get_gradient_of_deflection(const Vector< double > &s, Vector< double > &gradient) const
Get gradient of deflection: gradient[i] = dw/dx_i.
Base class for finite elements that can compute the quantities that are required for the Z2 error est...
FaceGeometry()
Constructor: Call the constructor for the appropriate lower-dimensional TElement.
//////////////////////////////////////////////////////////////////// ////////////////////////////////...
Node *& node_pt(const unsigned &n)
Return a pointer to the local node n.
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.
unsigned nnode() const
Return the number of nodes.
void(* SteadyExactSolutionFctPt)(const Vector< double > &, Vector< double > &)
Function pointer for function that computes vector-valued steady "exact solution" as .
void(* UnsteadyExactSolutionFctPt)(const double &, const Vector< double > &, Vector< double > &)
Function pointer for function that computes Vector-valued time-dependent function as .
unsigned long eqn_number(const unsigned &ieqn_local) const
Return the global equation number corresponding to the ieqn_local-th local equation number.
int local_eqn_number(const unsigned long &ieqn_global) const
Return the local equation number corresponding to the ieqn_global-th global equation number....
Nodes are derived from Data, but, in addition, have a definite (Eulerian) position in a space of a gi...
A Class for shape functions. In simple cases, the shape functions have only one index that can be tho...
//////////////////////////////////////////////////////////////////////
void operator=(const TDisplacementBasedFoepplvonKarmanElement< NNODE_1D > &)=delete
Broken assignment operator.
TDisplacementBasedFoepplvonKarmanElement()
Constructor: Call constructors for TElement and Foeppl von Karman equations.
void output(FILE *file_pt, const unsigned &n_plot)
C-style output function: x,y,w at n_plot^2 plot points.
unsigned num_Z2_flux_terms()
Number of 'flux' terms for Z2 error estimation.
void output(std::ostream &outfile)
Output function: x,y,w.
double dshape_and_dtest_eulerian_fvk(const Vector< double > &s, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const
Shape, test functions & derivs. w.r.t. to global coords. Return Jacobian.
static const unsigned Initial_Nvalue
Static unsigned that holds the (same) number of variables at every node.
void output(FILE *file_pt)
C-style output function: x,y,w.
unsigned required_nvalue(const unsigned &n) const
Access function for Nvalue: # of ‘values’ (pinned or dofs) at node n (always returns the same value a...
unsigned ndof_types() const
The number of dof types that degrees of freedom in this element are sub-divided into.
unsigned nvertex_node() const
Number of vertex nodes in the element.
void get_Z2_flux(const Vector< double > &s, Vector< double > &flux)
Get 'flux' for Z2 error recovery: Standard flux.from FvK equations.
void output_fct(std::ostream &outfile, const unsigned &n_plot, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt)
Output function for an exact solution: x,y,w_exact.
void output(std::ostream &outfile, const unsigned &n_plot)
Output function: x,y,w at n_plot^2 plot points.
Node * vertex_node_pt(const unsigned &j) const
Pointer to the j-th vertex node in the element.
double dshape_and_dtest_eulerian_at_knot_fvk(const unsigned &ipt, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const
Shape, test functions & derivs. w.r.t. to global coords. Return Jacobian.
TDisplacementBasedFoepplvonKarmanElement(const TDisplacementBasedFoepplvonKarmanElement< NNODE_1D > &dummy)=delete
Broken copy constructor.
void output_fct(std::ostream &outfile, const unsigned &n_plot, const double &time, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt)
Output function for a time-dependent exact solution. x,y,w_exact (calls the steady version)
void get_dof_numbers_for_unknowns(std::list< std::pair< unsigned long, unsigned >> &dof_lookup_list) const
Create a list of pairs for all unknowns in this element, so that the first entry in each pair contain...
unsigned nrecovery_order()
Order of recovery shape functions for Z2 error estimation: Same order as shape functions.
//////////////////////////////////////////////////////////////////// ////////////////////////////////...