oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM > Class Template Reference

#include <womersley_elements.h>

+ Inheritance diagram for oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >:

Public Member Functions

 NavierStokesImpedanceTractionElement (FiniteElement *const &element_pt, const int &face_index)
 
 ~NavierStokesImpedanceTractionElement ()
 Destructor should not delete anything. More...
 
Mesh *& navier_stokes_outflow_mesh_pt ()
 
double get_volume_flux ()
 Get integral of volume flux through element. More...
 
void set_external_data_from_navier_stokes_outflow_mesh (Mesh *navier_stokes_outflow_mesh_pt)
 
void set_aux_integral_pt (std::map< unsigned, double > *aux_integral_pt)
 
double total_volume_flux_into_downstream_tube ()
 
void set_impedance_tube_pt (TemplateFreeWomersleyImpedanceTubeBase *impedance_tube_pt)
 
void add_element_contribution_to_aux_integral (std::map< unsigned, double > *aux_integral_pt)
 
void fill_in_contribution_to_residuals (Vector< double > &residuals)
 Fill in the element's contribution to the element's residual vector. More...
 
void fill_in_contribution_to_jacobian (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 
double zeta_nodal (const unsigned &n, const unsigned &k, const unsigned &i) const
 
void output (std::ostream &outfile)
 Overload the output function. More...
 
void output (std::ostream &outfile, const unsigned &nplot)
 Output function: x,y,[z],u,v,[w],p in tecplot format. More...
 
- Public Member Functions inherited from oomph::FaceElement
 FaceElement ()
 Constructor: Initialise all appropriate member data. More...
 
virtual ~FaceElement ()
 Empty virtual destructor. More...
 
 FaceElement (const FaceElement &)=delete
 Broken copy constructor. More...
 
const unsignedboundary_number_in_bulk_mesh () const
 Broken assignment operator. More...
 
void set_boundary_number_in_bulk_mesh (const unsigned &b)
 Set function for the boundary number in bulk mesh. More...
 
double J_eulerian (const Vector< double > &s) const
 
double J_eulerian_at_knot (const unsigned &ipt) const
 
void check_J_eulerian_at_knots (bool &passed) const
 
double interpolated_x (const Vector< double > &s, const unsigned &i) const
 
double interpolated_x (const unsigned &t, const Vector< double > &s, const unsigned &i) const
 
void interpolated_x (const Vector< double > &s, Vector< double > &x) const
 
void interpolated_x (const unsigned &t, const Vector< double > &s, Vector< double > &x) const
 
double interpolated_dxdt (const Vector< double > &s, const unsigned &i, const unsigned &t)
 
void interpolated_dxdt (const Vector< double > &s, const unsigned &t, Vector< double > &dxdt)
 
intnormal_sign ()
 
int normal_sign () const
 
intface_index ()
 
int face_index () const
 
const Vector< double > * tangent_direction_pt () const
 Public access function for the tangent direction pointer. More...
 
void set_tangent_direction (Vector< double > *tangent_direction_pt)
 Set the tangent direction vector. More...
 
void turn_on_warning_for_discontinuous_tangent ()
 
void turn_off_warning_for_discontinuous_tangent ()
 
void continuous_tangent_and_outer_unit_normal (const Vector< double > &s, Vector< Vector< double >> &tang_vec, Vector< double > &unit_normal) const
 
void continuous_tangent_and_outer_unit_normal (const unsigned &ipt, Vector< Vector< double >> &tang_vec, Vector< double > &unit_normal) const
 
void outer_unit_normal (const Vector< double > &s, Vector< double > &unit_normal) const
 Compute outer unit normal at the specified local coordinate. More...
 
void outer_unit_normal (const unsigned &ipt, Vector< double > &unit_normal) const
 Compute outer unit normal at ipt-th integration point. More...
 
FiniteElement *& bulk_element_pt ()
 Pointer to higher-dimensional "bulk" element. More...
 
FiniteElementbulk_element_pt () const
 Pointer to higher-dimensional "bulk" element (const version) More...
 
CoordinateMappingFctPtface_to_bulk_coordinate_fct_pt ()
 
CoordinateMappingFctPt face_to_bulk_coordinate_fct_pt () const
 
BulkCoordinateDerivativesFctPtbulk_coordinate_derivatives_fct_pt ()
 
BulkCoordinateDerivativesFctPt bulk_coordinate_derivatives_fct_pt () const
 
Vector< doublelocal_coordinate_in_bulk (const Vector< double > &s) const
 
void get_local_coordinate_in_bulk (const Vector< double > &s, Vector< double > &s_bulk) const
 
void get_ds_bulk_ds_face (const Vector< double > &s, DenseMatrix< double > &dsbulk_dsface, unsigned &interior_direction) const
 
unsignedbulk_position_type (const unsigned &i)
 
const unsignedbulk_position_type (const unsigned &i) const
 
void bulk_node_number_resize (const unsigned &i)
 Resize the storage for the bulk node numbers. More...
 
unsignedbulk_node_number (const unsigned &n)
 
const unsignedbulk_node_number (const unsigned &n) const
 
void bulk_position_type_resize (const unsigned &i)
 Resize the storage for bulk_position_type to i entries. More...
 
unsignednbulk_value (const unsigned &n)
 
unsigned nbulk_value (const unsigned &n) const
 
void nbulk_value_resize (const unsigned &i)
 
void resize_nodes (Vector< unsigned > &nadditional_data_values)
 
void output_zeta (std::ostream &outfile, const unsigned &nplot)
 Output boundary coordinate zeta. More...
 
- Public Member Functions inherited from oomph::FiniteElement
void set_dimension (const unsigned &dim)
 
void set_nodal_dimension (const unsigned &nodal_dim)
 
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)
 
int nodal_local_eqn (const unsigned &n, const unsigned &i) const
 
double dJ_eulerian_at_knot (const unsigned &ipt, Shape &psi, DenseMatrix< double > &djacobian_dX) const
 
 FiniteElement ()
 Constructor. More...
 
virtual ~FiniteElement ()
 
 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
 
void get_centre_of_gravity_and_max_radius_in_terms_of_zeta (Vector< double > &cog, double &max_radius) const
 
virtual void local_coordinate_of_node (const unsigned &j, Vector< double > &s) const
 
virtual void local_fraction_of_node (const unsigned &j, Vector< double > &s_fraction)
 
virtual double local_one_d_fraction_of_node (const unsigned &n1d, const unsigned &i)
 
virtual void set_macro_elem_pt (MacroElement *macro_elem_pt)
 
MacroElementmacro_elem_pt ()
 Access function to pointer to macro element. More...
 
void get_x (const Vector< double > &s, Vector< double > &x) const
 
void get_x (const unsigned &t, const Vector< double > &s, Vector< double > &x)
 
virtual void get_x_from_macro_element (const Vector< double > &s, Vector< double > &x) const
 
virtual void get_x_from_macro_element (const unsigned &t, const Vector< double > &s, Vector< double > &x)
 
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
 
virtual void shape_at_knot (const unsigned &ipt, Shape &psi) const
 
virtual void dshape_local (const Vector< double > &s, Shape &psi, DShape &dpsids) const
 
virtual void dshape_local_at_knot (const unsigned &ipt, Shape &psi, DShape &dpsids) const
 
