oomph::MyCrouzeixRaviartElement Class Reference

Overload CrouzeixRaviart element to modify output. More...

+ Inheritance diagram for oomph::MyCrouzeixRaviartElement:

Public Member Functions

 MyCrouzeixRaviartElement ()
 Constructor initialise error. More...
 
void set_error (const double &error)
 Set error value for post-processing. More...
 
std::string variable_identifier ()
 Return variable identifier. More...
 
void output (std::ostream &outfile, const unsigned &nplot)
 Overload output function. More...
 
 MyCrouzeixRaviartElement ()
 Constructor initialise error. More...
 
void set_error (const double &error)
 Set error value for post-processing. More...
 
std::string variable_identifier ()
 Return variable identifier. More...
 
void output (std::ostream &outfile, const unsigned &nplot)
 Overload output function. More...
 
double square_of_l2_norm ()
 Get square of L2 norm of velocity. More...
 
- Public Member Functions inherited from oomph::PseudoSolidNodeUpdateElement< TCrouzeixRaviartElement< 2 >, TPVDBubbleEnrichedElement< 2, 3 > >
 PseudoSolidNodeUpdateElement ()
 
void describe_local_dofs (std::ostream &out, const std::string &current_string) const
 
void compute_norm (double &el_norm)
 
unsigned required_nvalue (const unsigned &n) const
 The required number of values is the sum of the two. More...
 
int solid_p_nodal_index () const
 
void fill_in_contribution_to_residuals (Vector< double > &residuals)
 
void fill_in_contribution_to_jacobian (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 
void fill_in_contribution_to_jacobian_and_mass_matrix (Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix)
 
void evaluate_shape_derivs_by_direct_fd ()
 Evaluate shape derivatives by direct finite differencing. More...
 
void evaluate_shape_derivs_by_chain_rule ()
 Evaluate shape derivatives by chain rule. More...
 
void fill_in_shape_derivatives (DenseMatrix< double > &jacobian)
 
void fill_in_shape_derivatives_by_fd (DenseMatrix< double > &jacobian)
 
void identify_geometric_data (std::set< Data * > &geometric_data_pt)
 
void output (std::ostream &outfile)
 Overload the output function: Call that of the basic element. More...
 
void output (std::ostream &outfile, const unsigned &n_p)
 
void output (FILE *file_pt)
 Overload the output function: Call that of the basic element. More...
 
void output (FILE *file_pt, const unsigned &n_p)
 Output function is just the same as the basic equations. More...
 
unsigned num_Z2_flux_terms ()
 
void compute_exact_Z2_error (std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_flux_pt, double &error, double &norm)
 
void get_Z2_flux (const Vector< double > &s, Vector< double > &flux)
 
unsigned nvertex_node () const
 Number of vertex nodes in the element. More...
 
Nodevertex_node_pt (const unsigned &j) const
 Pointer to the j-th vertex node in the element. More...
 
unsigned nrecovery_order ()
 
unsigned ndof_types () const
 
unsigned nbasic_dof_types () const
 
unsigned nsolid_dof_types () const
 
void get_dof_numbers_for_unknowns (std::list< std::pair< unsigned long, unsigned >> &dof_lookup_list) const
 
- Public Member Functions inherited from oomph::TCrouzeixRaviartElement< DIM >
void pshape_nst (const Vector< double > &s, Shape &psi) const
 Pressure shape functions at local coordinate s. More...
 
void pshape_nst (const Vector< double > &s, Shape &psi, Shape &test) const
 Pressure shape and test functions at local coordinte s. More...
 
void unpin_all_internal_pressure_dofs ()
 Unpin all internal pressure dofs. More...
 
int p_local_eqn (const unsigned &n) const
 Return the local equation numbers for the pressure values. More...
 
 TCrouzeixRaviartElement ()
 Constructor, there are DIM+1 internal values (for the pressure) More...
 
 TCrouzeixRaviartElement (const TCrouzeixRaviartElement< DIM > &dummy)=delete
 Broken copy constructor. More...
 
double p_nst (const unsigned &i) const
 
double p_nst (const unsigned &t, const unsigned &i) const
 
unsigned npres_nst () const
 Return number of pressure values. More...
 
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. More...
 
void build_fp_press_adv_diff_robin_bc_element (const unsigned &face_index)
 
void identify_load_data (std::set< std::pair< Data *, unsigned >> &paired_load_data)
 
void identify_pressure_data (std::set< std::pair< Data *, unsigned >> &paired_pressure_data)
 
void full_output (std::ostream &outfile)
 
void full_output (std::ostream &outfile, const unsigned &nplot)
 
void pshape_nst (const Vector< double > &s, Shape &psi) const
 
void pshape_nst (const Vector< double > &s, Shape &psi, Shape &test) const
 Pressure shape and test functions. More...
 
void pshape_nst (const Vector< double > &s, Shape &psi) const
 
void pshape_nst (const Vector< double > &s, Shape &psi, Shape &test) const
 Pressure shape and test functions. More...
 
- Public Member Functions inherited from oomph::TBubbleEnrichedElement< DIM, 3 >
 TBubbleEnrichedElement ()
 Constructor. More...
 
 TBubbleEnrichedElement (const TBubbleEnrichedElement &)=delete
 Broken copy constructor. More...
 
 ~TBubbleEnrichedElement ()
 Broken assignment operator. More...
 
void shape (const Vector< double > &s, Shape &psi) const
 Calculate the geometric shape functions at local coordinate s. More...
 
void dshape_local (const Vector< double > &s, Shape &psi, DShape &dpsids) const
 
void d2shape_local (const Vector< double > &s, Shape &psi, DShape &dpsids, DShape &d2psids) const
 
void local_coordinate_of_node (const unsigned &j, Vector< double > &s) const
 Return local coordinates of node j. More...
 
void build_face_element (const int &face_index, FaceElement *face_element_pt)
 Build the lower-dimensional FaceElement. More...
 
- Public Member Functions inherited from oomph::TElement< DIM, 3 >
const unsigned Node_on_face [3][2]
 Assign the nodal translation schemes. More...
 
const unsigned Node_on_face [3][3]
 
const unsigned Node_on_face [3][4]
 
const unsigned Node_on_face [4][3]
 Assign the nodal translation scheme for linear elements. More...
 
const unsigned Node_on_face [4][6]
 Assign the nodal translation scheme for quadratic elements. More...
 
- Public Member Functions inherited from oomph::NavierStokesEquations< DIM >
 NavierStokesEquations ()
 
const doublere () const
 Reynolds number. More...
 
const doublere_st () const
 Product of Reynolds and Strouhal number (=Womersley number) More...
 
double *& re_pt ()
 Pointer to Reynolds number. More...
 
double *& re_st_pt ()
 Pointer to product of Reynolds and Strouhal number (=Womersley number) More...
 
const doubleviscosity_ratio () const
 
double *& viscosity_ratio_pt ()
 Pointer to Viscosity Ratio. More...
 
const doubledensity_ratio () const
 
double *& density_ratio_pt ()
 Pointer to Density ratio. More...
 
const doublere_invfr () const
 Global inverse Froude number. More...
 
double *& re_invfr_pt ()
 Pointer to global inverse Froude number. More...
 
const Vector< double > & g () const
 Vector of gravitational components. More...
 
Vector< double > *& g_pt ()
 Pointer to Vector of gravitational components. More...
 
NavierStokesBodyForceFctPtbody_force_fct_pt ()
 Access function for the body-force pointer. More...
 
NavierStokesBodyForceFctPt body_force_fct_pt () const
 Access function for the body-force pointer. Const version. More...
 
NavierStokesSourceFctPtsource_fct_pt ()
 Access function for the source-function pointer. More...
 
NavierStokesSourceFctPt source_fct_pt () const
 Access function for the source-function pointer. Const version. More...
 
NavierStokesPressureAdvDiffSourceFctPtsource_fct_for_pressure_adv_diff ()
 
NavierStokesPressureAdvDiffSourceFctPt source_fct_for_pressure_adv_diff () const
 
intpinned_fp_pressure_eqn ()
 
double u_nst (const unsigned &n, const unsigned &i) const
 
double u_nst (const unsigned &t, const unsigned &n, const unsigned &i) const
 
virtual unsigned u_index_nst (const unsigned &i) const
 
unsigned n_u_nst () const
 
double du_dt_nst (const unsigned &n, const unsigned &i) const
 
void disable_ALE ()
 
void enable_ALE ()
 
virtual int p_nodal_index_nst () const
 
double pressure_integral () const
 Integral of pressure over element. More...
 
double dissipation () const
 Return integral of dissipation over element. More...
 
double dissipation (const Vector< double > &s) const
 Return dissipation at local coordinate s. More...
 
void get_vorticity (const Vector< double > &s, Vector< double > &vorticity) const
 Compute the vorticity vector at local coordinate s. More...
 
void get_vorticity (const Vector< double > &s, double &vorticity) const
 Compute the scalar vorticity at local coordinate s (2D) More...
 
double kin_energy () const
 Get integral of kinetic energy over element. More...
 
double d_kin_energy_dt () const
 Get integral of time derivative of kinetic energy over element. More...
 
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) More...
 
