32 #ifndef OOMPH_GENERALISED_NEWTONIAN_TAXISYM_NAVIER_STOKES_ELEMENTS_HEADER    33 #define OOMPH_GENERALISED_NEWTONIAN_TAXISYM_NAVIER_STOKES_ELEMENTS_HEADER    37 #include <oomph-lib-config.h>    45 #include "../generic/Telements.h"    46 #include "../generic/error_estimator.h"   154     "GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement");
   161     "GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement");
   202   std::set<std::pair<Data*,unsigned> > &paired_pressure_data);
   209  void output(std::ostream &outfile, 
const unsigned &nplot)
   218  void output(FILE* file_pt, 
const unsigned &n_plot)
   247    unsigned num_entries=6;
   248     if (flux.size() < num_entries)
   250       std::ostringstream error_message;
   251       error_message << 
"The flux vector has the wrong number of entries, "    252       << flux.size() << 
", whereas it should be at least "    253       << num_entries << std::endl;
   255                           OOMPH_CURRENT_FUNCTION,
   256                           OOMPH_EXCEPTION_LOCATION);
   268   for(
unsigned i=0;
i<3;
i++)
   270     flux[icount]=strainrate(
i,
i);
   275   for(
unsigned i=0;
i<3;
i++)
   277     for(
unsigned j=
i+1;j<3;j++)
   279       flux[icount]=strainrate(
i,j);
   300   std::list<std::pair<unsigned long,unsigned> >& dof_lookup_list)
 const   303    unsigned n_node = this->
nnode();
   309    std::pair<unsigned,unsigned> dof_lookup;
   312    unsigned pressure_dof_number = 3;
   315    for (
unsigned n = 0; n < n_press; n++)
   323      if (local_eqn_number >= 0)
   327        dof_lookup.first = this->
eqn_number(local_eqn_number);
   328        dof_lookup.second = pressure_dof_number;
   331        dof_lookup_list.push_front(dof_lookup);
   336    for (
unsigned n = 0; n < n_node; n++)
   342      for (
unsigned v = 0; v < nv; v++)
   348        if (local_eqn_number >= 0)
   352          dof_lookup.first = this->
eqn_number(local_eqn_number);
   353          dof_lookup.second = v;
   356          dof_lookup_list.push_front(dof_lookup);
   396    const unsigned &ipt, 
Shape &psi,
   428                                                  djacobian_dX,d_dpsidx_dX);
   433   d_dtestdx_dX = d_dpsidx_dX;
   565  static const unsigned Initial_Nvalue[];
   571  static const unsigned Pconv[];
   614  void unpin_all_nodal_pressure_dofs();
   617  void pin_all_nodal_pressure_dofs();
   620  void unpin_proper_nodal_pressure_dofs();
   635     "GeneralisedNewtonianAxisymmetricTTaylorHoodElement");
   642     "GeneralisedNewtonianAxisymmetricTTaylorHoodElement");
   648   {
return Initial_Nvalue[n];}
   699   std::set<std::pair<Data*,unsigned> > &paired_load_data);
   710   std::set<std::pair<Data*,unsigned> > &paired_pressure_data);
   717  void output(std::ostream &outfile, 
const unsigned &nplot)
   726  void output(FILE* file_pt, 
const unsigned &n_plot)
   755   unsigned num_entries=6;
   756   if (flux.size() < num_entries)
   758     std::ostringstream error_message;
   759     error_message << 
"The flux vector has the wrong number of entries, "    760                   << flux.size() << 
", whereas it should be at least "    761                   << num_entries << std::endl;
   763                         OOMPH_CURRENT_FUNCTION,
   764                         OOMPH_EXCEPTION_LOCATION);
   776   for(
unsigned i=0;
i<3;
i++)
   778     flux[icount]=strainrate(
i,
i);
   783   for(
unsigned i=0;
i<3;
i++)
   785     for(
unsigned j=
i+1;j<3;j++)
   787       flux[icount]=strainrate(
i,j);
   807   std::list<std::pair<unsigned long,unsigned> >& dof_lookup_list)
 const   810    unsigned n_node = this->