virtual void d2shape_local (const Vector< double > &s, Shape &psi, DShape &dpsids, DShape &d2psids) const
 
virtual void d2shape_local_at_knot (const unsigned &ipt, Shape &psi, DShape &dpsids, DShape &d2psids) const
 
void check_J_eulerian_at_knots (bool &passed) const
 
void check_jacobian (const double &jacobian) const
 
double dshape_eulerian (const Vector< double > &s, Shape &psi, DShape &dpsidx) const
 
virtual double dshape_eulerian_at_knot (const unsigned &ipt, Shape &psi, DShape &dpsidx) const
 
virtual double dshape_eulerian_at_knot (const unsigned &ipt, Shape &psi, DShape &dpsi, DenseMatrix< double > &djacobian_dX, RankFourTensor< double > &d_dpsidx_dX) const
 
double d2shape_eulerian (const Vector< double > &s, Shape &psi, DShape &dpsidx, DShape &d2psidx) const
 
virtual double d2shape_eulerian_at_knot (const unsigned &ipt, Shape &psi, DShape &dpsidx, DShape &d2psidx) const
 
virtual void assign_nodal_local_eqn_numbers (const bool &store_local_dof_pt)
 
virtual void describe_local_dofs (std::ostream &out, const std::string &current_string) const
 
virtual void describe_nodal_local_dofs (std::ostream &out, const std::string &current_string) const
 
virtual void assign_all_generic_local_eqn_numbers (const bool &store_local_dof_pt)
 
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
 
double raw_nodal_position (const unsigned &n, const unsigned &i) const
 
double raw_nodal_position (const unsigned &t, const unsigned &n, const unsigned &i) const
 
double raw_dnodal_position_dt (const unsigned &n, const unsigned &i) const
 
double raw_dnodal_position_dt (const unsigned &n, const unsigned &j, const unsigned &i) const
 
double raw_nodal_position_gen (const unsigned &n, const unsigned &k, const unsigned &i) const
 
double raw_nodal_position_gen (const unsigned &t, const unsigned &n, const unsigned &k, const unsigned &i) const
 
double raw_dnodal_position_gen_dt (const unsigned &n, const unsigned &k, const unsigned &i) const
 
double raw_dnodal_position_gen_dt (const unsigned &j, const unsigned &n, const unsigned &k, const unsigned &i) const
 
double nodal_position (const unsigned &n, const unsigned &i) const
 
double nodal_position (const unsigned &t, const unsigned &n, const unsigned &i) const
 
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
 
double nodal_position_gen (const unsigned &n, const unsigned &k, const unsigned &i) const
 
double nodal_position_gen (const unsigned &t, const unsigned &n, const unsigned &k, const unsigned &i) const
 
double dnodal_position_gen_dt (const unsigned &n, const unsigned &k, const unsigned &i) const
 
double dnodal_position_gen_dt (const unsigned &j, const unsigned &n, const unsigned &k, const unsigned &i) const
 
virtual void get_dresidual_dnodal_coordinates (RankThreeTensor< double > &dresidual_dnodal_coordinates)
 
virtual void disable_ALE ()
 
virtual void enable_ALE ()
 
virtual unsigned required_nvalue (const unsigned &n) const
 
unsigned nnodal_position_type () const
 
bool has_hanging_nodes () const
 
unsigned nodal_dimension () const
 Return the required Eulerian dimension of the nodes in this element. More...
 
virtual unsigned nvertex_node () const
 
virtual Nodevertex_node_pt (const unsigned &j) const
 
virtual Nodeconstruct_node (const unsigned &n)
 
virtual Nodeconstruct_node (const unsigned &n, TimeStepper *const &time_stepper_pt)
 
virtual Nodeconstruct_boundary_node (const unsigned &n)
 
virtual Nodeconstruct_boundary_node (const unsigned &n, TimeStepper *const &time_stepper_pt)
 
int get_node_number (Node *const &node_pt) const
 
virtual Nodeget_node_at_local_coordinate (const Vector< double > &s) const
 
double raw_nodal_value (const unsigned &n, const unsigned &i) const
 
double raw_nodal_value (const unsigned &t, const unsigned &n, const unsigned &i) const
 
double nodal_value (const unsigned &n, const unsigned &i) const
 
double nodal_value (const unsigned &t, const unsigned &n, const unsigned &i) const
 
unsigned dim () const
 
virtual ElementGeometry::ElementGeometry element_geometry () const
 Return the geometry type of the element (either Q or T usually). More...
 
unsigned ngeom_data () const
 
Datageom_data_pt (const unsigned &j)
 
void position (const Vector< double > &zeta, Vector< double > &r) const
 
void position (const unsigned &t, const Vector< double > &zeta, Vector< double > &r) const
 
void dposition_dt (const Vector< double > &zeta, const unsigned &t, Vector< double > &drdt)
 
void interpolated_zeta (const Vector< double > &s, Vector< double > &zeta) const
 
void locate_zeta (const Vector< double > &zeta, GeomObject *&geom_object_pt, Vector< double > &s, const bool &use_coordinate_as_initial_guess=false)
 
virtual void node_update ()
 
virtual void identify_field_data_for_interactions (std::set< std::pair< Data *, unsigned >> &paired_field_data)
 
virtual void identify_geometric_data (std::set< Data * > &geometric_data_pt)
 
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
 
virtual double compute_physical_size () const
 
virtual void point_output_data (const Vector< double > &s, Vector< double > &data)
 
void point_output (std::ostream &outfile, const Vector< double > &s)
 
virtual unsigned nplot_points_paraview (const unsigned &nplot) const
 
virtual unsigned nsub_elements_paraview (const unsigned &nplot) const
 
void output_paraview (std::ofstream &file_out, const unsigned &nplot) const
 
virtual void write_paraview_output_offset_information (std::ofstream &file_out, const unsigned &nplot, unsigned &counter) const
 
virtual void write_paraview_type (std::ofstream &file_out, const unsigned &nplot) const
 
virtual void write_paraview_offsets (std::ofstream &file_out, const unsigned &nplot, unsigned &offset_sum) const
 
virtual unsigned nscalar_paraview () const
 
virtual void scalar_value_paraview (std::ofstream &file_out, const unsigned &i, const unsigned &nplot) const
 
virtual void scalar_value_fct_paraview (std::ofstream &file_out, const unsigned &i, const unsigned &nplot, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt) const
 
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
 
virtual std::string scalar_name_paraview (const unsigned &i) const
 
virtual void output (const unsigned &t, std::ostream &outfile, const unsigned &n_plot) const
 
virtual void output (FILE *file_pt)
 
virtual void output (FILE *file_pt, const unsigned &n_plot)
 
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
 
virtual std::string tecplot_zone_string (const unsigned &nplot) const
 
virtual void write_tecplot_zone_footer (std::ostream &outfile, const unsigned &nplot) const
 
virtual void write_tecplot_zone_footer (FILE *file_pt, const unsigned &nplot) const
 
virtual unsigned nplot_points (const unsigned &nplot) const
 
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)
 
virtual void compute_error (FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, Vector< double > &error, Vector< double > &norm)
 
virtual void compute_error (std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, double &error, double &norm)
 
virtual void compute_error (std::ostream &outfile, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, double &error, double &norm)
 
