Public Member Functions | List of all members
oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT > Class Template Reference

#include <multi_domain_boussinesq_elements.h>

Inheritance diagram for oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >:

Public Member Functions

 RefineableAdvectionDiffusionBoussinesqElement ()
 Constructor: call the underlying constructors. More...
 
void output (std::ostream &outfile, const unsigned &nplot)
 Output function: Output x, y, theta at Nplot^DIM plot points. More...
 
void output (std::ostream &outfile)
 Overload the standard output function with the broken default. More...
 
void output (FILE *file_pt)
 C-style output function: Broken default. More...
 
void output (FILE *file_pt, const unsigned &n_plot)
 C-style output function: Broken default. More...
 
void get_wind_adv_diff (const unsigned &ipt, const Vector< double > &s, const Vector< double > &x, Vector< double > &wind) const
 Overload the wind function in the advection-diffusion equations. This provides the coupling from the Navier–Stokes equations to the advection-diffusion equations because the wind is the fluid velocity, obtained from the "external" element. More...
 
void fill_in_contribution_to_jacobian (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 Compute the element's residual vector and the Jacobian matrix. More...
 
void identify_all_field_data_for_external_interaction (Vector< std::set< FiniteElement *> > const &external_elements_pt, std::set< std::pair< Data *, unsigned > > &paired_interaction_data)
 Overload the function that must return all field data involved in the interaction with the external (Navier Stokes) element. Only the velocity dofs in the Navier Stokes element affect the interaction with the current element. More...
 
void fill_in_contribution_to_jacobian_and_mass_matrix (Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix)
 Add the element's contribution to its residuals vector, jacobian matrix and mass matrix. More...
 
void get_dwind_adv_diff_dexternal_element_data (const unsigned &ipt, const unsigned &i, Vector< double > &result, Vector< unsigned > &global_eqn_number)
 Fill in the derivatives of the wind with respect to the external unknowns. More...
 
void fill_in_off_diagonal_block_analytic (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 Compute the contribution of the external degrees of freedom (velocities) on the advection-diffusion equations. More...
 
void get_dof_numbers_for_unknowns (std::list< std::pair< unsigned long, unsigned > > &dof_lookup_list) const
 Classify dofs for use in block preconditioner. More...
 
unsigned ndof_types () const
 Specify number of dof types for use in block preconditioner. More...
 

Detailed Description

template<class AD_ELEMENT, class NST_ELEMENT>
class oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >

Build an AdvectionDiffusionElement that inherits from ElementWithExternalElement so that it can "communicate" with the a NavierStokesElement that provides its wind.

Definition at line 381 of file multi_domain_boussinesq_elements.h.

Constructor & Destructor Documentation

◆ RefineableAdvectionDiffusionBoussinesqElement()

template<class AD_ELEMENT , class NST_ELEMENT >
oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::RefineableAdvectionDiffusionBoussinesqElement ( )
inline

Constructor: call the underlying constructors.

Definition at line 388 of file multi_domain_boussinesq_elements.h.

Member Function Documentation

◆ fill_in_contribution_to_jacobian()

template<class AD_ELEMENT , class NST_ELEMENT >
void oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_contribution_to_jacobian ( Vector< double > &  residuals,
DenseMatrix< double > &  jacobian 
)
inline

Compute the element's residual vector and the Jacobian matrix.

Definition at line 472 of file multi_domain_boussinesq_elements.h.

◆ fill_in_contribution_to_jacobian_and_mass_matrix()

template<class AD_ELEMENT , class NST_ELEMENT >
void oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_contribution_to_jacobian_and_mass_matrix ( Vector< double > &  residuals,
DenseMatrix< double > &  jacobian,
DenseMatrix< double > &  mass_matrix 
)
inline

Add the element's contribution to its residuals vector, jacobian matrix and mass matrix.

Definition at line 503 of file multi_domain_boussinesq_elements.h.

◆ fill_in_off_diagonal_block_analytic()

template<class AD_ELEMENT , class NST_ELEMENT >
void oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic ( Vector< double > &  residuals,
DenseMatrix< double > &  jacobian 
)
inline

Compute the contribution of the external degrees of freedom (velocities) on the advection-diffusion equations.

Definition at line 539 of file multi_domain_boussinesq_elements.h.

◆ get_dof_numbers_for_unknowns()

template<class AD_ELEMENT , class NST_ELEMENT >
void oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::get_dof_numbers_for_unknowns ( std::list< std::pair< unsigned long, unsigned > > &  dof_lookup_list) const
inline

Classify dofs for use in block preconditioner.

Definition at line 693 of file multi_domain_boussinesq_elements.h.

◆ get_dwind_adv_diff_dexternal_element_data()

template<class AD_ELEMENT , class NST_ELEMENT >
void oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::get_dwind_adv_diff_dexternal_element_data ( const unsigned &  ipt,
const unsigned &  i,
Vector< double > &  result,
Vector< unsigned > &  global_eqn_number 
)
inline

Fill in the derivatives of the wind with respect to the external unknowns.

Definition at line 517 of file multi_domain_boussinesq_elements.h.

◆ get_wind_adv_diff()

template<class AD_ELEMENT , class NST_ELEMENT >
void oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::get_wind_adv_diff ( const unsigned &  ipt,
const Vector< double > &  s,
const Vector< double > &  x,
Vector< double > &  wind 
) const
inline

Overload the wind function in the advection-diffusion equations. This provides the coupling from the Navier–Stokes equations to the advection-diffusion equations because the wind is the fluid velocity, obtained from the "external" element.

Definition at line 454 of file multi_domain_boussinesq_elements.h.

◆ identify_all_field_data_for_external_interaction()

template<class AD_ELEMENT , class NST_ELEMENT >
void oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::identify_all_field_data_for_external_interaction ( Vector< std::set< FiniteElement *> > const &  external_elements_pt,
std::set< std::pair< Data *, unsigned > > &  paired_interaction_data 
)

Overload the function that must return all field data involved in the interaction with the external (Navier Stokes) element. Only the velocity dofs in the Navier Stokes element affect the interaction with the current element.

Overload the function that must return all field data involved in the interaction with the external (Navier Stokes) element. Only the velocity dofs in the Navier Stokes element affect the interaction with the current element.

Definition at line 757 of file multi_domain_boussinesq_elements.h.

Referenced by oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::ndof_types().

◆ ndof_types()

template<class AD_ELEMENT , class NST_ELEMENT >
unsigned oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::ndof_types ( ) const
inline

◆ output() [1/4]

template<class AD_ELEMENT , class NST_ELEMENT >
void oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output ( std::ostream &  outfile,
const unsigned &  nplot 
)
inline

Output function: Output x, y, theta at Nplot^DIM plot points.

Definition at line 407 of file multi_domain_boussinesq_elements.h.

◆ output() [2/4]

template<class AD_ELEMENT , class NST_ELEMENT >
void oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output ( std::ostream &  outfile)
inline

Overload the standard output function with the broken default.

Definition at line 439 of file multi_domain_boussinesq_elements.h.

◆ output() [3/4]

template<class AD_ELEMENT , class NST_ELEMENT >
void oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output ( FILE *  file_pt)
inline

C-style output function: Broken default.

Definition at line 442 of file multi_domain_boussinesq_elements.h.

◆ output() [4/4]

template<class AD_ELEMENT , class NST_ELEMENT >
void oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::output ( FILE *  file_pt,
const unsigned &  n_plot 
)
inline

C-style output function: Broken default.

Definition at line 446 of file multi_domain_boussinesq_elements.h.


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