nnode();
   813    std::pair<unsigned,unsigned> dof_lookup;
   816    for (
unsigned n = 0; n < n_node; n++)
   822      for (
unsigned v = 0; v < nv; v++)
   830        if (local_eqn_number >= 0)
   834          dof_lookup.first = this->
eqn_number(local_eqn_number);
   837          dof_lookup.second = v;
   840          dof_lookup_list.push_front(dof_lookup);
   911                                                  djacobian_dX,d_dpsidx_dX);
   916   d_dtestdx_dX = d_dpsidx_dX;
   937   ppsi[2] = 1.0-s[0]-s[1];
   983  psi[2] = 1.0-s[0]-s[1];
 double value(const unsigned &i) const
Return i-th stored value. This function is not virtual so that it can be inlined. This means that if ...
unsigned nvertex_node() const
Number of vertex nodes in the element. 
void broken_copy(const std::string &class_name)
Issue error message and terminate execution. 
Base class for finite elements that can compute the quantities that are required for the Z2 error est...
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...
double dshape_and_dtest_eulerian_at_knot_axi_nst(const unsigned &ipt, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const
Velocity shape and test functions and their derivs w.r.t. to global coords at ipt-th integation point...
unsigned npres_axi_nst() const
Return number of pressure values. 
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-...
unsigned p_index_axi_nst()
Which nodal value represents the pressure? 
int p_local_eqn(const unsigned &n) const
Pointer to n_p-th pressure node. 
void unpin_all_internal_pressure_dofs()
Unpin all internal pressure dofs. 
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...
GeneralisedNewtonianAxisymmetricTCrouzeix_Raviart elements are. 
unsigned num_Z2_flux_terms()
Number of 'flux' terms for Z2 error estimation. 
double p_axi_nst(const unsigned &n_p) const
Access function for the pressure values at local pressure node n_p (const version) ...
int p_local_eqn(const unsigned &n) const
Return the local equation numbers for the pressure values. 
unsigned nrecovery_order()
Order of recovery shape functions for Z2 error estimation: Same order as shape functions. 
void get_Z2_flux(const Vector< double > &s, Vector< double > &flux)
Get 'flux' for Z2 error recovery: Upper triangular entries in strain rate tensor. ...
virtual double dpshape_and_dptest_eulerian_axi_nst(const Vector< double > &s, Shape &ppsi, DShape &dppsidx, Shape &ptest, DShape &dptestdx) const
Compute the pressure shape and test functions and derivatives w.r.t. global coords at local coordinat...
virtual unsigned required_nvalue(const unsigned &n) const
Number of values (pinned or dofs) required at node n. Can be overwritten for hanging node version...
void operator=(const GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement &)
Broken assignment operator. 
Nodes are derived from Data, but, in addition, have a definite (Eulerian) position in a space of a gi...
void output(FILE *file_pt)
Redirect output to NavierStokesEquations output. 
Node * vertex_node_pt(const unsigned &j) const
Pointer to the j-th vertex node in the element. 
void identify_pressure_data(std::set< std::pair< Data *, unsigned > > &paired_pressure_data)
Add to the set paired_pressure_data pairs containing. 
unsigned nvalue() const
Return number of values stored in data object (incl pinned ones). 
unsigned num_Z2_flux_terms()
Number of 'flux' terms for Z2 error estimation. 
unsigned nvertex_node() const
Number of vertex nodes in the element. 
void output(std::ostream &outfile, const unsigned &nplot)
Redirect output to NavierStokesEquations output. 
void output(FILE *file_pt, const unsigned &n_plot)
Redirect output to NavierStokesEquations output. 
void pin(const unsigned &i)
Pin the i-th stored variable. 
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 function...
GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement()
Constructor, there are 3 internal values (for the pressure) 
GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement(const GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement &dummy)
Broken copy constructor. 
void fix_pressure(const unsigned &p_dof, const double &p_value)
Pin p_dof-th pressure dof and set it to value specified by p_value. 
void output(std::ostream &outfile)
Redirect output to NavierStokesEquations output. 
void identify_load_data(std::set< std::pair< Data *, unsigned > > &paired_load_data)
Add to the set paired_load_data pairs of pointers to data objects and unsignedegers that index the va...
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 ...
int p_nodal_index_axi_nst() const
Set the value at which the pressure is stored in the nodes. 
unsigned ndof_types() const
The number of "DOF types" that degrees of freedom in this element are sub-divided into: Velocities an...
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 c...
void output(FILE *file_pt)
Redirect output to NavierStokesEquations output. 
void set_value(const unsigned &i, const double &value_)
Set the i-th stored data value to specified value. The only reason that we require an explicit set fu...
Data *& internal_data_pt(const unsigned &i)
Return a pointer to i-th internal data object. 
unsigned long eqn_number(const unsigned &ieqn_local) const
Return the global equation number corresponding to the ieqn_local-th local equation number...
FaceGeometry()
Constructor: Call constructor of base. 
GeneralisedNewtonianAxisymmetricTTaylorHoodElement()
Constructor, no internal data points. 
A class that represents a collection of data; each Data object may contain many different individual ...
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 c...
void output(std::ostream &outfile, const unsigned &nplot)
Redirect output to NavierStokesEquations output. 
void operator=(const GeneralisedNewtonianAxisymmetricTTaylorHoodElement &)
Broken assignment operator. 
void strain_rate(const Vector< double > &s, DenseMatrix< double > &strain_rate) const
Strain-rate tensor:  where  (in that order) 
unsigned ndof_types() const
The number of "DOF types" that degrees of freedom in this element are sub-divided into: Velocity and ...
double dshape_and_dtest_eulerian_at_knot_axi_nst(const unsigned &ipt, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const
Velocity shape and test functions and their derivs w.r.t. to global coords at local coordinate s (tak...
Node *& node_pt(const unsigned &n)
Return a pointer to the local node n. 
GeneralisedNewtonianAxisymmetricTTaylorHoodElement(const GeneralisedNewtonianAxisymmetricTTaylorHoodElement &dummy)
Broken copy constructor. 
void output(std::ostream &outfile)
Output function: x,y,[z],u,v,[w],p in tecplot format. Default number of plot points. 
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...
virtual unsigned required_nvalue(const unsigned &n) const
Number of values (pinned or dofs) required at local node n. 
void pshape_axi_nst(const Vector< double > &s, Shape &psi) const
Test whether the pressure dof p_dof hanging or not? 
double dshape_and_dtest_eulerian_axi_nst(const Vector< double > &s, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const
Velocity shape and test functions and their derivs w.r.t. to global coords at local coordinate s (tak...
unsigned npres_axi_nst() const
Return number of pressure values. 
void fix_pressure(const unsigned &p_dof, const double &p_value)
Pin p_dof-th pressure dof and set it to value specified by p_value. 
double p_axi_nst(const unsigned &i) const
Return the pressure values at internal dof i_internal (Discontinous pressure interpolation – no need...
double dpshape_and_dptest_eulerian_axi_nst(const Vector< double > &s, Shape &ppsi, DShape &dppsidx, Shape &ptest, DShape &dptestdx) const
Pressure shape and test functions and their derivs w.r.t. to global coords at local coordinate s (tak...
void broken_assign(const std::string &class_name)
Issue error message and terminate execution. 
double dshape_and_dtest_eulerian_axi_nst(const Vector< double > &s, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const
Velocity shape and test functions and their derivs w.r.t. to global coords at local coordinate s (tak...
Node * vertex_node_pt(const unsigned &j) const
Pointer to the j-th vertex node in the element. 
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 ...
void pshape_axi_nst(const Vector< double > &s, Shape &psi) const
Pressure shape functions at local coordinate s. 
void output(std::ostream &outfile)
Redirect output to NavierStokesEquations output. 
int local_eqn_number(const unsigned long &ieqn_global) const
Return the local equation number corresponding to the ieqn_global-th global equation number...
unsigned nnode() const
Return the number of nodes. 
void output(FILE *file_pt, const unsigned &n_plot)
Redirect output to NavierStokesEquations output. 
unsigned nrecovery_order()
Order of recovery shape functions for Z2 error estimation: Same order as unenriched shape functions...
void get_Z2_flux(const Vector< double > &s, Vector< double > &flux)
Get 'flux' for Z2 error recovery: Upper triangular entries in strain rate tensor. ...
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...
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...
unsigned P_axi_nst_internal_index