void get_traction (const Vector< double > &s, const Vector< double > &N, Vector< double > &traction)
 
void get_traction (const Vector< double > &s, const Vector< double > &N, Vector< double > &traction_p, Vector< double > &traction_visc_n, Vector< double > &traction_visc_t)
 
void get_load (const Vector< double > &s, const Vector< double > &N, Vector< double > &load)
 
void get_pressure_and_velocity_mass_matrix_diagonal (Vector< double > &press_mass_diag, Vector< double > &veloc_mass_diag, const unsigned &which_one=0)
 
unsigned nscalar_paraview () const
 
void scalar_value_paraview (std::ofstream &file_out, const unsigned &i, const unsigned &nplot) const
 
void scalar_value_fct_paraview (std::ofstream &file_out, const unsigned &i, const unsigned &nplot, const double &time, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt) const
 
std::string scalar_name_paraview (const unsigned &i) const
 
void full_output (std::ostream &outfile)
 
void full_output (std::ostream &outfile, const unsigned &nplot)
 
void output_veloc (std::ostream &outfile, const unsigned &nplot, const unsigned &t)
 
void output_vorticity (std::ostream &outfile, const unsigned &nplot)
 
void output_fct (std::ostream &outfile, const unsigned &nplot, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt)
 
void output_fct (std::ostream &outfile, const unsigned &nplot, const double &time, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt)
 
void compute_norm (Vector< double > &norm)
 Compute the vector norm of the FEM solution. More...
 
void compute_error (std::ostream &outfile, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, double &error, double &norm)
 
void compute_error (std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, double &error, double &norm)
 
void compute_error (FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, double &error, double &norm)
 
void compute_error (FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, double &error, double &norm)
 
void fill_in_contribution_to_dresiduals_dparameter (double *const &parameter_pt, Vector< double > &dres_dparam)
 Compute the element's residual Vector. More...
 
void fill_in_contribution_to_djacobian_dparameter (double *const &parameter_pt, Vector< double > &dres_dparam, DenseMatrix< double > &djac_dparam)
 
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)
 
void fill_in_pressure_advection_diffusion_residuals (Vector< double > &residuals)
 
void fill_in_pressure_advection_diffusion_jacobian (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 
void pin_all_non_pressure_dofs (std::map< Data *, std::vector< int >> &eqn_number_backup)
 Pin all non-pressure dofs and backup eqn numbers. More...
 
void output_pressure_advection_diffusion_robin_elements (std::ostream &outfile)
 
void delete_pressure_advection_diffusion_robin_elements ()
 
virtual void get_dresidual_dnodal_coordinates (RankThreeTensor< double > &dresidual_dnodal_coordinates)
 
void interpolated_u_nst (const Vector< double > &s, Vector< double > &veloc) const
 Compute vector of FE interpolated velocity u at local coordinate s. More...
 
double interpolated_u_nst (const Vector< double > &s, const unsigned &i) const
 Return FE interpolated velocity u[i] at local coordinate s. More...
 
double interpolated_u_nst (const unsigned &t, const Vector< double > &s, const unsigned &i) const
 
virtual void dinterpolated_u_nst_ddata (const Vector< double > &s, const unsigned &i, Vector< double > &du_ddata, Vector< unsigned > &global_eqn_number)
 
virtual double interpolated_p_nst (const Vector< double > &s) const
 Return FE interpolated pressure at local coordinate s. More...
 
double interpolated_p_nst (const unsigned &t, const Vector< double > &s) const
 Return FE interpolated pressure at local coordinate s at time level t. More...
 
double interpolated_dudx_nst (const Vector< double > &s, const unsigned &i, const unsigned &j) const
 
void point_output_data (const Vector< double > &s, Vector< double > &data)
 
void get_vorticity (const Vector< double > &s, Vector< double > &vorticity) const
 
void get_vorticity (const Vector< double > &s, double &vorticity) const
 
void get_vorticity (const Vector< double > &s, Vector< double > &vorticity) const
 Compute 3D vorticity vector at local coordinate s. More...
 
- Public Member Functions inherited from oomph::FSIFluidElement
 FSIFluidElement ()
 Constructor. More...
 
 FSIFluidElement (const FSIFluidElement &)=delete
 Broken copy constructor. More...
 
void operator= (const FSIFluidElement &)=delete
 Broken assignment operator. 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)
 
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
 