virtual void compute_error (std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, Vector< double > &error, Vector< double > &norm)
 
virtual void compute_error (std::ostream &outfile, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, Vector< double > &error, Vector< double > &norm)
 
virtual void compute_abs_error (std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, double &error)
 
void integrate_fct (FiniteElement::SteadyExactSolutionFctPt integrand_fct_pt, Vector< double > &integral)
 Integrate Vector-valued function over element. More...
 
void integrate_fct (FiniteElement::UnsteadyExactSolutionFctPt integrand_fct_pt, const double &time, Vector< double > &integral)
 Integrate Vector-valued time-dep function over element. More...
 
virtual void build_face_element (const int &face_index, FaceElement *face_element_pt)
 
virtual unsigned self_test ()
 
virtual unsigned get_bulk_node_number (const int &face_index, const unsigned &i) const
 
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
 
virtual BulkCoordinateDerivativesFctPt bulk_coordinate_derivatives_fct_pt (const int &face_index) const
 
- Public Member Functions inherited from oomph::GeneralisedElement
 GeneralisedElement ()
 Constructor: Initialise all pointers and all values to zero. More...
 
virtual ~GeneralisedElement ()
 Virtual destructor to clean up any memory allocated by the object. More...
 
 GeneralisedElement (const GeneralisedElement &)=delete
 Broken copy constructor. 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
 
int local_eqn_number (const unsigned long &ieqn_global) const
 
unsigned add_external_data (Data *const &data_pt, const bool &fd=true)
 
bool external_data_fd (const unsigned &i) const
 
void exclude_external_data_fd (const unsigned &i)
 
void include_external_data_fd (const unsigned &i)
 
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)
 
void assign_internal_eqn_numbers (unsigned long &global_number, Vector< double * > &Dof_pt)
 
void describe_dofs (std::ostream &out, const std::string &current_string) const
 
void add_internal_value_pt_to_map (std::map< unsigned, double * > &map_of_value_pt)
 
virtual void assign_local_eqn_numbers (const bool &store_local_dof_pt)
 
virtual void complete_setup_of_dependencies ()
 
virtual void get_residuals (Vector< double > &residuals)
 
virtual void get_jacobian (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 
virtual void get_mass_matrix (Vector< double > &residuals, DenseMatrix< double > &mass_matrix)
 
virtual void get_jacobian_and_mass_matrix (Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix)
 
virtual void get_dresiduals_dparameter (double *const &parameter_pt, Vector< double > &dres_dparam)
 
virtual void get_djacobian_dparameter (double *const &parameter_pt, Vector< double > &dres_dparam, DenseMatrix< double > &djac_dparam)
 
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)
 
virtual void get_hessian_vector_products (Vector< double > const &Y, DenseMatrix< double > const &C, DenseMatrix< double > &product)
 
virtual void get_inner_products (Vector< std::pair< unsigned, unsigned >> const &history_index, Vector< double > &inner_product)
 
virtual void get_inner_product_vectors (Vector< unsigned > const &history_index, Vector< Vector< double >> &inner_product_vector)
 
virtual void compute_norm (Vector< double > &norm)
 
virtual void compute_norm (double &norm)
 
virtual unsigned ndof_types () const
 
virtual void get_dof_numbers_for_unknowns (std::list< std::pair< unsigned long, unsigned >> &dof_lookup_list) const
 
- Public Member Functions inherited from oomph::GeomObject
 GeomObject ()
 Default constructor. More...
 
 GeomObject (const unsigned &ndim)
 
 GeomObject (const unsigned &nlagrangian, const unsigned &ndim)
 
 GeomObject (const unsigned &nlagrangian, const unsigned &ndim, TimeStepper *time_stepper_pt)
 
 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 ()
 
TimeSteppertime_stepper_pt () const
 
virtual void position (const double &t, const Vector< double > &zeta, Vector< double > &r) const
 
virtual void dposition (const Vector< double > &zeta, DenseMatrix< double > &drdzeta) const
 
virtual void d2position (const Vector< double > &zeta, RankThreeTensor< double > &ddrdzeta) const
 
virtual void d2position (const Vector< double > &zeta, Vector< double > &r, DenseMatrix< double > &drdzeta, RankThreeTensor< double > &ddrdzeta) const
 
- Public Member Functions inherited from oomph::NavierStokesImpedanceTractionElementBase
 NavierStokesImpedanceTractionElementBase ()
 
virtual ~NavierStokesImpedanceTractionElementBase ()
 Empty vitual destructor. More...
 

Protected Member Functions

virtual int u_local_eqn (const unsigned &n, const unsigned &i)
 
double shape_and_test_at_knot (const unsigned &ipt, Shape &psi, Shape &test) const
 
void fill_in_generic_residual_contribution_fluid_traction (Vector< double > &residuals, DenseMatrix< double > &jacobian, unsigned flag)
 
- Protected Member Functions inherited from oomph::FaceElement
void add_additional_values (const Vector< unsigned > &nadditional_values, const unsigned &id)
 
- Protected Member Functions inherited from oomph::FiniteElement
virtual void assemble_local_to_eulerian_jacobian (const DShape &dpsids, DenseMatrix< double > &jacobian) const
 
virtual void assemble_local_to_eulerian_jacobian2 (const DShape &d2psids, DenseMatrix< double > &jacobian2) const
 
virtual void assemble_eulerian_base_vectors (const DShape &dpsids, DenseMatrix< double > &interpolated_G) const
 
