32 #ifndef OOMPH_TAXISYM_NAVIER_STOKES_ELEMENTS_HEADER 33 #define OOMPH_TAXISYM_NAVIER_STOKES_ELEMENTS_HEADER 37 #include <oomph-lib-config.h> 42 #include "../generic/Telements.h" 44 #include "../generic/error_estimator.h" 211 std::set<std::pair<Data*,unsigned> > &paired_pressure_data);
218 void output(std::ostream &outfile,
const unsigned &nplot)
226 void output(FILE* file_pt,
const unsigned &n_plot)
254 unsigned num_entries=6;
255 if (flux.size() < num_entries)
257 std::ostringstream error_message;
258 error_message <<
"The flux vector has the wrong number of entries, " 259 << flux.size() <<
", whereas it should be at least " 260 << num_entries << std::endl;
262 OOMPH_CURRENT_FUNCTION,
263 OOMPH_EXCEPTION_LOCATION);
275 for(
unsigned i=0;
i<3;
i++)
277 flux[icount]=strainrate(
i,
i);
282 for(
unsigned i=0;
i<3;
i++)
284 for(
unsigned j=
i+1;j<3;j++)
286 flux[icount]=strainrate(
i,j);
307 std::list<std::pair<unsigned long,unsigned> >& dof_lookup_list)
const 310 unsigned n_node = this->
nnode();
316 std::pair<unsigned,unsigned> dof_lookup;
319 unsigned pressure_dof_number = 3;
322 for (
unsigned n = 0; n < n_press; n++)
330 if (local_eqn_number >= 0)
334 dof_lookup.first = this->
eqn_number(local_eqn_number);
335 dof_lookup.second = pressure_dof_number;
338 dof_lookup_list.push_front(dof_lookup);
343 for (
unsigned n = 0; n < n_node; n++)
349 for (
unsigned v = 0; v < nv; v++)
355 if (local_eqn_number >= 0)
359 dof_lookup.first = this->
eqn_number(local_eqn_number);
360 dof_lookup.second = v;
363 dof_lookup_list.push_front(dof_lookup);
403 const unsigned &ipt,
Shape &psi,
435 djacobian_dX,d_dpsidx_dX);
440 d_dtestdx_dX = d_dpsidx_dX;
569 static const unsigned Initial_Nvalue[];
575 static const unsigned Pconv[];
618 void unpin_all_nodal_pressure_dofs();
621 void pin_all_nodal_pressure_dofs();
624 void unpin_proper_nodal_pressure_dofs();
649 {
return Initial_Nvalue[n];}
712 std::set<std::pair<Data*,unsigned> > &paired_load_data);
723 std::set<std::pair<Data*,unsigned> > &paired_pressure_data);
730 void output(std::ostream &outfile,
const unsigned &nplot)
738 void output(FILE* file_pt,
const unsigned &n_plot)
766 unsigned num_entries=6;
767 if (flux.size() < num_entries)
769 std::ostringstream error_message;
770 error_message <<
"The flux vector has the wrong number of entries, " 771 << flux.size() <<
", whereas it should be at least " 772 << num_entries << std::endl;
774 OOMPH_CURRENT_FUNCTION,
775 OOMPH_EXCEPTION_LOCATION);
787 for(
unsigned i=0;
i<3;
i++)
789 flux[icount]=strainrate(
i,
i);
794 for(
unsigned i=0;
i<3;
i++)
796 for(
unsigned j=
i+1;j<3;j++)
798 flux[icount]=strainrate(
i,j);
818 std::list<std::pair<unsigned long,unsigned> >& dof_lookup_list)
const 821 unsigned n_node = this->
nnode();
824 std::pair<unsigned,unsigned> dof_lookup;
827 for (
unsigned n = 0; n < n_node; n++)
833 for (
unsigned v = 0; v < nv; v++)
841 if (local_eqn_number >= 0)
845 dof_lookup.first = this->
eqn_number(local_eqn_number);
848 dof_lookup.second = v;
851 dof_lookup_list.push_front(dof_lookup);
922 djacobian_dX,d_dpsidx_dX);
927 d_dtestdx_dX = d_dpsidx_dX;
948 ppsi[2] = 1.0-s[0]-s[1];
994 psi[2] = 1.0-s[0]-s[1];
int p_nodal_index_axi_nst() const
Set the value at which the pressure is stored in the nodes.
int p_local_eqn(const unsigned &n) const
Pointer to n_p-th pressure node.
int p_local_eqn(const unsigned &n) const
Return the local equation numbers for the pressure values.
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 ...
void broken_copy(const std::string &class_name)
Issue error message and terminate execution.
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...
Base class for finite elements that can compute the quantities that are required for the Z2 error est...
unsigned num_Z2_flux_terms()
Number of 'flux' terms for Z2 error estimation.
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 nvertex_node() const
Number of vertex nodes in the element.
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...
AxisymmetricTTaylorHoodElement(const AxisymmetricTTaylorHoodElement &dummy)
Broken copy constructor.
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...
void identify_load_data(std::set< std::pair< Data *, unsigned > > &paired_load_data)
Build FaceElements that apply the Robin boundary condition to the pressure advection diffusion proble...
Node * vertex_node_pt(const unsigned &j) const
Pointer to the j-th vertex node in the element.
unsigned nrecovery_order()
Order of recovery shape functions for Z2 error estimation: Same order as unenriched shape functions...
virtual unsigned required_nvalue(const unsigned &n) const
Broken assignment operator.
void output(FILE *file_pt, const unsigned &n_plot)
Redirect output to NavierStokesEquations output.
double p_axi_nst(const unsigned &i) const
Return the pressure values at internal dof i_internal (Discontinous pressure interpolation – no need...
unsigned npres_axi_nst() const
Return number of pressure values.
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...
Nodes are derived from Data, but, in addition, have a definite (Eulerian) position in a space of a gi...
void output(FILE *file_pt, const unsigned &n_plot)
Redirect output to NavierStokesEquations output.
void strain_rate(const Vector< double > &s, DenseMatrix< double > &strain_rate) const
Strain-rate tensor: where (in that order)
unsigned nvalue() const
Return number of values stored in data object (incl pinned ones).
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 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...
void pin(const unsigned &i)
Pin the i-th stored variable.
AxisymmetricTCrouzeixRaviartElement()
Constructor, there are 3 internal values (for the pressure)
unsigned ndof_types() const
The number of "DOF types" that degrees of freedom in this element are sub-divided into: Velocities (3...
void output(FILE *file_pt)
Redirect output to NavierStokesEquations output.
void identify_pressure_data(std::set< std::pair< Data *, unsigned > > &paired_pressure_data)
Add to the set paired_pressure_data pairs containing.
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...
unsigned p_index_axi_nst()
Which nodal value represents the pressure?
AxisymmetricTCrouzeixRaviartElement(const AxisymmetricTCrouzeixRaviartElement &dummy)
Broken copy constructor.
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 ...
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...
double p_axi_nst(const unsigned &n_p) const
Access function for the pressure values at local pressure node n_p (const version) ...
void get_Z2_flux(const Vector< double > &s, Vector< double > &flux)
Get 'flux' for Z2 error recovery: Upper triangular entries in strain rate tensor. ...
void output(std::ostream &outfile)
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...
AxisymmetricTTaylorHoodElement()
Constructor, no internal data points.
void unpin_all_internal_pressure_dofs()
Unpin all internal pressure dofs.
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)
Redirect output to NavierStokesEquations output.
virtual unsigned required_nvalue(const unsigned &n) const
Broken assignment operator.
FaceGeometry()
Constructor: Call constructor of base.
Node *& node_pt(const unsigned &n)
Return a pointer to the local node n.
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...
unsigned ndof_types() const
The number of "DOF types" that degrees of freedom in this element are sub-divided into: Velocity (3 c...
void output(std::ostream &outfile)
Output function: x,y,[z],u,v,[w],p in tecplot format. Default number of plot points.
void output(FILE *file_pt)
Redirect output to NavierStokesEquations output.
unsigned num_Z2_flux_terms()
Number of 'flux' terms for Z2 error estimation.
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...
Node * vertex_node_pt(const unsigned &j) const
Pointer to the j-th vertex node in the element.
void get_Z2_flux(const Vector< double > &s, Vector< double > &flux)
Get 'flux' for Z2 error recovery: Upper triangular entries in strain rate tensor. ...
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 ...
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 nvertex_node() const
Number of vertex nodes in the element.
void pshape_axi_nst(const Vector< double > &s, Shape &psi) const
Pressure shape functions at local coordinate s.
unsigned P_axi_nst_internal_index
void pshape_axi_nst(const Vector< double > &s, Shape &psi) const
Test whether the pressure dof p_dof hanging or not?
unsigned nrecovery_order()
Order of recovery shape functions for Z2 error estimation: Same order as shape functions.
void output(std::ostream &outfile, const unsigned &nplot)
Redirect output to NavierStokesEquations output.
unsigned npres_axi_nst() const
Return number of pressure values.
void output(std::ostream &outfile, const unsigned &nplot)
Redirect output to NavierStokesEquations output.
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.
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 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...
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...