virtual double J_eulerian (const Vector< double > &s) const
 
virtual double J_eulerian_at_knot (const unsigned &ipt) 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_nodal_local_dofs (std::ostream &out, const std::string &current_string) const
 
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
 
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...
 
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...
 
virtual double interpolated_x (const Vector< double > &s, const unsigned &i) const
 Return FE interpolated coordinate x[i] at local coordinate s. More...
 
virtual double interpolated_x (const unsigned &t, const Vector< double > &s, const unsigned &i) const
 
virtual void interpolated_x (const Vector< double > &s, Vector< double > &x) const
 Return FE interpolated position x[] at local coordinate s as Vector. More...
 
virtual void interpolated_x (const unsigned &t, const Vector< double > &s, Vector< double > &x) const
 
virtual double interpolated_dxdt (const Vector< double > &s, const unsigned &i, const unsigned &t)
 
virtual void interpolated_dxdt (const Vector< double > &s, const unsigned &t, Vector< double > &dxdt)
 
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 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
 
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 void scalar_value_fct_paraview (std::ofstream &file_out, const unsigned &i, const unsigned &nplot, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt) const
 
virtual void output (const unsigned &t, std::ostream &outfile, const unsigned &n_plot) const
 
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, 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, 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)
 
- 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::TemplateFreeNavierStokesEquationsBase
 TemplateFreeNavierStokesEquationsBase ()
 Constructor (empty) More...
 
virtual ~TemplateFreeNavierStokesEquationsBase ()
 Virtual destructor (empty) More...
 
- Public Member Functions inherited from oomph::NavierStokesElementWithDiagonalMassMatrices
 NavierStokesElementWithDiagonalMassMatrices ()
 Empty constructor. More...
 
virtual ~NavierStokesElementWithDiagonalMassMatrices ()
 Virtual destructor. More...
 
 NavierStokesElementWithDiagonalMassMatrices (const NavierStokesElementWithDiagonalMassMatrices &)=delete
 Broken copy constructor. More...
 
void operator= (const NavierStokesElementWithDiagonalMassMatrices &)=delete
 Broken assignment operator. More...
 
- Public Member Functions inherited from oomph::ElementWithZ2ErrorEstimator
 ElementWithZ2ErrorEstimator ()
 Default empty constructor. More...
 
 ElementWithZ2ErrorEstimator (const ElementWithZ2ErrorEstimator &)=delete
 Broken copy constructor. More...
 
void operator= (const ElementWithZ2ErrorEstimator &)=delete
 Broken assignment operator. More...
 
virtual unsigned ncompound_fluxes ()
 
virtual void get_Z2_compound_flux_indices (Vector< unsigned > &flux_index)
 
virtual double geometric_jacobian (const Vector< double > &x)
 
- Public Member Functions inherited from oomph::TPVDBubbleEnrichedElement< DIM, NNODE_1D >
 TPVDBubbleEnrichedElement ()
 Constructor, there are no internal data points. More...
 
- Public Member Functions inherited from oomph::SolidTBubbleEnrichedElement< DIM, NNODE_1D >
void build_face_element (const int &face_index, FaceElement *face_element_pt)
 
void build_face_element (const int &face_index, FaceElement *face_element_pt)
 
- Public Member Functions inherited from oomph::PVDEquations< DIM >
 PVDEquations ()
 Constructor. More...
 
void get_stress (const Vector< double > &s, DenseMatrix< double > &sigma)
 
void extended_output (std::ostream &outfile, const unsigned &n_plot)
 Output: x,y,[z],xi0,xi1,[xi2],gamma strain and stress components. More...
 
- Public Member Functions inherited from oomph::PVDEquationsBase< DIM >
 PVDEquationsBase ()
 
ConstitutiveLaw *& constitutive_law_pt ()
 Return the constitutive law pointer. More...
 
const doublelambda_sq () const
 Access function for timescale ratio (nondim density) More...
 
double *& lambda_sq_pt ()
 Access function for pointer to timescale ratio (nondim density) More...
 
IsotropicGrowthFctPtisotropic_growth_fct_pt ()
 Access function: Pointer to isotropic growth function. More...
 
PrestressFctPtprestress_fct_pt ()
 Access function: Pointer to pre-stress function. More...
 
IsotropicGrowthFctPt isotropic_growth_fct_pt () const
 Access function: Pointer to isotropic growth function (const version) More...
 
BodyForceFctPtbody_force_fct_pt ()
 Access function: Pointer to body force function. More...
 
BodyForceFctPt body_force_fct_pt () const
 Access function: Pointer to body force function (const version) More...
 
void enable_inertia ()
 Switch on solid inertia. More...
 
void disable_inertia ()
 Switch off solid inertia. More...
 
bool is_inertia_enabled () const
 Access function to flag that switches inertia on/off (const version) More...
 
virtual unsigned npres_solid () const
 
virtual int solid_p_local_eqn (const unsigned &i) const
 
virtual void pin_elemental_redundant_nodal_solid_pressures ()
 Pin the element's redundant solid pressures (needed for refinement) More...
 
void get_strain (const Vector< double > &s, DenseMatrix< double > &strain) const
 Return the strain tensor. More...
 
void get_energy (double &pot_en, double &kin_en)
 Get potential (strain) and kinetic energy. More...
 
void get_deformed_covariant_basis_vectors (const Vector< double > &s, DenseMatrix< double > &def_covariant_basis)
 
void get_principal_stress (const Vector< double > &s, DenseMatrix< double > &principal_stress_vector, Vector< double > &principal_stress)
 