template<unsigned DIM>
double invert_jacobian (const DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 
virtual double invert_jacobian_mapping (const DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 
virtual double local_to_eulerian_mapping (const DShape &dpsids, DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 
double local_to_eulerian_mapping (const DShape &dpsids, DenseMatrix< double > &inverse_jacobian) const
 
virtual double local_to_eulerian_mapping_diagonal (const DShape &dpsids, DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 
virtual void dJ_eulerian_dnodal_coordinates (const DenseMatrix< double > &jacobian, const DShape &dpsids, DenseMatrix< double > &djacobian_dX) const
 
template<unsigned DIM>
void dJ_eulerian_dnodal_coordinates_templated_helper (const DenseMatrix< double > &jacobian, const DShape &dpsids, DenseMatrix< double > &djacobian_dX) const
 
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
 
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
 
virtual void transform_derivatives (const DenseMatrix< double > &inverse_jacobian, DShape &dbasis) const
 
void transform_derivatives_diagonal (const DenseMatrix< double > &inverse_jacobian, DShape &dbasis) const
 
virtual void transform_second_derivatives (const DenseMatrix< double > &jacobian, const DenseMatrix< double > &inverse_jacobian, const DenseMatrix< double > &jacobian2, DShape &dbasis, DShape &d2basis) const
 
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
 
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
 
virtual void fill_in_jacobian_from_nodal_by_fd (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 
void fill_in_jacobian_from_nodal_by_fd (DenseMatrix< double > &jacobian)
 
virtual void update_before_nodal_fd ()
 
virtual void reset_after_nodal_fd ()
 
virtual void update_in_nodal_fd (const unsigned &i)
 
virtual void reset_in_nodal_fd (const unsigned &i)
 
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
 
template<>
void dJ_eulerian_dnodal_coordinates_templated_helper (const DenseMatrix< double > &jacobian, const DShape &dpsids, DenseMatrix< double > &djacobian_dX) const
 
template<>
void dJ_eulerian_dnodal_coordinates_templated_helper (const DenseMatrix< double > &jacobian, const DShape &dpsids, DenseMatrix< double > &djacobian_dX) const
 
template<>
void dJ_eulerian_dnodal_coordinates_templated_helper (const DenseMatrix< double > &jacobian, const DShape &dpsids, DenseMatrix< double > &djacobian_dX) const
 
template<>
void dJ_eulerian_dnodal_coordinates_templated_helper (const DenseMatrix< double > &jacobian, const DShape &dpsids, DenseMatrix< double > &djacobian_dX) const
 
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
 
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
 
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
 
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
 
template<>
void transform_second_derivatives_template (const DenseMatrix< double > &jacobian, const DenseMatrix< double > &inverse_jacobian, const DenseMatrix< double > &jacobian2, DShape &dbasis, DShape &d2basis) const
 
template<>
void transform_second_derivatives_template (const DenseMatrix< double > &jacobian, const DenseMatrix< double > &inverse_jacobian, const DenseMatrix< double > &jacobian2, DShape &dbasis, DShape &d2basis) const
 
template<>
void transform_second_derivatives_diagonal (const DenseMatrix< double > &jacobian, const DenseMatrix< double > &inverse_jacobian, const DenseMatrix< double > &jacobian2, DShape &dbasis, DShape &d2basis) const
 
template<>
void transform_second_derivatives_diagonal (const DenseMatrix< double > &jacobian, const DenseMatrix< double > &inverse_jacobian, const DenseMatrix< double > &jacobian2, DShape &dbasis, DShape &d2basis) const
 
- Protected Member Functions inherited from oomph::GeneralisedElement
unsigned add_internal_data (Data *const &data_pt, const bool &fd=true)
 
bool internal_data_fd (const unsigned &i) const
 
void exclude_internal_data_fd (const unsigned &i)
 
void include_internal_data_fd (const unsigned &i)
 
void clear_global_eqn_numbers ()
 
void add_global_eqn_numbers (std::deque< unsigned long > const &global_eqn_numbers, std::deque< double * > const &global_dof_pt)
 
virtual void assign_internal_and_external_local_eqn_numbers (const bool &store_local_dof_pt)
 
virtual void assign_additional_local_eqn_numbers ()
 
int internal_local_eqn (const unsigned &i, const unsigned &j) const
 
int external_local_eqn (const unsigned &i, const unsigned &j)
 
void fill_in_jacobian_from_internal_by_fd (Vector< double > &residuals, DenseMatrix< double > &jacobian, const bool &fd_all_data=false)
 
void fill_in_jacobian_from_internal_by_fd (DenseMatrix< double > &jacobian, const bool &fd_all_data=false)
 
void fill_in_jacobian_from_external_by_fd (Vector< double > &residuals, DenseMatrix< double > &jacobian, const bool &fd_all_data=false)
 
void fill_in_jacobian_from_external_by_fd (DenseMatrix< double > &jacobian, const bool &fd_all_data=false)
 
virtual void update_before_internal_fd ()
 
virtual void reset_after_internal_fd ()
 
virtual void update_in_internal_fd (const unsigned &i)
 
virtual void reset_in_internal_fd (const unsigned &i)
 
virtual void update_before_external_fd ()
 
virtual void reset_after_external_fd ()
 
virtual void update_in_external_fd (const unsigned &i)
 
virtual void reset_in_external_fd (const unsigned &i)
 
virtual void fill_in_contribution_to_mass_matrix (Vector< double > &residuals, DenseMatrix< double > &mass_matrix)
 
virtual void fill_in_contribution_to_jacobian_and_mass_matrix (Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix)
 
virtual void fill_in_contribution_to_dresiduals_dparameter (double *const &parameter_pt, Vector< double > &dres_dparam)
 
virtual void fill_in_contribution_to_djacobian_dparameter (double *const &parameter_pt, Vector< double > &dres_dparam, DenseMatrix< double > &djac_dparam)
 
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)
 
virtual void fill_in_contribution_to_hessian_vector_products (Vector< double > const &Y, DenseMatrix< double > const &C, DenseMatrix< double > &product)
 
virtual void fill_in_contribution_to_inner_products (Vector< std::pair< unsigned, unsigned >> const &history_index, Vector< double > &inner_product)
 
virtual void fill_in_contribution_to_inner_product_vectors (Vector< unsigned > const &history_index, Vector< Vector< double >> &inner_product_vector)
 

Private Attributes

std::map< unsigned, double > * Aux_integral_pt
 
WomersleyImpedanceTubeBase< WOMERSLEY_ELEMENT, DIM > * Impedance_tube_pt
 Pointer to ImpedanceTubeProblem that computes the flow resistance. More...
 

Additional Inherited Members

- Public Types inherited from oomph::FiniteElement
typedef void(* SteadyExactSolutionFctPt) (const Vector< double > &, Vector< double > &)
 
typedef void(* UnsteadyExactSolutionFctPt) (const double &, const Vector< double > &, Vector< double > &)
 
- Static Public Attributes inherited from oomph::FiniteElement
static double Tolerance_for_singular_jacobian = 1.0e-16
 Tolerance below which the jacobian is considered singular. More...
 
static bool Accept_negative_jacobian = false
 
static bool Suppress_output_while_checking_for_inverted_elements
 
- Static Public Attributes inherited from oomph::GeneralisedElement
static bool Suppress_warning_about_repeated_internal_data
 
static bool Suppress_warning_about_repeated_external_data = true
 
static double Default_fd_jacobian_step = 1.0e-8
 
- Protected Attributes inherited from oomph::FaceElement
unsigned Boundary_number_in_bulk_mesh
 The boundary number in the bulk mesh to which this element is attached. More...
 
FiniteElementBulk_element_pt
 Pointer to the associated higher-dimensional "bulk" element. More...
 
Vector< unsignedBulk_node_number
 
Vector< unsignedNbulk_value
 
Vector< double > * Tangent_direction_pt
 
- Protected Attributes inherited from oomph::FiniteElement
MacroElementMacro_elem_pt
 Pointer to the element's macro element (NULL by default) 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
 
- Protected Attributes inherited from oomph::NavierStokesImpedanceTractionElementBase
MeshNavier_stokes_outflow_mesh_pt
 
- Static Protected Attributes inherited from oomph::FiniteElement
static const unsigned Default_Initial_Nvalue = 0
 Default value for the number of values at a node. More...
 
static const double Node_location_tolerance = 1.0e-14
 
static const unsigned N2deriv [] = {0, 1, 3, 6}
 
- Static Protected Attributes inherited from oomph::GeneralisedElement
static DenseMatrix< doubleDummy_matrix
 
static std::deque< double * > Dof_pt_deque
 

Detailed Description

template<class BULK_NAVIER_STOKES_ELEMENT, class WOMERSLEY_ELEMENT, unsigned DIM>
class oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >

///////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////// A class for elements that allow the imposition of an impedance type traction boundary condition to the Navier–Stokes equations The geometrical information can be read from the FaceGeometery<ELEMENT> class and and thus, we can be generic enough without the need to have a separate equations class. Template arguments specify the type of the bulk Navier Stokes elements that the elements are attached to, and the type of the Womersley element used to compute the flow resistance in the downstream "impedance tube".

Constructor & Destructor Documentation

◆ NavierStokesImpedanceTractionElement()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::NavierStokesImpedanceTractionElement ( FiniteElement *const &  element_pt,
const int face_index 
)
inline

Constructor, which takes a "bulk" element and the value of the index and its limit

2037  : FaceGeometry<BULK_NAVIER_STOKES_ELEMENT>(), FaceElement()
2038  {
2039  // Attach the geometrical information to the element. N.B. This function
2040  // also assigns nbulk_value from the required_nvalue of the bulk element
2041  element_pt->build_face_element(face_index, this);
2042 
2043  // Initialise pointer to mesh containing the
2044  // NavierStokesImpedanceTractionElements
2045  // that contribute to the volume flux into the "downstream tube" that
2046  // provides the impedance
2048 
2049  // Initialise pointer to impedance tube
2050  Impedance_tube_pt = 0;
2051 
2052  // Initialise pointer to auxiliary integral
2053  Aux_integral_pt = 0;
2054 
2055  // Set the dimension from the dimension of the first node
2056  // Dim = this->node_pt(0)->ndim();
2057 
2058 #ifdef PARANOID
2059  {
2060  // Check that the element is not a refineable 3d element
2061  BULK_NAVIER_STOKES_ELEMENT* elem_pt =
2062  dynamic_cast<BULK_NAVIER_STOKES_ELEMENT*>(element_pt);
2063  // If it's three-d
2064  if (elem_pt->dim() == 3)
2065  {
2066  // Is it refineable
2067  RefineableElement* ref_el_pt =
2068  dynamic_cast<RefineableElement*>(elem_pt);
2069  if (ref_el_pt != 0)
2070  {
2071  if (this->has_hanging_nodes())
2072  {
2073  throw OomphLibError("This flux element will not work correctly "
2074  "if nodes are hanging\n",
2077  }
2078  }
2079  }
2080  }
2081 #endif
2082  }
int & face_index()
Definition: elements.h:4626
FaceElement()
Constructor: Initialise all appropriate member data.
Definition: elements.h:4446
bool has_hanging_nodes() const
Definition: elements.h:2470
Mesh * Navier_stokes_outflow_mesh_pt
Definition: womersley_elements.h:143
WomersleyImpedanceTubeBase< WOMERSLEY_ELEMENT, DIM > * Impedance_tube_pt
Pointer to ImpedanceTubeProblem that computes the flow resistance.
Definition: womersley_elements.h:1988
std::map< unsigned, double > * Aux_integral_pt
Definition: womersley_elements.h:1985
#define OOMPH_EXCEPTION_LOCATION
Definition: oomph_definitions.h:61
#define OOMPH_CURRENT_FUNCTION
Definition: oomph_definitions.h:86

References oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::Aux_integral_pt, oomph::FiniteElement::build_face_element(), oomph::FaceElement::face_index(), oomph::FiniteElement::has_hanging_nodes(), oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::Impedance_tube_pt, oomph::NavierStokesImpedanceTractionElementBase::Navier_stokes_outflow_mesh_pt, OOMPH_CURRENT_FUNCTION, and OOMPH_EXCEPTION_LOCATION.

◆ ~NavierStokesImpedanceTractionElement()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::~NavierStokesImpedanceTractionElement ( )
inline

Destructor should not delete anything.

2086 {}

Member Function Documentation

◆ add_element_contribution_to_aux_integral()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
void oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::add_element_contribution_to_aux_integral ( std::map< unsigned, double > *  aux_integral_pt)
inlinevirtual

Add the element's contribution to the auxiliary integral that contains the derivative of the total volume flux through the outflow boundary of the (higher-dimensional) Navier-Stokes mesh w.r.t. to the discrete (global) (velocity) degrees of freedom.

Implements oomph::NavierStokesImpedanceTractionElementBase.

2299  {
2300  // Spatial dimension of element
2301  // unsigned ndim=dim();
2302 
2303  // Vector of local coordinates in face element
2304  Vector<double> s(DIM);
2305 
2306  // Create storage for shape functions
2307  unsigned nnod = nnode();
2308  Shape psi(nnod);
2309 
2310  // Set the value of n_intpt
2311  unsigned n_intpt = integral_pt()->nweight();
2312 
2313  // Loop over the integration points
2314  for (unsigned ipt = 0; ipt < n_intpt; ipt++)
2315  {
2316  // Assign values of s in FaceElement and local coordinates in bulk
2317  // element
2318  for (unsigned i = 0; i < DIM; i++)
2319  {
2320  s[i] = integral_pt()->knot(ipt, i);
2321  }
2322 
2323  // Get the integral weight
2324  double w = integral_pt()->weight(ipt);
2325 
2326  // Get jacobian of mapping
2327  double J = J_eulerian(s);
2328 
2329  // Get shape functions
2330  shape(s, psi);
2331 
2332  // Premultiply the weights and the Jacobian
2333  double W = w * J;
2334 
2335  // Outer unit normal
2336  Vector<double> normal(DIM + 1);
2338 
2339  // Loop over nodes
2340  for (unsigned j = 0; j < nnod; j++)
2341  {
2342  // Get pointer to Node
2343  Node* nod_pt = node_pt(j);
2344 
2345  // Loop over directions
2346  for (unsigned i = 0; i < (DIM + 1); i++)
2347  {
2348  // Get global equation number
2349  int i_global = nod_pt->eqn_number(i);
2350 
2351  // Real dof or bc?
2352  if (i_global >= 0)
2353  {
2354  (*aux_integral_pt)[i_global] += psi[j] * normal[i] * W;
2355  }
2356  }
2357  }
2358  }
2359  }
int i
Definition: BiCGSTAB_step_by_step.cpp:9
JacobiRotation< float > J
Definition: Jacobi_makeJacobi.cpp:3
RowVector3d w
Definition: Matrix_resize_int.cpp:3
void outer_unit_normal(const Vector< double > &s, Vector< double > &unit_normal) const
Compute outer unit normal at the specified local coordinate.
Definition: elements.cc:6006
double J_eulerian(const Vector< double > &s) const
Definition: elements.cc:5242
Node *& node_pt(const unsigned &n)
Return a pointer to the local node n.
Definition: elements.h:2175
virtual void shape(const Vector< double > &s, Shape &psi) const =0
unsigned nnode() const
Return the number of nodes.
Definition: elements.h:2210
Integral *const & integral_pt() const
Return the pointer to the integration scheme (const version)
Definition: elements.h:1963
virtual double knot(const unsigned &i, const unsigned &j) const =0
Return local coordinate s[j] of i-th integration point.
virtual unsigned nweight() const =0
Return the number of integration points of the scheme.
virtual double weight(const unsigned &i) const =0
Return weight of i-th integration point.
RealScalar s
Definition: level1_cplx_impl.h:130
#define DIM
Definition: linearised_navier_stokes_elements.h:44
void normal(const Vector< double > &x, Vector< double > &normal)
Definition: free_surface_rotation.cc:65
@ W
Definition: quadtree.h:63
std::ptrdiff_t j
Definition: tut_arithmetic_redux_minmax.cpp:2

References DIM, oomph::Data::eqn_number(), i, oomph::FiniteElement::integral_pt(), J, j, oomph::FaceElement::J_eulerian(), oomph::Integral::knot(), oomph::FiniteElement::nnode(), oomph::FiniteElement::node_pt(), WallFunction::normal(), oomph::Integral::nweight(), oomph::FaceElement::outer_unit_normal(), s, oomph::FiniteElement::shape(), w, oomph::QuadTreeNames::W, and oomph::Integral::weight().

◆ fill_in_contribution_to_jacobian()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
void oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::fill_in_contribution_to_jacobian ( Vector< double > &  residuals,
DenseMatrix< double > &  jacobian 
)
inlinevirtual

Fill in the element's contribution to the element's residual vector and Jacobian matrix

Reimplemented from oomph::FiniteElement.

2376  {
2377  // Call the generic routine with the flag set to 1
2379  residuals, jacobian, 1);
2380  }
void fill_in_generic_residual_contribution_fluid_traction(Vector< double > &residuals, DenseMatrix< double > &jacobian, unsigned flag)
Definition: womersley_elements.h:2425

References oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::fill_in_generic_residual_contribution_fluid_traction().

◆ fill_in_contribution_to_residuals()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
void oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::fill_in_contribution_to_residuals ( Vector< double > &  residuals)
inlinevirtual

Fill in the element's contribution to the element's residual vector.

Reimplemented from oomph::GeneralisedElement.

2364  {
2365  // Call the generic residuals function with flag set to 0
2366  // using a dummy matrix argument
2368  residuals, GeneralisedElement::Dummy_matrix, 0);
2369  }
static DenseMatrix< double > Dummy_matrix
Definition: elements.h:227

References oomph::GeneralisedElement::Dummy_matrix, and oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::fill_in_generic_residual_contribution_fluid_traction().

◆ fill_in_generic_residual_contribution_fluid_traction()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
void oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::fill_in_generic_residual_contribution_fluid_traction ( Vector< double > &  residuals,
DenseMatrix< double > &  jacobian,
unsigned  flag 
)
protected

This function returns the residuals for the traction function. flag=1(or 0): do (or don't) compute the Jacobian as well.

//////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// Function that returns the residuals for the imposed traction Navier_Stokes equations

2427  {
2428  // Find out how many nodes there are
2429  unsigned n_node = nnode();
2430 
2431  // Set up memory for the shape and test functions
2432  Shape psif(n_node), testf(n_node);
2433 
2434  // Set the value of n_intpt
2435  unsigned n_intpt = integral_pt()->nweight();
2436 
2437  // Integers to store local equation numbers
2438  int local_eqn = 0;
2439  int local_unknown = 0;
2440 
2441  // Loop over the integration points
2442  for (unsigned ipt = 0; ipt < n_intpt; ipt++)
2443  {
2444  // Get the integral weight
2445  double w = integral_pt()->weight(ipt);
2446 
2447  // Find the shape and test functions and return the Jacobian
2448  // of the mapping
2449  double J = shape_and_test_at_knot(ipt, psif, testf);
2450 
2451  // Premultiply the weights and the Jacobian
2452  double W = w * J;
2453 
2454  // Traction vector
2455  Vector<double> traction(DIM + 1);
2456 
2457  // Initialise response
2458  double p_in = 0.0;
2459  double dp_in_dq = 0.0;
2460 
2461  // Traction= outer unit normal x pressure at upstream end of
2462  // impedance tube
2464  {
2465  // Get response of the impedance tube:
2466  Impedance_tube_pt->get_response(p_in, dp_in_dq);
2467  }
2468 
2469  // Get outer unit normal at current integration point
2470  Vector<double> unit_normal(DIM + 1);
2471  outer_unit_normal(ipt, unit_normal);
2472 
2473  // Loop over the directions
2474  for (unsigned i = 0; i < DIM + 1; i++)
2475  {
2476  traction[i] = -unit_normal[i] * p_in;
2477  }
2478 
2479 
2480  // Loop over the test functions
2481  for (unsigned l = 0; l < n_node; l++)
2482  {
2483  // Loop over the velocity components
2484  for (unsigned i = 0; i < DIM + 1; i++)
2485  {
2486  local_eqn = u_local_eqn(l, i);
2487  /*IF it's not a boundary condition*/
2488  if (local_eqn >= 0)
2489  {
2490  // Add the user-defined traction terms
2491  residuals[local_eqn] += traction[i] * testf[l] * W;
2492 
2493  // Compute the Jacobian too?
2494  if (flag && (Navier_stokes_outflow_mesh_pt != 0))
2495  {
2496  // Loop over the nodes
2497  for (unsigned j = 0; j < n_node; j++)
2498  {
2499  // Get pointer to Node
2500  Node* nod_pt = node_pt(j);
2501 
2502  // Loop over the velocity components
2503  for (unsigned ii = 0; ii < DIM + 1; ii++)
2504  {
2505  local_unknown = u_local_eqn(j, ii);
2506 
2507  /*IF it's not a boundary condition*/
2508  if (local_unknown >= 0)
2509  {
2510  // Get corresponding global unknown number
2511  unsigned global_unknown = nod_pt->eqn_number(ii);
2512 
2513  // Add contribution
2514  jacobian(local_eqn, local_unknown) -=
2515  (*Aux_integral_pt)[global_unknown] * psif[l] *
2516  unit_normal[i] * dp_in_dq * W;
2517  }
2518  }
2519  }
2520 
2521 
2522  // Loop over external dofs for unknowns
2523  unsigned n_ext = nexternal_data();
2524  for (unsigned j = 0; j < n_ext; j++)
2525  {
2526  // Get pointer to external Data (=other nodes)
2527  Data* ext_data_pt = external_data_pt(j);
2528 
2529  // Loop over directions for equation
2530  for (unsigned ii = 0; ii < DIM + 1; ii++)
2531  {
2532  // Get local unknown number
2533  int local_unknown = external_local_eqn(j, ii);
2534 
2535  // Real dof or bc?
2536  if (local_unknown >= 0)
2537  {
2538  // Get corresponding global unknown number
2539  unsigned global_unknown = ext_data_pt->eqn_number(ii);
2540 
2541  // Add contribution
2542  jacobian(local_eqn, local_unknown) -=
2543  (*Aux_integral_pt)[global_unknown] * psif[l] *
2544  unit_normal[i] * dp_in_dq * W;
2545  }
2546  }
2547  }
2548  } // end of computation of Jacobian terms
2549  }
2550  } // End of loop over dimension
2551  } // End of loop over shape functions
2552  }
2553  }
unsigned nexternal_data() const
Return the number of external data objects.
Definition: elements.h:829
Data *& external_data_pt(const unsigned &i)
Return a pointer to i-th external data object.
Definition: elements.h:659
int external_local_eqn(const unsigned &i, const unsigned &j)
Definition: elements.h:311
double shape_and_test_at_knot(const unsigned &ipt, Shape &psi, Shape &test) const
Definition: womersley_elements.h:2004
virtual int u_local_eqn(const unsigned &n, const unsigned &i)
Definition: womersley_elements.h:1997
void get_response(double &p_in, double &dp_in_dq)
Definition: womersley_elements.h:1375

References DIM, oomph::Data::eqn_number(), i, J, j, w, and oomph::QuadTreeNames::W.

Referenced by oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::fill_in_contribution_to_jacobian(), and oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::fill_in_contribution_to_residuals().

◆ get_volume_flux()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
double oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::get_volume_flux ( )
inlinevirtual

Get integral of volume flux through element.

Implements oomph::NavierStokesImpedanceTractionElementBase.

2098  {
2099  // Initialise
2100  double volume_flux_integral = 0.0;
2101 
2102  // Vector of local coordinates in face element
2103  Vector<double> s(DIM);
2104 
2105  // Vector for global Eulerian coordinates
2106  Vector<double> x(DIM + 1);
2107 
2108  // Vector for local coordinates in bulk element
2109  Vector<double> s_bulk(DIM + 1);
2110 
2111  // Set the value of n_intpt
2112  unsigned n_intpt = integral_pt()->nweight();
2113 
2114  // Get pointer to assocated bulk element
2115  BULK_NAVIER_STOKES_ELEMENT* bulk_el_pt =
2116  dynamic_cast<BULK_NAVIER_STOKES_ELEMENT*>(bulk_element_pt());
2117 
2118  // Loop over the integration points
2119  for (unsigned ipt = 0; ipt < n_intpt; ipt++)
2120  {
2121  // Assign values of s in FaceElement and local coordinates in bulk
2122  // element
2123  for (unsigned i = 0; i < DIM; i++)
2124  {
2125  s[i] = integral_pt()->knot(ipt, i);
2126  }
2127 
2128  // Get the bulk coordinates
2129  this->get_local_coordinate_in_bulk(s, s_bulk);
2130 
2131  // Get the integral weight
2132  double w = integral_pt()->weight(ipt);
2133 
2134  // Get jacobian of mapping
2135  double J = J_eulerian(s);
2136 
2137  // Premultiply the weights and the Jacobian
2138  double W = w * J;
2139 
2140 
2141 #ifdef PARANOID
2142 
2143  // Get x position as Vector
2144  interpolated_x(s, x);
2145 
2146  // Get x position as Vector from bulk element
2147  Vector<double> x_bulk(DIM + 1);
2148  bulk_el_pt->interpolated_x(s_bulk, x_bulk);
2149 
2150  double max_legal_error = 1.0e-12;
2151  double error = 0.0;
2152  for (unsigned i = 0; i < DIM + 1; i++)
2153  {
2154  error += std::fabs(x[i] - x_bulk[i]);
2155  }
2156  if (error > max_legal_error)
2157  {
2158  std::ostringstream error_stream;
2159  error_stream << "difference in Eulerian posn from bulk and face: "
2160  << error << " exceeds threshold " << max_legal_error
2161  << std::endl;
2162  throw OomphLibError(error_stream.str(),
2165  }
2166 #endif
2167 
2168  // Outer unit normal
2169  Vector<double> normal(DIM + 1);
2171 
2172  // Get velocity from bulk element
2173  Vector<double> veloc(DIM + 1);
2174  bulk_el_pt->interpolated_u_nst(s_bulk, veloc);
2175 
2176  // Volume flux
2177  double volume_flux = 0.0;
2178  for (unsigned i = 0; i < DIM + 1; i++)
2179  {
2180  volume_flux += normal[i] * veloc[i];
2181  }
2182 
2183  // Add to integral
2184  volume_flux_integral += volume_flux * W;
2185  }
2186 
2187  return volume_flux_integral;
2188  }
FiniteElement *& bulk_element_pt()
Pointer to higher-dimensional "bulk" element.
Definition: elements.h:4735
double interpolated_x(const Vector< double > &s, const unsigned &i) const
Definition: elements.h:4528
void get_local_coordinate_in_bulk(const Vector< double > &s, Vector< double > &s_bulk) const
Definition: elements.cc:6384
Real fabs(const Real &a)
Definition: boostmultiprec.cpp:117
int error
Definition: calibrate.py:297
list x
Definition: plotDoE.py:28

References oomph::FaceElement::bulk_element_pt(), DIM, calibrate::error, boost::multiprecision::fabs(), oomph::FaceElement::get_local_coordinate_in_bulk(), i, oomph::FiniteElement::integral_pt(), oomph::FaceElement::interpolated_x(), J, oomph::FaceElement::J_eulerian(), oomph::Integral::knot(), WallFunction::normal(), oomph::Integral::nweight(), OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, oomph::FaceElement::outer_unit_normal(), s, w, oomph::QuadTreeNames::W, oomph::Integral::weight(), and plotDoE::x.

◆ navier_stokes_outflow_mesh_pt()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
Mesh*& oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::navier_stokes_outflow_mesh_pt ( )
inline

Access to mesh containing all NavierStokesImpedanceTractionElements that contribute to the volume flux into the "downstream tube" that provides the impedance

2092  {
2094  }

References oomph::NavierStokesImpedanceTractionElementBase::Navier_stokes_outflow_mesh_pt.

Referenced by oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::set_external_data_from_navier_stokes_outflow_mesh().

◆ output() [1/2]

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
void oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::output ( std::ostream &  outfile)
inlinevirtual

Overload the output function.

Reimplemented from oomph::FiniteElement.

2398  {
2399  FiniteElement::output(outfile);
2400  }
virtual void output(std::ostream &outfile)
Definition: elements.h:3050

References oomph::FiniteElement::output().

◆ output() [2/2]

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
void oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::output ( std::ostream &  outfile,
const unsigned nplot 
)
inlinevirtual

Output function: x,y,[z],u,v,[w],p in tecplot format.

Reimplemented from oomph::FiniteElement.

2404  {
2405  FiniteElement::output(outfile, nplot);
2406  }

References oomph::FiniteElement::output().

◆ set_aux_integral_pt()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
void oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::set_aux_integral_pt ( std::map< unsigned, double > *  aux_integral_pt)
inlinevirtual

Set pointer to the precomputed auxiliary integral that contains the derivative of the total volume flux through the outflow boundary of the (higher-dimensional) Navier-Stokes mesh w.r.t. to the discrete (global) (velocity) degrees of freedom.

Implements oomph::NavierStokesImpedanceTractionElementBase.

2240  {
2241  Aux_integral_pt = aux_integral_pt;
2242  }

References oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::Aux_integral_pt.

◆ set_external_data_from_navier_stokes_outflow_mesh()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
void oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::set_external_data_from_navier_stokes_outflow_mesh ( Mesh navier_stokes_outflow_mesh_pt)
inlinevirtual

NavierStokesImpedanceTractionElements that contribute to the volume flux into the downstream "impedance tube" to the element and classify all nodes in that mesh as external Data for this element (unless the nodes are also the element's own nodes, of course).

Implements oomph::NavierStokesImpedanceTractionElementBase.

2198  {
2199  // Store pointer to mesh of NavierStokesImpedanceTractionElement
2200  // that contribute to the volume flux into the "impedance tube" that
2201  // provides the flow resistance
2203 
2204  // Create a set the contains all nodal Data in the flux mesh
2205  std::set<Data*> external_data_set;
2206  unsigned nelem = Navier_stokes_outflow_mesh_pt->nelement();
2207  for (unsigned e = 0; e < nelem; e++)
2208  {
2209  FiniteElement* el_pt =
2211  unsigned nnod = el_pt->nnode();
2212  for (unsigned j = 0; j < nnod; j++)
2213  {
2214  external_data_set.insert(el_pt->node_pt(j));
2215  }
2216  }
2217 
2218  // Remove the element's own nodes
2219  unsigned nnod = nnode();
2220  for (unsigned j = 0; j < nnod; j++)
2221  {
2222  external_data_set.erase(node_pt(j));
2223  }
2224 
2225  // Copy across
2226  for (std::set<Data*>::iterator it = external_data_set.begin();
2227  it != external_data_set.end();
2228  it++)
2229  {
2230  add_external_data(*it);
2231  }
2232  }
Array< double, 1, 3 > e(1./3., 0.5, 2.)
FiniteElement()
Constructor.
Definition: elements.h:1782
unsigned add_external_data(Data *const &data_pt, const bool &fd=true)
Definition: elements.cc:307
FiniteElement * finite_element_pt(const unsigned &e) const
Definition: mesh.h:473
unsigned long nelement() const
Return number of elements in the mesh.
Definition: mesh.h:590
Mesh *& navier_stokes_outflow_mesh_pt()
Definition: womersley_elements.h:2091

References oomph::GeneralisedElement::add_external_data(), e(), oomph::Mesh::finite_element_pt(), j, oomph::NavierStokesImpedanceTractionElementBase::Navier_stokes_outflow_mesh_pt, oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::navier_stokes_outflow_mesh_pt(), oomph::Mesh::nelement(), oomph::FiniteElement::nnode(), and oomph::FiniteElement::node_pt().

◆ set_impedance_tube_pt()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
void oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::set_impedance_tube_pt ( TemplateFreeWomersleyImpedanceTubeBase impedance_tube_pt)
inlinevirtual

Set pointer to "impedance tube" that provides the flow resistance

Implements oomph::NavierStokesImpedanceTractionElementBase.

2286  {
2288  dynamic_cast<WomersleyImpedanceTubeBase<WOMERSLEY_ELEMENT, DIM>*>(
2289  impedance_tube_pt);
2290  }

References oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::Impedance_tube_pt.

◆ shape_and_test_at_knot()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
double oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::shape_and_test_at_knot ( const unsigned ipt,
Shape psi,
Shape test 
) const
inlineprotected

Function to compute the shape and test functions and to return the Jacobian of mapping

2007  {
2008  // Find number of nodes
2009  unsigned n_node = nnode();
2010 
2011  // Calculate the shape functions
2012  shape_at_knot(ipt, psi);
2013 
2014  // Set the test functions to be the same as the shape functions
2015  for (unsigned i = 0; i < n_node; i++)
2016  {
2017  test[i] = psi[i];
2018  }
2019 
2020  // Return the value of the jacobian
2021  return J_eulerian_at_knot(ipt);
2022  }
double J_eulerian_at_knot(const unsigned &ipt) const
Definition: elements.cc:5328
virtual void shape_at_knot(const unsigned &ipt, Shape &psi) const
Definition: elements.cc:3220
Definition: indexed_view.cpp:20

References i, oomph::FaceElement::J_eulerian_at_knot(), oomph::FiniteElement::nnode(), and oomph::FiniteElement::shape_at_knot().

◆ total_volume_flux_into_downstream_tube()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
double oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::total_volume_flux_into_downstream_tube ( )
inline

Compute total volume flux into the "downstream tube" that provides the impedance (computed by adding up the flux through all NavierStokesImpedanceTractionElements in the mesh specified by volume_flux_mesh_pt().

2250  {
2251 #ifdef PARANOID
2253  {
2254  throw OomphLibError(
2255  "Navier_stokes_outflow_mesh_pt==0 -- set it with \n "
2256  "set_external_data_from_navier_stokes_outflow_mesh() before calling "
2257  "this function!\n",
2260  }
2261 #endif
2262 
2263 
2264  double total_flux = 0.0;
2265  unsigned nelem = Navier_stokes_outflow_mesh_pt->nelement();
2266  for (unsigned e = 0; e < nelem; e++)
2267  {
2268  NavierStokesImpedanceTractionElement<BULK_NAVIER_STOKES_ELEMENT,
2269  WOMERSLEY_ELEMENT,
2270  DIM>* el_pt =
2271  dynamic_cast<
2272  NavierStokesImpedanceTractionElement<BULK_NAVIER_STOKES_ELEMENT,
2273  WOMERSLEY_ELEMENT,
2274  DIM>*>(
2276  total_flux += el_pt->get_volume_flux();
2277  }
2278  return total_flux;
2279  }
GeneralisedElement *& element_pt(const unsigned long &e)
Return pointer to element e.
Definition: mesh.h:448
NavierStokesImpedanceTractionElement(FiniteElement *const &element_pt, const int &face_index)
Definition: womersley_elements.h:2035

References DIM, e(), oomph::Mesh::element_pt(), oomph::NavierStokesImpedanceTractionElementBase::Navier_stokes_outflow_mesh_pt, oomph::Mesh::nelement(), OOMPH_CURRENT_FUNCTION, and OOMPH_EXCEPTION_LOCATION.

◆ u_local_eqn()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
virtual int oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::u_local_eqn ( const unsigned n,
const unsigned i 
)
inlineprotectedvirtual

Access function that returns the local equation numbers for velocity components. u_local_eqn(n,i) = local equation number or < 0 if pinned. The default is to asssume that n is the local node number and the i-th velocity component is the i-th unknown stored at the node.

1998  {
1999  return nodal_local_eqn(n, i);
2000  }
const unsigned n
Definition: CG3DPackingUnitTest.cpp:11
int nodal_local_eqn(const unsigned &n, const unsigned &i) const
Definition: elements.h:1432

References i, n, and oomph::FiniteElement::nodal_local_eqn().

◆ zeta_nodal()

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
double oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::zeta_nodal ( const unsigned n,
const unsigned k,
const unsigned i 
) const
inlinevirtual

Specify the value of nodal zeta from the face geometry The "global" intrinsic coordinate of the element when viewed as part of a geometric object should be given by the FaceElement representation, by default (needed to break indeterminacy if bulk element is SolidElement)

Reimplemented from oomph::FaceElement.

2391  {
2392  return FaceElement::zeta_nodal(n, k, i);
2393  }
double zeta_nodal(const unsigned &n, const unsigned &k, const unsigned &i) const
Definition: elements.h:4497
char char char int int * k
Definition: level2_impl.h:374

References i, k, n, and oomph::FaceElement::zeta_nodal().

Member Data Documentation

◆ Aux_integral_pt

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
std::map<unsigned, double>* oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::Aux_integral_pt
private

Pointer to auxiliary integral, containing the derivative of the total volume flux through the outflow boundary of the (higher-dimensional) Navier-Stokes mesh w.r.t. to the discrete (global) (velocity) degrees of freedom.

Referenced by oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::NavierStokesImpedanceTractionElement(), and oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::set_aux_integral_pt().

◆ Impedance_tube_pt

template<class BULK_NAVIER_STOKES_ELEMENT , class WOMERSLEY_ELEMENT , unsigned DIM>
WomersleyImpedanceTubeBase<WOMERSLEY_ELEMENT, DIM>* oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::Impedance_tube_pt
private

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