32 #ifndef OOMPH_GENERALISED_NEWTONIAN_TNAVIER_STOKES_ELEMENTS_HEADER 33 #define OOMPH_GENERALISED_NEWTONIAN_TNAVIER_STOKES_ELEMENTS_HEADER 37 #include <oomph-lib-config.h> 42 #include "../generic/Telements.h" 44 #include "../generic/error_estimator.h" 64 template <
unsigned DIM>
176 double p_nst(
const unsigned &
t,
const unsigned &
i)
const 206 std::set<std::pair<Data*,unsigned> > &paired_pressure_data);
213 void output(std::ostream &outfile,
const unsigned &nplot)
221 void output(FILE* file_pt,
const unsigned &n_plot)
241 return DIM + (DIM*(DIM-1))/2;
249 unsigned num_entries=DIM+(DIM*(DIM-1))/2;
250 if (flux.size() < num_entries)
252 std::ostringstream error_message;
253 error_message <<
"The flux vector has the wrong number of entries, " 254 << flux.size() <<
", whereas it should be at least " 255 << num_entries << std::endl;
257 OOMPH_CURRENT_FUNCTION,
258 OOMPH_EXCEPTION_LOCATION);
270 for(
unsigned i=0;
i<DIM;
i++)
272 flux[icount]=strainrate(
i,
i);
277 for(
unsigned i=0;
i<DIM;
i++)
279 for(
unsigned j=
i+1;j<DIM;j++)
281 flux[icount]=strainrate(
i,j);
315 std::list<std::pair<unsigned long,unsigned> >& dof_lookup_list)
const;
327 template<
unsigned DIM>
349 template<
unsigned DIM>
352 const unsigned &ipt,
Shape &psi,
375 template<
unsigned DIM>
391 for(
unsigned i=0;
i<9;
i++)
395 for(
unsigned k=0;k<2;k++)
397 dtestdx(
i,k) = dpsidx(
i,k);
399 for(
unsigned p=0;p<2;p++)
401 for(
unsigned q=0;q<9;q++)
403 d_dtestdx_dX(p,q,
i,k) = d_dpsidx_dX(p,q,
i,k);
656 template<
unsigned DIM>
659 std::list<std::pair<unsigned long,unsigned> >& dof_lookup_list)
const 662 unsigned n_node = this->
nnode();
668 std::pair<unsigned,unsigned> dof_lookup;
671 unsigned pressure_dof_number = DIM;
674 for (
unsigned n = 0; n < n_press; n++)
682 if (local_eqn_number >= 0)
686 dof_lookup.first = this->
eqn_number(local_eqn_number);
687 dof_lookup.second = pressure_dof_number;
690 dof_lookup_list.push_front(dof_lookup);
695 for (
unsigned n = 0; n < n_node; n++)
701 for (
unsigned v = 0; v < nv; v++)
707 if (local_eqn_number >= 0)
711 dof_lookup.first = this->
eqn_number(local_eqn_number);
712 dof_lookup.second = v;
715 dof_lookup_list.push_front(dof_lookup);
733 template <
unsigned DIM>
742 static const unsigned Initial_Nvalue[];
748 static const unsigned Pconv[];
790 void unpin_all_nodal_pressure_dofs();
793 void pin_all_nodal_pressure_dofs();
796 void unpin_proper_nodal_pressure_dofs();
822 {
return Initial_Nvalue[n];}
849 double p_nst(
const unsigned &n_p)
const 854 double p_nst(
const unsigned &
t,
const unsigned &n_p)
const 879 std::set<std::pair<Data*,unsigned> > &paired_load_data);
890 std::set<std::pair<Data*,unsigned> > &paired_pressure_data);
897 void output(std::ostream &outfile,
const unsigned &nplot)
905 void output(FILE* file_pt,
const unsigned &n_plot)
925 return DIM + (DIM*(DIM-1))/2;
933 unsigned num_entries=DIM+(DIM*(DIM-1))/2;
934 if (flux.size() < num_entries)
936 std::ostringstream error_message;
937 error_message <<
"The flux vector has the wrong number of entries, " 938 << flux.size() <<
", whereas it should be at least " 939 << num_entries << std::endl;
941 OOMPH_CURRENT_FUNCTION,
942 OOMPH_EXCEPTION_LOCATION);
954 for(
unsigned i=0;
i<DIM;
i++)
956 flux[icount]=strainrate(
i,
i);
961 for(
unsigned i=0;
i<DIM;
i++)
963 for(
unsigned j=
i+1;j<DIM;j++)
965 flux[icount]=strainrate(
i,j);
985 std::list<std::pair<unsigned long,unsigned> >& dof_lookup_list)
const 988 unsigned n_node = this->
nnode();
991 std::pair<unsigned,unsigned> dof_lookup;
994 for (
unsigned n = 0; n < n_node; n++)
1000 for (
unsigned v = 0; v < nv; v++)
1008 if (local_eqn_number >= 0)
1012 dof_lookup.first = this->
eqn_number(local_eqn_number);
1015 dof_lookup.second = v;
1018 dof_lookup_list.push_front(dof_lookup);
1058 template<
unsigned DIM>
1081 template<
unsigned DIM>
1113 ppsi[2] = 1.0-s[0]-s[1];
1168 ppsi[3] = 1.0-s[0]-s[1]-s[2];
1238 for(
unsigned i=0;
i<6;
i++)
1242 for(
unsigned k=0;k<2;k++)
1244 dtestdx(
i,k) = dpsidx(
i,k);
1246 for(
unsigned p=0;p<2;p++)
1248 for(
unsigned q=0;q<6;q++)
1250 d_dtestdx_dX(p,q,
i,k) = d_dpsidx_dX(p,q,
i,k);
1286 for(
unsigned i=0;
i<10;
i++)
1290 for(
unsigned k=0;k<3;k++)
1292 dtestdx(
i,k) = dpsidx(
i,k);
1294 for(
unsigned p=0;p<3;p++)
1296 for(
unsigned q=0;q<10;q++)
1298 d_dtestdx_dX(p,q,
i,k) = d_dpsidx_dX(p,q,
i,k);
1321 psi[2] = 1.0-s[0]-s[1];
1336 psi[3] = 1.0-s[0]-s[1]-s[2];
1343 template<
unsigned DIM>
void output(FILE *file_pt, const unsigned &n_plot)
Redirect output to NavierStokesEquations output.
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 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...
void broken_copy(const std::string &class_name)
Issue error message and terminate execution.
void output(std::ostream &outfile)
Redirect output to NavierStokesEquations output.
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...
int p_local_eqn(const unsigned &n) const
Return the local equation numbers for the 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-...
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(FILE *file_pt)
Redirect output to NavierStokesEquations output.
unsigned num_Z2_flux_terms()
Number of 'flux' terms for Z2 error estimation.
double dshape_and_dtest_eulerian_at_knot_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...
void full_output(std::ostream &outfile)
Full output function: x,y,[z],u,v,[w],p,du/dt,dv/dt,[dw/dt],dissipation in tecplot format...
unsigned P_nst_internal_index
Node * vertex_node_pt(const unsigned &j) const
Pointer to the j-th vertex node in the element.
FaceGeometry()
Constructor: Call constructor of base.
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 npres_nst() const
Return number of pressure values.
void full_output(std::ostream &outfile)
Full output function: x,y,[z],u,v,[w],p,du/dt,dv/dt,[dw/dt],dissipation in tecplot format...
unsigned nrecovery_order()
Order of recovery shape functions for Z2 error estimation: Same order as unenriched shape functions...
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...
Nodes are derived from Data, but, in addition, have a definite (Eulerian) position in a space of a gi...
double p_nst(const unsigned &n_p) const
Access function for the pressure values at local pressure node n_p (const version) ...
double dshape_and_dtest_eulerian_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...
int p_local_eqn(const unsigned &n) const
Pointer to n_p-th pressure node.
unsigned nvertex_node() const
Number of vertex nodes in the element.
unsigned nvalue() const
Return number of values stored in data object (incl pinned ones).
unsigned ndof_types() const
The number of "DOF types" that degrees of freedom in this element.
void pshape_nst(const Vector< double > &s, Shape &psi) const
Pressure shape functions at local coordinate s.
void pin(const unsigned &i)
Pin the i-th stored variable.
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 dshape_local(const Vector< double > &s, Shape &psi, DShape &dpsids) const
Compute the geometric shape functions and derivatives w.r.t. local coordinates at local coordinate s...
unsigned p_index_nst()
Which nodal value represents the pressure?
void pshape_nst(const Vector< double > &s, Shape &psi) const
Test whether the pressure dof p_dof hanging or not?
void output(FILE *file_pt)
Redirect output to NavierStokesEquations output.
FaceGeometry()
Constructor: Call constructor of base.
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...
virtual double dpshape_and_dptest_eulerian_nst(const Vector< double > &s, Shape &ppsi, DShape &dppsidx, Shape &ptest, DShape &dptestdx) const
Compute the pressure shape and test functions and derivatives.
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...
GeneralisedNewtonianTCrouzeixRaviartElement()
Constructor, there are DIM+1 internal values (for the pressure)
unsigned num_Z2_flux_terms()
Number of 'flux' terms for Z2 error estimation.
GeneralisedNewtonianTCrouzeixRaviartElement(const GeneralisedNewtonianTCrouzeixRaviartElement< DIM > &dummy)
Broken copy constructor.
double dshape_and_dtest_eulerian_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...
double dshape_and_dtest_eulerian_at_knot_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 identify_pressure_data(std::set< std::pair< Data *, unsigned > > &paired_pressure_data)
Add to the set paired_pressure_data pairs containing.
unsigned nrecovery_order()
Order of recovery shape functions for Z2 error estimation: Same order as shape functions.
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...
void strain_rate(const Vector< double > &s, DenseMatrix< double > &strain_rate) const
Strain-rate tensor: 1/2 (du_i/dx_j + du_j/dx_i)
GeneralisedNewtonianTTaylorHoodElement(const GeneralisedNewtonianTTaylorHoodElement< DIM > &dummy)
Broken copy constructor.
A class that represents a collection of data; each Data object may contain many different individual ...
void output(std::ostream &outfile, const unsigned &nplot)
Redirect output to NavierStokesEquations output.
unsigned npres_nst() const
Return number of pressure values.
Node *& node_pt(const unsigned &n)
Return a pointer to the local node n.
void output(FILE *file_pt, const unsigned &n_plot)
Redirect output to NavierStokesEquations output.
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...
void full_output(std::ostream &outfile, const unsigned &nplot)
Full output function: x,y,[z],u,v,[w],p,du/dt,dv/dt,[dw/dt],dissipation in tecplot format...
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_nst(const unsigned &i) const
Return the pressure values at internal dof i_internal (Discontinous pressure interpolation – no need...
Node * vertex_node_pt(const unsigned &j) const
Pointer to the j-th vertex node in the element.
double p_nst(const unsigned &t, const unsigned &n_p) const
Access function for the pressure values at local pressure node n_p (const version) ...
int p_nodal_index_nst() const
Set the value at which the pressure is stored in the nodes.
void output(std::ostream &outfile, const unsigned &nplot)
Redirect output to NavierStokesEquations output.
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 ...
virtual unsigned required_nvalue(const unsigned &n) const
Broken assignment operator.
virtual unsigned required_nvalue(const unsigned &n) const
Broken assignment operator.
unsigned ndof_types() const
The number of "DOF types" that degrees of freedom in this element are sub-divided into: Velocity and ...
void unpin_all_internal_pressure_dofs()
Unpin all internal pressure dofs.
double p_nst(const unsigned &t, const unsigned &i) const
Return the pressure values at internal dof i_internal (Discontinous pressure interpolation – no need...
GeneralisedNewtonianTTaylorHoodElement()
Constructor, no internal data points.
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.
double dpshape_and_dptest_eulerian_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...
unsigned nvertex_node() const
Number of vertex nodes in the element.
void output(std::ostream &outfile)
Output function: x,y,[z],u,v,[w],p in tecplot format. Default number of plot points.
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...