virtual void get_isotropic_growth (const unsigned &ipt, const Vector< double > &s, const Vector< double > &xi, double &gamma) const
 
void body_force (const Vector< double > &xi, Vector< double > &b) const
 
void enable_evaluate_jacobian_by_fd ()
 Set Jacobian to be evaluated by FD? Else: Analytically. More...
 
void disable_evaluate_jacobian_by_fd ()
 Set Jacobian to be evaluated analytically Else: by FD. More...
 
bool is_jacobian_evaluated_by_fd () const
 Return the flag indicating whether the jacobian is evaluated by fd. More...
 
double prestress (const unsigned &i, const unsigned &j, const Vector< double > xi)
 
- Public Member Functions inherited from oomph::SolidFiniteElement
void set_lagrangian_dimension (const unsigned &lagrangian_dimension)
 
virtual bool has_internal_solid_data ()
 
 SolidFiniteElement ()
 Constructor: Set defaults. More...
 
virtual ~SolidFiniteElement ()
 Destructor to clean up any allocated memory. More...
 
 SolidFiniteElement (const SolidFiniteElement &)=delete
 Broken copy constructor. More...
 
unsigned ngeom_data () const
 Broken assignment operator. More...
 
Datageom_data_pt (const unsigned &j)
 
double zeta_nodal (const unsigned &n, const unsigned &k, const unsigned &i) const
 
virtual void get_x_and_xi (const Vector< double > &s, Vector< double > &x_fe, Vector< double > &x, Vector< double > &xi_fe, Vector< double > &xi) const
 
virtual void set_macro_elem_pt (MacroElement *macro_elem_pt)
 
virtual void set_macro_elem_pt (MacroElement *macro_elem_pt, MacroElement *undeformed_macro_elem_pt)
 
void set_undeformed_macro_elem_pt (MacroElement *undeformed_macro_elem_pt)
 
MacroElementundeformed_macro_elem_pt ()
 Access function to pointer to "undeformed" macro element. More...
 
double dshape_lagrangian (const Vector< double > &s, Shape &psi, DShape &dpsidxi) const
 
virtual double dshape_lagrangian_at_knot (const unsigned &ipt, Shape &psi, DShape &dpsidxi) const
 
double d2shape_lagrangian (const Vector< double > &s, Shape &psi, DShape &dpsidxi, DShape &d2psidxi) const
 
virtual double d2shape_lagrangian_at_knot (const unsigned &ipt, Shape &psi, DShape &dpsidxi, DShape &d2psidxi) const
 
unsigned lagrangian_dimension () const
 
unsigned nnodal_lagrangian_type () const
 
Nodeconstruct_node (const unsigned &n)
 Construct the local node n and return a pointer to it. More...
 
Nodeconstruct_node (const unsigned &n, TimeStepper *const &time_stepper_pt)
 
Nodeconstruct_boundary_node (const unsigned &n)
 
Nodeconstruct_boundary_node (const unsigned &n, TimeStepper *const &time_stepper_pt)
 
virtual void assign_all_generic_local_eqn_numbers (const bool &store_local_dof_pt)
 
double raw_lagrangian_position (const unsigned &n, const unsigned &i) const
 
double raw_lagrangian_position_gen (const unsigned &n, const unsigned &k, const unsigned &i) const
 
double lagrangian_position (const unsigned &n, const unsigned &i) const
 Return i-th Lagrangian coordinate at local node n. More...
 
double lagrangian_position_gen (const unsigned &n, const unsigned &k, const unsigned &i) const
 
virtual double interpolated_xi (const Vector< double > &s, const unsigned &i) const
 
virtual void interpolated_xi (const Vector< double > &s, Vector< double > &xi) const
 
virtual void interpolated_dxids (const Vector< double > &s, DenseMatrix< double > &dxids) const
 
virtual void J_lagrangian (const Vector< double > &s) const
 
virtual double J_lagrangian_at_knot (const unsigned &ipt) const
 
SolidInitialCondition *& solid_ic_pt ()
 Pointer to object that describes the initial condition. More...
 
void enable_solve_for_consistent_newmark_accel ()
 
void disable_solve_for_consistent_newmark_accel ()
 Set to reset the problem being solved to be the standard problem. More...
 
MultiplierFctPtmultiplier_fct_pt ()
 
MultiplierFctPt multiplier_fct_pt () const
 
virtual void get_residuals_for_solid_ic (Vector< double > &residuals)
 
void fill_in_residuals_for_solid_ic (Vector< double > &residuals)
 
void fill_in_jacobian_for_solid_ic (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 
void fill_in_jacobian_for_newmark_accel (DenseMatrix< double > &jacobian)
 
int position_local_eqn (const unsigned &n, const unsigned &k, const unsigned &j) const
 

Private Attributes

double Error
 Storage for elemental error estimate – used for post-processing. More...
 

Additional Inherited Members

- Public Types inherited from oomph::NavierStokesEquations< DIM >
typedef void(* NavierStokesBodyForceFctPt) (const double &time, const Vector< double > &x, Vector< double > &body_force)
 
typedef double(* NavierStokesSourceFctPt) (const double &time, const Vector< double > &x)
 
typedef double(* NavierStokesPressureAdvDiffSourceFctPt) (const Vector< double > &x)
 
- Public Types inherited from oomph::FiniteElement
typedef void(* SteadyExactSolutionFctPt) (const Vector< double > &, Vector< double > &)
 
typedef void(* UnsteadyExactSolutionFctPt) (const double &, const Vector< double > &, Vector< double > &)
 
- Public Types inherited from oomph::PVDEquationsBase< DIM >
typedef void(* IsotropicGrowthFctPt) (const Vector< double > &xi, double &gamma)
 
typedef double(* PrestressFctPt) (const unsigned &i, const unsigned &j, const Vector< double > &xi)
 
typedef void(* BodyForceFctPt) (const double &t, const Vector< double > &xi, Vector< double > &b)
 
- Public Types inherited from oomph::SolidFiniteElement
typedef double(* MultiplierFctPt) (const Vector< double > &xi)
 
- Static Public Member Functions inherited from oomph::PVDEquationsBase< DIM >
static void pin_redundant_nodal_solid_pressures (const Vector< GeneralisedElement * > &element_pt)
 
static void unpin_all_solid_pressure_dofs (const Vector< GeneralisedElement * > &element_pt)
 Unpin all pressure dofs in elements listed in vector. More...
 
- Static Public Attributes inherited from oomph::NavierStokesEquations< DIM >
static Vector< doubleGamma
 Vector to decide whether the stress-divergence form is used or not. More...
 
- 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 Member Functions inherited from oomph::TCrouzeixRaviartElement< DIM >
double dshape_and_dtest_eulerian_nst (const Vector< double > &s, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const
 
double dshape_and_dtest_eulerian_at_knot_nst (const unsigned &ipt, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const
 
double dshape_and_dtest_eulerian_at_knot_nst (const unsigned &ipt, Shape &psi, DShape &dpsidx, RankFourTensor< double > &d_dpsidx_dX, Shape &test, DShape &dtestdx, RankFourTensor< double > &d_dtestdx_dX, DenseMatrix< double > &djacobian_dX) const
 
double dpshape_and_dptest_eulerian_nst (const Vector< double > &s, Shape &ppsi, DShape &dppsidx, Shape &ptest, DShape &dptestdx) const
 
double dpshape_and_dptest_eulerian_nst (const Vector< double > &s, Shape &ppsi, DShape &dppsidx, Shape &ptest, DShape &dptestdx) const
 
double dpshape_and_dptest_eulerian_nst (const Vector< double > &s, Shape &ppsi, DShape &dppsidx, Shape &ptest, DShape &dptestdx) const
 
- Protected Member Functions inherited from oomph::NavierStokesEquations< DIM >
virtual void get_body_force_nst (const double &time, const unsigned &ipt, const Vector< double > &s, const Vector< double > &x, Vector< double > &result)
 
virtual void get_body_force_gradient_nst (const double &time, const unsigned &ipt, const Vector< double > &s, const Vector< double > &x, DenseMatrix< double > &d_body_force_dx)
 
virtual double get_source_nst (const double &time, const unsigned &ipt, const Vector< double > &x)
 
virtual void get_source_gradient_nst (const double &time, const unsigned &ipt, const Vector< double > &x, Vector< double > &gradient)
 
virtual void fill_in_generic_residual_contribution_nst (Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix, unsigned flag)
 
virtual void fill_in_generic_pressure_advection_diffusion_contribution_nst (Vector< double > &residuals, DenseMatrix< double > &jacobian, unsigned flag)
 
virtual void fill_in_generic_dresidual_contribution_nst (double *const &parameter_pt, Vector< double > &dres_dparam, DenseMatrix< double > &djac_dparam, DenseMatrix< double > &dmass_matrix_dparam, unsigned flag)
 
void fill_in_contribution_to_hessian_vector_products (Vector< double > const &Y, DenseMatrix< double > const &C, DenseMatrix< double > &product)
 
- 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_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)
 
- Protected Member Functions inherited from oomph::PVDEquations< DIM >
virtual void fill_in_generic_contribution_to_residuals_pvd (Vector< double > &residuals, DenseMatrix< double > &jacobian, const unsigned &flag)
 
void get_stress (const DenseMatrix< double > &g, const DenseMatrix< double > &G, DenseMatrix< double > &sigma)
 
void get_d_stress_dG_upper (const DenseMatrix< double > &g, const DenseMatrix< double > &G, const DenseMatrix< double > &sigma, RankFourTensor< double > &d_sigma_dG)
 
- Protected Member Functions inherited from oomph::SolidFiniteElement
void fill_in_generic_jacobian_for_solid_ic (Vector< double > &residuals, DenseMatrix< double > &jacobian, const unsigned &flag)
 
void set_nnodal_lagrangian_type (const unsigned &nlagrangian_type)
 
virtual double local_to_lagrangian_mapping (const DShape &dpsids, DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 
double local_to_lagrangian_mapping (const DShape &dpsids, DenseMatrix< double > &inverse_jacobian) const
 
virtual double local_to_lagrangian_mapping_diagonal (const DShape &dpsids, DenseMatrix< double > &jacobian, DenseMatrix< double > &inverse_jacobian) const
 
virtual void assign_solid_local_eqn_numbers (const bool &store_local_dof)
 Assign local equation numbers for the solid equations in the element. More...
 
void describe_solid_local_dofs (std::ostream &out, const std::string &current_string) const
 Classifies dofs locally for solid specific aspects. More...
 
virtual void fill_in_jacobian_from_solid_position_by_fd (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 
void fill_in_jacobian_from_solid_position_by_fd (DenseMatrix< double > &jacobian)
 
virtual void update_before_solid_position_fd ()
 
virtual void reset_after_solid_position_fd ()
 
virtual void update_in_solid_position_fd (const unsigned &i)
 
virtual void reset_in_solid_position_fd (const unsigned &i)
 
- Protected Attributes inherited from oomph::TCrouzeixRaviartElement< DIM >
unsigned P_nst_internal_index
 
- Protected Attributes inherited from oomph::NavierStokesEquations< DIM >
doubleViscosity_Ratio_pt
 
doubleDensity_Ratio_pt
 
doubleRe_pt
 Pointer to global Reynolds number. More...
 
doubleReSt_pt
 Pointer to global Reynolds number x Strouhal number (=Womersley) More...
 
doubleReInvFr_pt
 
Vector< double > * G_pt
 Pointer to global gravity Vector. More...
 
NavierStokesBodyForceFctPt Body_force_fct_pt
 Pointer to body force function. More...
 
NavierStokesSourceFctPt Source_fct_pt
 Pointer to volumetric source function. More...
 
NavierStokesPressureAdvDiffSourceFctPt Press_adv_diff_source_fct_pt
 
bool ALE_is_disabled
 
Vector< FpPressureAdvDiffRobinBCElementBase * > Pressure_advection_diffusion_robin_element_pt
 
int Pinned_fp_pressure_eqn
 
- 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::PVDEquationsBase< DIM >
IsotropicGrowthFctPt Isotropic_growth_fct_pt
 Pointer to isotropic growth function. More...
 
PrestressFctPt Prestress_fct_pt
 Pointer to prestress function. More...
 
ConstitutiveLawConstitutive_law_pt
 Pointer to the constitutive law. More...
 
doubleLambda_sq_pt
 Timescale ratio (non-dim. density) More...
 
bool Unsteady
 Flag that switches inertia on/off. More...
 
BodyForceFctPt Body_force_fct_pt
 Pointer to body force function. More...
 
bool Evaluate_jacobian_by_fd
 Use FD to evaluate Jacobian. More...
 
- Protected Attributes inherited from oomph::SolidFiniteElement
MacroElementUndeformed_macro_elem_pt
 Pointer to the element's "undeformed" macro element (NULL by default) More...
 
SolidInitialConditionSolid_ic_pt
 Pointer to object that specifies the initial condition. More...
 
bool Solve_for_consistent_newmark_accel_flag
 
- 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
 
- Static Protected Attributes inherited from oomph::PVDEquationsBase< DIM >
static double Default_lambda_sq_value = 1.0
 Static default value for timescale ratio (1.0 – for natural scaling) More...
 

Detailed Description

Overload CrouzeixRaviart element to modify output.

Constructor & Destructor Documentation

◆ MyCrouzeixRaviartElement() [1/2]

oomph::MyCrouzeixRaviartElement::MyCrouzeixRaviartElement ( )
inline

Constructor initialise error.

66  {
67  Error=0.0;
68  }
double Error
Storage for elemental error estimate – used for post-processing.
Definition: refineable_two_layer_interface.cc:59
Definition: pseudosolid_node_update_elements.h:58
Definition: solid_elements.h:1935

References Error.

◆ MyCrouzeixRaviartElement() [2/2]

oomph::MyCrouzeixRaviartElement::MyCrouzeixRaviartElement ( )
inline

Constructor initialise error.

References Error.

Member Function Documentation

◆ output() [1/2]

void oomph::MyCrouzeixRaviartElement::output ( std::ostream &  outfile,
const unsigned nplot 
)
inlinevirtual

Overload output function.

Reimplemented from oomph::FiniteElement.

104  {
105 
106  // Assign dimension
107  unsigned el_dim=2;
108 
109  // Vector of local coordinates
111 
112  // Acceleration
113  Vector<double> dudt(el_dim);
114 
115  // Mesh elocity
116  Vector<double> mesh_veloc(el_dim,0.0);
117 
118  // Tecplot header info
119  outfile << tecplot_zone_string(nplot);
120 
121  // Find out how many nodes there are
122  unsigned n_node = nnode();
123 
124  //Set up memory for the shape functions
125  Shape psif(n_node);
126  DShape dpsifdx(n_node,el_dim);
127 
128  // Loop over plot points
129  unsigned num_plot_points=nplot_points(nplot);
130  for (unsigned iplot=0;iplot<num_plot_points;iplot++)
131  {
132 
133  // Get local coordinates of plot point
134  get_s_plot(iplot,nplot,s);
135 
136  //Call the derivatives of the shape and test functions
137  dshape_eulerian(s,psif,dpsifdx);
138 
139  //Allocate storage
140  Vector<double> mesh_veloc(el_dim);
141  Vector<double> dudt(el_dim);
142  Vector<double> dudt_ALE(el_dim);
143  DenseMatrix<double> interpolated_dudx(el_dim,el_dim);
144 
145  //Initialise everything to zero
146  for(unsigned i=0;i<el_dim;i++)
147  {
148  mesh_veloc[i]=0.0;
149  dudt[i]=0.0;
150  dudt_ALE[i]=0.0;
151  for(unsigned j=0;j<el_dim;j++)
152  {
153  interpolated_dudx(i,j) = 0.0;
154  }
155  }
156 
157  //Calculate velocities and derivatives
158 
159  //Loop over directions
160  for(unsigned i=0;i<el_dim;i++)
161  {
162  //Get the index at which velocity i is stored
163  unsigned u_nodal_index = u_index_nst(i);
164  // Loop over nodes
165  for(unsigned l=0;l<n_node;l++)
166  {
167  dudt[i]+=du_dt_nst(l,u_nodal_index)*psif[l];
168  mesh_veloc[i]+=dnodal_position_dt(l,i)*psif[l];
169 
170  //Loop over derivative directions for velocity gradients
171  for(unsigned j=0;j<el_dim;j++)
172  {
173  interpolated_dudx(i,j) += nodal_value(l,u_nodal_index)*
174  dpsifdx(l,j);
175  }
176  }
177  }
178 
179 
180  // Get dudt in ALE form (incl mesh veloc)
181  for(unsigned i=0;i<el_dim;i++)
182  {
183  dudt_ALE[i]=dudt[i];
184  for (unsigned k=0;k<el_dim;k++)
185  {
186  dudt_ALE[i]-=mesh_veloc[k]*interpolated_dudx(i,k);
187  }
188  }
189 
190 
191  // Coordinates
192  for(unsigned i=0;i<el_dim;i++)
193  {
194  outfile << interpolated_x(s,i) << " ";
195  }
196 
197  // Velocities
198  for(unsigned i=0;i<el_dim;i++)
199  {
200  outfile << interpolated_u_nst(s,i) << " ";
201  }
202 
203  // Pressure
204  outfile << interpolated_p_nst(s) << " ";
205 
206  // Accelerations
207  for(unsigned i=0;i<el_dim;i++)
208  {
209  outfile << dudt_ALE[i] << " ";
210  }
211 
212  // Mesh velocity
213  for(unsigned i=0;i<el_dim;i++)
214  {
215  outfile << mesh_veloc[i] << " ";
216  }
217 
218  // History values of coordinates
219  unsigned n_prev=node_pt(0)->position_time_stepper_pt()->ntstorage();
220  for (unsigned t=1;t<n_prev;t++)
221  {
222  for(unsigned i=0;i<el_dim;i++)
223  {
224  outfile << interpolated_x(t,s,i) << " ";
225  }
226  }
227 
228  // History values of velocities
229  n_prev=node_pt(0)->time_stepper_pt()->ntstorage();
230  for (unsigned t=1;t<n_prev;t++)
231  {
232  for(unsigned i=0;i<el_dim;i++)
233  {
234  outfile << interpolated_u_nst(t,s,i) << " ";
235  }
236  }
237 
238  outfile << Error << " "
239  << size() << std::endl;
240  }
241 
242  // Write tecplot footer (e.g. FE connectivity lists)
243  write_tecplot_zone_footer(outfile,nplot);
244  }
int i
Definition: BiCGSTAB_step_by_step.cpp:9
Definition: shape.h:278
TimeStepper *& time_stepper_pt()
Return the pointer to the timestepper.
Definition: nodes.h:238
Node *& node_pt(const unsigned &n)
Return a pointer to the local node n.
Definition: elements.h:2175
double nodal_value(const unsigned &n, const unsigned &i) const
Definition: elements.h:2593
double size() const
Definition: elements.cc:4290
virtual std::string tecplot_zone_string(const unsigned &nplot) const
Definition: elements.h:3161
virtual double interpolated_x(const Vector< double > &s, const unsigned &i) const
Return FE interpolated coordinate x[i] at local coordinate s.
Definition: elements.cc:3962
unsigned nnode() const
Return the number of nodes.
Definition: elements.h:2210
virtual void get_s_plot(const unsigned &i, const unsigned &nplot, Vector< double > &s, const bool &shifted_to_interior=false) const
Definition: elements.h:3148
virtual unsigned nplot_points(const unsigned &nplot) const
Definition: elements.h:3186
virtual void write_tecplot_zone_footer(std::ostream &outfile, const unsigned &nplot) const
Definition: elements.h:3174
double dshape_eulerian(const Vector< double > &s, Shape &psi, DShape &dpsidx) const
Definition: elements.cc:3298
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.
Definition: elements.h:2333
virtual unsigned u_index_nst(const unsigned &i) const
Definition: navier_stokes_elements.h:866
void interpolated_u_nst(const Vector< double > &s, Vector< double > &veloc) const
Compute vector of FE interpolated velocity u at local coordinate s.
Definition: navier_stokes_elements.h:1505
virtual double interpolated_p_nst(const Vector< double > &s) const
Return FE interpolated pressure at local coordinate s.
Definition: navier_stokes_elements.h:1639
double du_dt_nst(const unsigned &n, const unsigned &i) const
Definition: navier_stokes_elements.h:880
TimeStepper *& position_time_stepper_pt()
Return a pointer to the position timestepper.
Definition: nodes.h:1022
Definition: shape.h:76
unsigned ntstorage() const
Definition: timesteppers.h:601
RealScalar s
Definition: level1_cplx_impl.h:130
char char char int int * k
Definition: level2_impl.h:374
t
Definition: plotPSD.py:36
unsigned el_dim
dimension
Definition: overloaded_cartesian_element_body.h:30
std::ptrdiff_t j
Definition: tut_arithmetic_redux_minmax.cpp:2

References el_dim, Error, i, j, k, s, size, and plotPSD::t.

◆ output() [2/2]

void oomph::MyCrouzeixRaviartElement::output ( std::ostream &  outfile,
const unsigned nplot 
)
inlinevirtual

Overload output function.

Reimplemented from oomph::FiniteElement.

104  {
105 
106  // Assign dimension
107  unsigned el_dim=2;
108 
109  // Vector of local coordinates
111 
112  // Acceleration
113  Vector<double> dudt(el_dim);
114 
115  // Mesh elocity
116  Vector<double> mesh_veloc(el_dim,0.0);
117 
118  // Tecplot header info
119  outfile << tecplot_zone_string(nplot);
120 
121  // Find out how many nodes there are
122  unsigned n_node = nnode();
123 
124  //Set up memory for the shape functions
125  Shape psif(n_node);
126  DShape dpsifdx(n_node,el_dim);
127 
128  // Loop over plot points
129  unsigned num_plot_points=nplot_points(nplot);
130  for (unsigned iplot=0;iplot<num_plot_points;iplot++)
131  {
132 
133  // Get local coordinates of plot point
134  get_s_plot(iplot,nplot,s);
135 
136  //Call the derivatives of the shape and test functions
137  dshape_eulerian(s,psif,dpsifdx);
138 
139  //Allocate storage
140  Vector<double> mesh_veloc(el_dim);
141  Vector<double> dudt(el_dim);
142  Vector<double> dudt_ALE(el_dim);
143  DenseMatrix<double> interpolated_dudx(el_dim,el_dim);
144 
145  //Initialise everything to zero
146  for(unsigned i=0;i<el_dim;i++)
147  {
148  mesh_veloc[i]=0.0;
149  dudt[i]=0.0;
150  dudt_ALE[i]=0.0;
151  for(unsigned j=0;j<el_dim;j++)
152  {
153  interpolated_dudx(i,j) = 0.0;
154  }
155  }
156 
157  //Calculate velocities and derivatives
158 
159  //Loop over directions
160  for(unsigned i=0;i<el_dim;i++)
161  {
162  //Get the index at which velocity i is stored
163  unsigned u_nodal_index = u_index_nst(i);
164  // Loop over nodes
165  for(unsigned l=0;l<n_node;l++)
166  {
167  dudt[i]+=du_dt_nst(l,u_nodal_index)*psif[l];
168  mesh_veloc[i]+=dnodal_position_dt(l,i)*psif[l];
169 
170  //Loop over derivative directions for velocity gradients
171  for(unsigned j=0;j<el_dim;j++)
172  {
173  interpolated_dudx(i,j) += nodal_value(l,u_nodal_index)*
174  dpsifdx(l,j);
175  }
176  }
177  }
178 
179 
180  // Get dudt in ALE form (incl mesh veloc)
181  for(unsigned i=0;i<el_dim;i++)
182  {
183  dudt_ALE[i]=dudt[i];
184  for (unsigned k=0;k<el_dim;k++)
185  {
186  dudt_ALE[i]-=mesh_veloc[k]*interpolated_dudx(i,k);
187  }
188  }
189 
190 
191  // Coordinates
192  for(unsigned i=0;i<el_dim;i++)
193  {
194  outfile << interpolated_x(s,i) << " ";
195  }
196 
197  // Velocities
198  for(unsigned i=0;i<el_dim;i++)
199  {
200  outfile << interpolated_u_nst(s,i) << " ";
201  }
202 
203  // Pressure
204  outfile << interpolated_p_nst(s) << " ";
205 
206  // Accelerations
207  for(unsigned i=0;i<el_dim;i++)
208  {
209  outfile << dudt_ALE[i] << " ";
210  }
211 
212  // Mesh velocity
213  for(unsigned i=0;i<el_dim;i++)
214  {
215  outfile << mesh_veloc[i] << " ";
216  }
217 
218  // History values of coordinates
219  unsigned n_prev=node_pt(0)->position_time_stepper_pt()->ntstorage();
220  for (unsigned t=1;t<n_prev;t++)
221  {
222  for(unsigned i=0;i<el_dim;i++)
223  {
224  outfile << interpolated_x(t,s,i) << " ";
225  }
226  }
227 
228  // History values of velocities
229  n_prev=node_pt(0)->time_stepper_pt()->ntstorage();
230  for (unsigned t=1;t<n_prev;t++)
231  {
232  for(unsigned i=0;i<el_dim;i++)
233  {
234  outfile << interpolated_u_nst(t,s,i) << " ";
235  }
236  }
237 
238  outfile << Error << " "
239  << size() << std::endl;
240  }
241 
242  // Write tecplot footer (e.g. FE connectivity lists)
243  write_tecplot_zone_footer(outfile,nplot);
244  }

References el_dim, Error, i, j, k, s, size, and plotPSD::t.

◆ set_error() [1/2]

void oomph::MyCrouzeixRaviartElement::set_error ( const double error)
inline

Set error value for post-processing.

71 {Error=error;}
int error
Definition: calibrate.py:297

References calibrate::error, and Error.

◆ set_error() [2/2]

void oomph::MyCrouzeixRaviartElement::set_error ( const double error)
inline

Set error value for post-processing.

71 {Error=error;}

References calibrate::error, and Error.

◆ square_of_l2_norm()

double oomph::MyCrouzeixRaviartElement::square_of_l2_norm ( )
inline

Get square of L2 norm of velocity.

249  {
250 
251  // Assign dimension
252  unsigned el_dim=2;
253  // Initalise
254  double sum=0.0;
255 
256  //Find out how many nodes there are
257  unsigned n_node = nnode();
258 
259  //Find the indices at which the local velocities are stored
260  unsigned u_nodal_index[el_dim];
261  for(unsigned i=0;i<el_dim;i++) {u_nodal_index[i] = u_index_nst(i);}
262 
263  //Set up memory for the velocity shape fcts
264  Shape psif(n_node);
265  DShape dpsidx(n_node,el_dim);
266 
267  //Number of integration points
268  unsigned n_intpt = integral_pt()->nweight();
269 
270  //Set the Vector to hold local coordinates
272 
273  //Loop over the integration points
274  for(unsigned ipt=0;ipt<n_intpt;ipt++)
275  {
276  //Assign values of s
277  for(unsigned i=0;i<el_dim;i++) s[i] = integral_pt()->knot(ipt,i);
278 
279  //Get the integral weight
280  double w = integral_pt()->weight(ipt);
281 
282  // Call the derivatives of the veloc shape functions
283  // (Derivs not needed but they are free)
284  double J = this->dshape_eulerian_at_knot(ipt,psif,dpsidx);
285 
286  //Premultiply the weights and the Jacobian
287  double W = w*J;
288 
289  //Calculate velocities
290  Vector<double> interpolated_u(el_dim,0.0);
291 
292  // Loop over nodes
293  for(unsigned l=0;l<n_node;l++)
294  {
295  //Loop over directions
296  for(unsigned i=0;i<el_dim;i++)
297  {
298  //Get the nodal value
299  double u_value = raw_nodal_value(l,u_nodal_index[i]);
300  interpolated_u[i] += u_value*psif[l];
301  }
302  }
303 
304  //Assemble square of L2 norm
305  for(unsigned i=0;i<el_dim;i++)
306  {
307  sum+=interpolated_u[i]*interpolated_u[i]*W;
308  }
309  }
310 
311  return sum;
312 
313  }
JacobiRotation< float > J
Definition: Jacobi_makeJacobi.cpp:3
RowVector3d w
Definition: Matrix_resize_int.cpp:3
Integral *const & integral_pt() const
Return the pointer to the integration scheme (const version)
Definition: elements.h:1963
virtual double dshape_eulerian_at_knot(const unsigned &ipt, Shape &psi, DShape &dpsidx) const
Definition: elements.cc:3325
double raw_nodal_value(const unsigned &n, const unsigned &i) const
Definition: elements.h:2576
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.
@ W
Definition: quadtree.h:63

References el_dim, i, J, s, w, and oomph::QuadTreeNames::W.

◆ variable_identifier() [1/2]

std::string oomph::MyCrouzeixRaviartElement::variable_identifier ( )
inline

Return variable identifier.

75  {
76  std::string txt="VARIABLES=";
77  txt+="\"x\",";
78  txt+="\"y\",";
79  txt+="\"u\",";
80  txt+="\"v\",";
81  txt+="\"p\",";
82  txt+="\"du/dt\",";
83  txt+="\"dv/dt\",";
84  txt+="\"u_m\",";
85  txt+="\"v_m\",";
86  txt+="\"x_h1\",";
87  txt+="\"y_h1\",";
88  txt+="\"x_h2\",";
89  txt+="\"y_h2\",";
90  txt+="\"u_h1\",";
91  txt+="\"v_h1\",";
92  txt+="\"u_h2\",";
93  txt+="\"v_h2\",";
94  txt+="\"error\",";
95  txt+="\"size\",";
96  txt+="\n";
97  return txt;
98  }
std::string string(const unsigned &i)
Definition: oomph_definitions.cc:286

References oomph::Global_string_for_annotation::string().

◆ variable_identifier() [2/2]

std::string oomph::MyCrouzeixRaviartElement::variable_identifier ( )
inline

Return variable identifier.

75  {
76  std::string txt="VARIABLES=";
77  txt+="\"x\",";
78  txt+="\"y\",";
79  txt+="\"u\",";
80  txt+="\"v\",";
81  txt+="\"p\",";
82  txt+="\"du/dt\",";
83  txt+="\"dv/dt\",";
84  txt+="\"u_m\",";
85  txt+="\"v_m\",";
86  txt+="\"x_h1\",";
87  txt+="\"y_h1\",";
88  txt+="\"x_h2\",";
89  txt+="\"y_h2\",";
90  txt+="\"u_h1\",";
91  txt+="\"v_h1\",";
92  txt+="\"u_h2\",";
93  txt+="\"v_h2\",";
94  txt+="\"error\",";
95  txt+="\"size\",";
96  txt+="\n";
97  return txt;
98  }

References oomph::Global_string_for_annotation::string().

Member Data Documentation

◆ Error

double oomph::MyCrouzeixRaviartElement::Error
private

Storage for elemental error estimate – used for post-processing.


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