![]() |
|
Global variables. More...
Functions | |
void | constant_pressure (const Vector< double > &xi, const Vector< double > &x, const Vector< double > &n, Vector< double > &traction) |
Constant pressure load. More... | |
void | wind_function (const Vector< double > &x, Vector< double > &wind) |
Wind. More... | |
void | swimming (const Vector< double > &x, Vector< double > &swim) |
void | diff_function (const Vector< double > &x, DenseMatrix< double > &D) |
void | wall_unit_normal_fct (const Vector< double > &x, Vector< double > &normal) |
Function that specifies the wall unit normal. More... | |
void | axial_pressure_gradient (const double &time, const Vector< double > &x, Vector< double > &result) |
A function to specify a constant axial body force. More... | |
void | press_load (const Vector< double > &xi, const Vector< double > &x, const Vector< double > &N, Vector< double > &load) |
Load function: Perturbation pressure to force non-axisymmetric deformation. More... | |
double & | external_pressure () |
Access function to value of external pressure. More... | |
void | load (const Vector< double > &xi, const Vector< double > &x, const Vector< double > &N, Vector< double > &load) |
Load function: Apply a constant external pressure to the beam. More... | |
Vector< double > | P (5) |
Vector< double > | G (2) |
Direction of gravity. More... | |
void | hydrostatic_pressure (const double &time, const Vector< double > &x, const Vector< double > &n, Vector< double > &traction) |
Function that prescribes the hydrostatic pressure field at the outlet. More... | |
void | spring_load (const Vector< double > &xi, const Vector< double > &x, const Vector< double > &N, Vector< double > &load) |
Load function for the wall elements. More... | |
void | spring_load_lower (const Vector< double > &xi, const Vector< double > &x, const Vector< double > &N, Vector< double > &load) |
Load function for the wall elements. More... | |
void | load (const Vector< double > &xi, const Vector< double > &x, const Vector< double > &N, Vector< double > &load) |
double | flux (const double &t) |
void | prescribed_traction (const double &t, const Vector< double > &x, const Vector< double > &n, Vector< double > &traction) |
Traction applied on the fluid at the left (inflow) boundary. More... | |
void | set_params () |
void | pcos_load (const Vector< double > &xi, const Vector< double > &x, const Vector< double > &N, Vector< double > &load) |
void | outside_solid_boundary_traction (const double &time, const Vector< double > &x, const Vector< double > &n, Vector< double > &result) |
Traction applied to the outside of the solid mesh. More... | |
void | fluid_inflow_boundary_traction (const double &time, const Vector< double > &x, const Vector< double > &n, Vector< double > &result) |
Inflow traction applied to the fluid mesh. More... | |
void | validation_solid_fsi_boundary_traction (const double &time, const Vector< double > &x, const Vector< double > &n, Vector< double > &result) |
Traction applied to the solid mesh at fsi interface (for validation only) More... | |
void | validation_fluid_fsi_boundary_traction (const double &time, const Vector< double > &x, const Vector< double > &n, Vector< double > &result) |
void | pulse_wave_solution (const double &time, const Vector< double > &x, Vector< double > &soln) |
"Exact" solution for propagating pulse wave More... | |
void | update_dependent_parameters () |
Helper function to update dependent parameters. More... | |
void | doc_dependent_parameters () |
Doc dependent parameters. More... | |
std::string | Directory ("RESLT") |
template<class ELEMENT > | |
void | edge_sign_setup (Mesh *mesh_pt) |
Global function that completes the edge sign setup. More... | |
void | gravity (const double &time, const Vector< double > &xi, Vector< double > &b) |
Non-dimensional gravity as body force. More... | |
Vector< double > | Gravity (2) |
Gravity vector. More... | |
void | body_force (const double &time, const Vector< double > &x, Vector< double > &result) |
Functional body force. More... | |
void | zero_body_force (const double &time, const Vector< double > &x, Vector< double > &result) |
Zero functional body force. More... | |
Vector< double > | Direction_of_gravity (3) |
Gravity vector. More... | |
void | wall_unit_normal_left_fct (const Vector< double > &x, Vector< double > &normal) |
Function that specifies the wall unit normal. More... | |
void | wall_unit_normal_right_fct (const Vector< double > &x, Vector< double > &normal) |
Function that specifies the wall unit normal. More... | |
Vector< double > | Tau (2, 1.0) |
void | viscosity_ratio_function (double &temperature, double &result) |
Viscosity ratio function modeled following a Arrhenius fashion. More... | |
void | prescribed_beta_on_fixed_r_boundary (const Vector< double > &x_vector, double &beta) |
Beta on a boundary on which r is fixed. More... | |
void | prescribed_alpha_on_fixed_r_boundary (const Vector< double > &x_vect, double &alpha) |
Alfa on a boundary on which r is fixed. More... | |
void | inflow (const Vector< double > &x, Vector< double > &veloc) |
Vector< double > | G (2, 0.0) |
The Vector direction of gravity, set in main() More... | |
void | wall_unit_normal_inlet_fct (const Vector< double > &x, Vector< double > &normal) |
Function that specifies the wall unit normal at the inlet. More... | |
void | wall_unit_normal_outlet_fct (const Vector< double > &x, Vector< double > &normal) |
Function that specified the wall unit normal at the outlet. More... | |
void | hydrostatic_pressure_outlet (const double &time, const Vector< double > &x, const Vector< double > &n, Vector< double > &traction) |
Function that prescribes the hydrostatic pressure field at the outlet. More... | |
void | hydrostatic_pressure_inlet (const double &time, const Vector< double > &x, const Vector< double > &n, Vector< double > &traction) |
Function that prescribes hydrostatic pressure field at the inlet. More... | |
void | get_exact_u (const double &t, const Vector< double > &x, Vector< double > &u) |
Exact solution of the problem as a vector containing u,v,p. More... | |
double | height (const double &x) |
Height of domain. More... | |
void | traction_function (const double &time, const Vector< double > &x, Vector< double > &traction) |
Unused (but assigned) function to specify tractions. More... | |
void | growth_function (const Vector< double > &xi, double &gamma) |
Growth function. More... | |
double | multiplier (const Vector< double > &xi) |
void | body_force (const Vector< double > &xi, const double &t, Vector< double > &b) |
Body force vector: Vertically downwards with magnitude Gravity. More... | |
Variables | |
StrainEnergyFunction * | Strain_energy_function_pt =0 |
Pointer to strain energy function. More... | |
ConstitutiveLaw * | Constitutive_law_pt |
Pointer to constitutive law. More... | |
double | E = 1.0 |
Elastic modulus. More... | |
double | Nu = 0.3 |
Poisson's ratio. More... | |
double | C1 = 1.3 |
"Mooney Rivlin" coefficient for generalised Mooney Rivlin law More... | |
double | P = 0.0 |
Uniform pressure. More... | |
double | lenScale = 1 |
Length scale. More... | |
double | timeScale = 1 |
Time scale. More... | |
double | Peclet =200.0 |
Peclet number. More... | |
double | Length =10.0 |
Length of the pipe. More... | |
double | Radius =1.0 |
Radius of the pipe. More... | |
double | Peclet_St = 1.0 |
Peclet number multiplied by Strouhal number. More... | |
Vector< double > | Wall_normal |
Direction of the wall normal vector. More... | |
double | Re = 0.1 |
Reynolds number. More... | |
double | ReInvFr = 0.01 |
Product of Reynolds number and inverse of Froude number. More... | |
double | Ca = 10.0 |
Capillary number. More... | |
double | P_ext = 0.0 |
External pressure. More... | |
Vector< double > | G (3) = 1.0 |
Direction of gravity. More... | |
double | ReSt = 5.0 |
Womersley number. More... | |
double | Epsilon = 0.1 |
Free surface cosine deform parameter. More... | |
ofstream | Pvd_file |
double | Delta = 0.128 |
The curvature of the torus. More... | |
double | St = 1.0 |
Strouhal number. More... | |
double | Viscosity_Ratio = 0.1 |
double | Density_Ratio = 0.5 |
double | Dean = 100.0 |
The Dean number. More... | |
double | Lambda_sq =0.0 |
Pseudo-solid mass density. More... | |
double | Mu = 0.0 |
double | H =0.05 |
Nondim thickness. More... | |
double | Xprescr = 1.0 |
Prescribed position (only used for displacement control) More... | |
double | Pcos =0.0 |
Perturbation pressure. More... | |
Data * | Pext_data_pt =0 |
Pointer to pressure load. More... | |
unsigned | Nbuckl =3 |
Buckling wavenumber. More... | |
double | Sigma0 =1.0e3 |
2nd Piola Kirchhoff pre-stress More... | |
unsigned | Long_run_flag =1 |
Flag for long/short run: Default = perform long run. More... | |
unsigned | Fixed_timestep_flag =1 |
Flag for fixed timestep: Default = fixed timestep. More... | |
bool | Consistent_newmark_ic |
double | T_kick |
Duration of transient load. More... | |
double | Alpha =1.0 |
Scaling factor for wall thickness (to be used in an exercise) More... | |
double | L = 8.0 |
Length of beam. More... | |
double * | Lambda_pt |
double * | Mu_pt |
double | ReCa =0.0 |
Reynolds divided by Capillary number. More... | |
double | Bo = 0.0 |
Bond number. More... | |
double | Pext = 0.0 |
External Pressure. More... | |
double | Gamma = 1.0e-7 |
double | T = 0.0 |
Period of oscillations. More... | |
double | Kstiff = 0.5*50.0e-7 |
Spring stiffness. More... | |
double | Kseparation = H |
Huge stiffness for hitting. More... | |
double | Ktable = 0.0001 |
Huge stiffness for the table. More... | |
double | Tube_width = 10.0 |
Natural width of the open tube. More... | |
double | Table_position = 10.78 |
Position of the table. More... | |
double | Q =1.0e-2 |
Ratio of scales. More... | |
double | Rest_length_linear =1.0 |
Rest length of the linear springs. More... | |
bool | Non_linear_springs = false |
Do we include the non-linear springs. More... | |
GeomObject * | Upper_wall_pt |
Pointer to the upper wall. More... | |
GeomObject * | Lower_wall_pt |
Pointer to the lower wall. More... | |
map< double, pair< GeomObject *, Vector< double > > > | upper_map |
Upper wall map. More... | |
map< double, pair< GeomObject *, Vector< double > > > | lower_map |
Lower wall map. More... | |
Data * | P_ext_data_pt =0 |
Pointer to Data object that stores external pressure. More... | |
double | Pmin =1.5 |
double | Pmax =2.0 |
double | P_step =0.0 |
double | Yprescr = 1.0 |
double | Yprescr_min =0.6 |
double | Period =2.0 |
Period for fluctuations in flux. More... | |
double | Min_flux =1.0 |
Min. flux. More... | |
double | Max_flux =2.0 |
Max. flux. More... | |
double | P_up =0.0 |
Default pressure on the left boundary. More... | |
double | Alpha_sq =50.0 |
Square of Womersly number (a frequency parameter) More... | |
double | Density_ratio =1.0 |
Density ratio of the solid and the fluid. More... | |
bool | Pin_fluid_on_fsi =false |
For validation only. More... | |
double | Wo = 0.0 |
double | Inner_radius =0.5 |
Inner radius of tube. More... | |
double | Outer_radius =1.0 |
Outer radius of tube. More... | |
double | P_inlet_const =Length*4.0/(Inner_radius*Inner_radius) |
Constant inlet pressure (for steady Poiseuille flow) More... | |
double | T_cos =0.0 |
double | P_outside_scale =0.0 |
double | P_wall =1.0 |
Constant wall pressure for validation. More... | |
double | Tau =2.0/Inner_radius |
Shear stress (for steady Poiseuille flow) More... | |
double | Wavespeed =0.0 |
Storage for Moens Korteweg wavespeed – dependent parameter! More... | |
double | Pressure_wavespeed =0.0 |
Storage for pressure wavespeed in solid – dependent parameter! More... | |
double | Chris_p_factor =1.0 |
double | Poro_elastic_to_navier_stokes_fluid_density =1.0 |
double | Permeability =5.0 |
double | Porosity =0.18 |
Porosity. More... | |
double | Density_ratio_poro =1.0 |
double | Inverse_slip_rate_coefficient =0.0 |
Inverse slip rate coefficient. More... | |
double | Lambda_lame = 0.0 |
Lambda - first Lame parameter – dependent parameter; compute from nu. More... | |
double | Mu_lame = 0.0 |
mu - second Lame parameter – dependent parameter; compute from nu More... | |
double | Rho_f_over_rho = 0.0 |
double | Element_area_fluid =0.002 |
Target element area for fluid mesh. More... | |
double | Element_area_solid =0.002 |
Target element area for poro-elasticmesh. More... | |
double | Fluid_mesh_bl_thickness =0.01 |
Fluid mesh boundary layer thickness. More... | |
double | Solid_mesh_bl_thickness =0.01 |
Poro-elastic mesh boundary layer thickness. More... | |
double | P_inlet_initial =500.0 |
Constant inlet pressure (for steady Poiseuille flow) More... | |
double | P_inlet_step =P_inlet_initial |
double | T_tanh =0.25 |
Parameter for tanh origin for pressure incrementation. More... | |
double | Alpha_tanh =100.0 |
Steepness parameter for tanh for pressure incrementation. More... | |
double | Mesh_Nu = 0.1 |
Mesh poisson ratio. More... | |
ConstitutiveLaw * | Mesh_constitutive_law_pt =0 |
Pointer to constitutive law for the mesh. More... | |
double | Gravity =0.0 |
Non-dim gravity. More... | |
double | C2 =1.3 |
"Mooney Rivlin" coefficient for generalised Mooney Rivlin law More... | |
double | Re_invFr =100 |
Reynolds/Froude number. More... | |
double | Prescribed_y = 1.0 |
Prescribed position of control point. More... | |
WarpedLine | Boundary_geom_object (0.0) |
GeomObject specifying the shape of the boundary: Initially it's flat. More... | |
bool | Actually_attach_face_elements =true |
Actually attach elements? More... | |
double | Inverse_Prandtl =1.0 |
1/Prandtl number More... | |
double | Rayleigh = 1800.0 |
Rayleigh number. More... | |
Vector< double > | Direction_of_gravity (2) |
Gravity vector. More... | |
double | Reynolds =10.0 |
Reynolds number. More... | |
double | Lewis = 10.0 |
The Lewis number. More... | |
Vector< double > | Diff (2, 1.0) = 1.0/Pe |
Double relative diffusivities. More... | |
double | Rayleigh_T = 1800.0 |
double | Rayleigh_S = -1000 |
Solutal Rayleigh number. More... | |
double | Lambda = 1.414 |
Length of domain. More... | |
double | Scaled_Bond = 0.0 |
double | Biot = 0.0 |
Biot number. More... | |
double | Marangoni = 125.0 |
Marangoni number. More... | |
double | Capillary = 0.0045 |
Capillary number. More... | |
double | Beta = 100.0 |
Surface Elasticity number. More... | |
double | Peclet_S = 1.0 |
Surface Peclet number. More... | |
double | Peclet_St_S = 100.0 |
\shorT Sufrace Peclet number multiplied by Strouhal number More... | |
const double | Pi =MathematicalConstants::Pi |
Set the value of Pi. More... | |
double | Volume = 1.2 |
The volume of the domain. More... | |
double | Angle = 0.5*Pi |
The contact angle. More... | |
double | Film_Thickness = 0.2 |
double | Alpha_absorption = 1.0 |
Alpha for absorption kinetics. More... | |
double | K = 0.01 |
The ratio of adsorption-desorption times. More... | |
double | Pe = 10000.0 |
Peclet number. More... | |
double | PeSt = Pe |
double | Pe_reference_scale =1.0 |
Vector< double > | D (2, 1.0) |
Diffusivity (identically one from our non-dimensionalisation) More... | |
double | DD_s = 1000.0 |
The ratio of bulk diffusion to surface diffusion. More... | |
double | Ra = 10.0 |
Rayleigh number. More... | |
double | Bi = 0.01 |
Biot number. More... | |
double | T_ext = 0.0 |
Exterior temperature. More... | |
double | T_inlet = 1.0 |
Inlet temperature. More... | |
double | eta = 0.0 |
Eta factor (exponent of the exponecial function) More... | |
double * | H_lo_pt |
Pointer to film thickness at outflow on the lower wall. More... | |
double * | H_up_pt |
Pointer to film thickness at outflow on the upper wall. More... | |
double * | Y_lo_pt |
Pointer to y-position at inflow on the lower wall. More... | |
double * | Y_up_pt |
Pointer to y-position at inflow on the upper wall. More... | |
double | Pitch = 1.0 |
Data * | Pout_data_pt |
Pointer to Data holding downstream pressure load. More... | |
double | Omega = 0.0 |
Rotation rate. More... | |
double | N_wave = 3 |
Set the number of waves desired in the domain. More... | |
double | Inlet_Angle = 2.0*atan(1.0) |
The contact angle that is imposed at the inlet (pi) More... | |
double | Max_permitted_error =-1.0 |
double | Min_permitted_error =-1.0 |
double | A =1.0 |
x-Half axis length More... | |
double | A_hat =0.1 |
x-Half axis amplitude More... | |
double | X_indent_start =0.5 |
Start of indented region. More... | |
double | L_total =4.0 |
Total length of domain. More... | |
double | Height = 1.0 |
double | Length_tip = 0.50 |
double | Length_liq = 1.0 |
double | Length_can = 1.5 |
unsigned | Ncan = 2 |
unsigned | Ntip = 2 |
unsigned | Nliq = 2 |
double | Rat_press = 2.87 |
double | R_l =0.01 |
double | R_r =1. |
int | xmesh =30 |
int | ymesh =15 |
double | Rstep_prestart =30.0 |
double | Rmax_prestart =94. |
double | Rstep =0.1 |
double | Rmax =100. |
double | epsilon =0.1 |
bool | inlet_traction =false |
double | eta_inlet =1.0 |
bool | outlet_traction =true |
double | eta_outlet =0.0 |
bool | pinv =true |
bool | stokes =false |
bool | log_mesh =true |
bool | new_outlet_region =true |
int | uniform = 0 |
int | adaptive = 0 |
double | T_pcos_end =10.0 |
Only keep p_cos switched on until T_pcos_end. More... | |
double | Prescribed_z = 0.0 |
Prescribed position of control point. More... | |
double | Uniform_gamma =1.1 |
Uniform volumetric expansion. More... | |
double | lambda =1.0 |
Global variables.
Extension of global variables for self tests.
Namespace for the physical parameters in the problem.
A namespace for the physical parameters in the problem.
Global parameters.
Namepspace for global parameters.
Global variables that represent physical properties.
Namespace for global parameters.
Namespace for physical parameters.
Namespace for phyical parameters.
Namespace for physical variables.
//////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////
///////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////
//////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////
//////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////
///////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////
//////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////
/////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////
Namepspace for global parameters, chosen from Campana et al. as in the axisymmetric problem.
Namespace for physical parameters The parameter values are chosen to be those used in Figures 8, 9 in Campana et al.
Namespace for physical parameters The parameter values are chosen to be those used in Figures 7, 12 in Campana & Saita
//////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////
//////////////////////////////////////////////////////// //////////////////////////////////////////////////////// ////////////////////////////////////////////////////////
//////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////
//////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////
/////////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////////
void Global_Physical_Variables::axial_pressure_gradient | ( | const double & | time, |
const Vector< double > & | x, | ||
Vector< double > & | result | ||
) |
A function to specify a constant axial body force.
References Dean, Delta, sqrt(), and plotDoE::x.
Referenced by UnstructuredTorusProblem< ELEMENT >::actions_after_adapt(), and UnstructuredTorusProblem< ELEMENT >::UnstructuredTorusProblem().
void Global_Physical_Variables::body_force | ( | const double & | time, |
const Vector< double > & | x, | ||
Vector< double > & | result | ||
) |
Functional body force.
Body force vector: Vertically downwards with magnitude Gravity.
References Re_invFr.
Referenced by ElasticFishProblem< ELEMENT >::ElasticFishProblem(), and main().
void Global_Physical_Variables::body_force | ( | const Vector< double > & | xi, |
const double & | t, | ||
Vector< double > & | b | ||
) |
Body force vector: Vertically downwards with magnitude Gravity.
References b, and Global_Parameters::Gravity.
void Global_Physical_Variables::constant_pressure | ( | const Vector< double > & | xi, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | traction | ||
) |
Constant pressure load.
Constant pressure load. The arguments to this function are imposed on us by the SolidTractionElements which allow the traction to depend on the Lagrangian and Eulerian coordinates x and xi, and on the outer unit normal to the surface. Here we only need the outer unit normal.
Referenced by UnstructuredSolidProblem< ELEMENT, MESH >::actions_after_adapt(), DiskShockWaveProblem< ELEMENT, TIMESTEPPER >::actions_after_adapt(), BlockCompressionProblem< ELEMENT >::create_traction_elements(), SheetGlueProblem< ELEMENT >::create_traction_elements(), DiskShockWaveProblem< ELEMENT, TIMESTEPPER >::DiskShockWaveProblem(), CantileverProblem< ELEMENT >::set_traction_pt(), and StaticDiskCompressionProblem< ELEMENT >::StaticDiskCompressionProblem().
void Global_Physical_Variables::diff_function | ( | const Vector< double > & | x, |
DenseMatrix< double > & | D | ||
) |
Diffusivity tensor (again 3x3 but only the upper 2x2 block affects the axisymmetric advection diffusion equations)
References D.
std::string Global_Physical_Variables::Directory | ( | "RESLT" | ) |
Referenced by main().
void Global_Physical_Variables::doc_dependent_parameters | ( | ) |
Doc dependent parameters.
References Lambda_sq, oomph::oomph_info, Pressure_wavespeed, Wavespeed, and Wo.
Referenced by main().
void Global_Physical_Variables::edge_sign_setup | ( | Mesh * | mesh_pt | ) |
Global function that completes the edge sign setup.
References anonymous_namespace{skew_symmetric_matrix3.cpp}::assignments(), e(), oomph::Mesh::element_pt(), i, and oomph::Mesh::nelement().
double Global_Physical_Variables::external_pressure | ( | ) |
Access function to value of external pressure.
Return a reference to the external pressure load on the elastic ring. A reference is obtained by de-referencing the pointer to the data value that contains the external load
Return a reference to the external pressure load on the elastic tube.
References Pext_data_pt, and oomph::Data::value_pt().
Referenced by FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), main(), ElasticRingProblem< ELEMENT >::parameter_study(), and ShellProblem< ELEMENT >::solve().
void Global_Physical_Variables::fluid_inflow_boundary_traction | ( | const double & | time, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | result | ||
) |
Inflow traction applied to the fluid mesh.
References cos(), P_inlet_const, BiharmonicTestFunctions2::Pi, and T_cos.
Referenced by PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_fluid_traction_elements().
Flux: Pulsatile flow fluctuating between Min_flux and Max_flux with period Period
References cos(), Max_flux, Min_flux, Period, BiharmonicTestFunctions2::Pi, and plotPSD::t.
Referenced by FSIChannelWithLeafletProblem< ELEMENT >::actions_before_implicit_timestep(), and FSIChannelWithLeafletProblem< ELEMENT >::doc_solution().
The Vector direction of gravity, set in main()
void Global_Physical_Variables::get_exact_u | ( | const double & | t, |
const Vector< double > & | x, | ||
Vector< double > & | u | ||
) |
Exact solution of the problem as a vector containing u,v,p.
References a, A_hat, cos(), BiharmonicTestFunctions2::Pi, GlobalPhysicalVariables::Re, GlobalPhysicalVariables::ReSt, sin(), St, plotPSD::t, and plotDoE::x.
Referenced by OscEllipseProblem< ELEMENT, TIMESTEPPER >::doc_solution(), and OscEllipseProblem< ELEMENT, TIMESTEPPER >::set_initial_condition().
void Global_Physical_Variables::gravity | ( | const double & | time, |
const Vector< double > & | xi, | ||
Vector< double > & | b | ||
) |
Non-dimensional gravity as body force.
Referenced by CantileverProblem< ELEMENT >::CantileverProblem(), and CompressedSquareProblem< ELEMENT >::CompressedSquareProblem().
Growth function.
Referenced by StaticDiskCompressionProblem< ELEMENT >::StaticDiskCompressionProblem().
Height of domain.
References H, L, BiharmonicTestFunctions2::Pi, sin(), plotDoE::x, and X_indent_start.
Referenced by GranuHeap::actionsAfterTimeStep(), FlowAroundCylinderProblem< ELEMENT >::add_eigenproblem(), oomph::TetMeshBase::assess_mesh_quality(), ChannelSpineFlowProblem< ELEMENT >::ChannelSpineFlowProblem(), Beam::checkBeamDeflection(), ClosedCSCWalls::ClosedCSCWalls(), CollapsibleChannelProblem< ELEMENT >::CollapsibleChannelProblem(), CSCWalls::CSCWalls(), CylinderAndInterfaceMesh< ELEMENT >::CylinderAndInterfaceMesh(), oomph::CylinderWithFlagDomain::CylinderWithFlagDomain(), oomph::CylinderWithFlagMesh< ELEMENT >::CylinderWithFlagMesh(), ThreeDimBethertonProblem< ELEMENT >::doc_solution(), FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), ChuteWithHopper::getMaximumVelocityInducedByGravity(), main(), ChuteBottom::makeRoughBottom(), MandelbrotWidget::mouseMoveEvent(), MandelbrotWidget::mousePressEvent(), MandelbrotWidget::paintEvent(), ParticleCreation::ParticleCreation(), protectiveWall::protectiveWall(), RectangleWithHoleDomain::RectangleWithHoleDomain(), RectangleWithHoleMesh< ELEMENT >::RectangleWithHoleMesh(), oomph::RefineableQuadMeshWithMovingCylinder< ELEMENT >::RefineableQuadMeshWithMovingCylinder(), RefineableRotatingCylinderProblem< ELEMENT >::RefineableRotatingCylinderProblem(), MandelbrotWidget::resizeEvent(), RenderingWidget::resizeGL(), ChuteWithHopper::setHopper(), SphericalIndenter::setIndenterHeight(), Camera::setViewport(), SinusoidalWall::SinusoidalWall(), SpikedLine::SpikedLine(), oomph::StraightLine::StraightLine(), T_protectiveWall::T_protectiveWall(), ThreeDimBethertonProblem< ELEMENT >::ThreeDimBethertonProblem(), TurekNonFSIProblem< ELEMENT >::TurekNonFSIProblem(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem(), Tutorial11::Tutorial11(), inflowFromPeriodic::writeXBallsScript(), and ChuteWithPeriodicInflow::writeXBallsScript().
void Global_Physical_Variables::hydrostatic_pressure | ( | const double & | time, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | traction | ||
) |
Function that prescribes the hydrostatic pressure field at the outlet.
References G, GlobalPhysicalVariables::ReInvFr, and plotDoE::x.
Referenced by AirwayReopeningProblem< ELEMENT >::construct_pressure_gradient_outlet_elements(), and ThreeDimBethertonProblem< ELEMENT >::ThreeDimBethertonProblem().
void Global_Physical_Variables::hydrostatic_pressure_inlet | ( | const double & | time, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | traction | ||
) |
Function that prescribes hydrostatic pressure field at the inlet.
References G, GlobalPhysicalVariables::ReInvFr, and plotDoE::x.
Referenced by InclinedPlaneProblem< ELEMENT, INTERFACE_ELEMENT >::make_traction_elements().
void Global_Physical_Variables::hydrostatic_pressure_outlet | ( | const double & | time, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | traction | ||
) |
Function that prescribes the hydrostatic pressure field at the outlet.
References G, GlobalPhysicalVariables::ReInvFr, and plotDoE::x.
Referenced by InclinedPlaneProblem< ELEMENT, INTERFACE_ELEMENT >::make_traction_elements().
Set inflow velocity, based on spine heights at outflow and channel width at inflow
References H_lo_pt, H_up_pt, OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, plotDoE::x, y, Y_lo_pt, and Y_up_pt.
Referenced by BrethertonProblem< ELEMENT >::actions_before_newton_convergence_check(), and BrethertonProblem< ELEMENT >::activate_inflow_dependency().
void Global_Physical_Variables::load | ( | const Vector< double > & | xi, |
const Vector< double > & | x, | ||
const Vector< double > & | N, | ||
Vector< double > & | load | ||
) |
Load function: Apply a constant external pressure to the beam.
Load function: Apply a constant external pressure to the wall. Note: This is the load without the fluid contribution! Fluid load gets added on by FSIWallElement.
Referenced by ElasticBeamProblem::ElasticBeamProblem(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), and load().
void Global_Physical_Variables::load | ( | const Vector< double > & | xi, |
const Vector< double > & | x, | ||
const Vector< double > & | N, | ||
Vector< double > & | load | ||
) |
Load function: Apply a constant external pressure to the wall. Note: This is the load without the fluid contribution! Fluid load gets added on by FSIWallElement.
References i, load(), N, and P_ext_data_pt.
Multiplier for inertia terms (needed for consistent assignment of initial conditions in Newmark scheme)
References Lambda_sq.
Referenced by NonRefineableBinArray::fill_bin_array(), oomph::PolarStreamfunctionTractionElement< ELEMENT >::fill_in_generic_residual_contribution(), oomph::PolarNavierStokesTractionElement< ELEMENT >::fill_in_generic_residual_contribution(), NonRefineableBinArray::get_bin(), SuperQuadricParticle::getInitialGuessForContact(), oomph::RefineableQElement< 2 >::interpolated_zeta_on_edge(), NonRefineableBinArray::locate_zeta(), main(), DiskOscillationProblem< ELEMENT >::run(), BaseInteraction::setLagrangeMultiplier(), oomph::ILUZeroPreconditioner< CCDoubleMatrix >::setup(), and oomph::ILUZeroPreconditioner< CRDoubleMatrix >::setup().
void Global_Physical_Variables::outside_solid_boundary_traction | ( | const double & | time, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | result | ||
) |
Traction applied to the outside of the solid mesh.
References n, and P_outside_scale.
Referenced by PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_solid_traction_elements().
Referenced by ABCProblem< ELEMENT, TIMESTEPPERT >::ABCProblem(), and main().
void Global_Physical_Variables::pcos_load | ( | const Vector< double > & | xi, |
const Vector< double > & | x, | ||
const Vector< double > & | N, | ||
Vector< double > & | load | ||
) |
void Global_Physical_Variables::prescribed_alpha_on_fixed_r_boundary | ( | const Vector< double > & | x_vect, |
double & | alpha | ||
) |
Alfa on a boundary on which r is fixed.
Referenced by AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::AxisymFreeSurfaceNozzleAdvDiffRobinProblem().
void Global_Physical_Variables::prescribed_beta_on_fixed_r_boundary | ( | const Vector< double > & | x_vector, |
double & | beta | ||
) |
Beta on a boundary on which r is fixed.
References beta, Bi, and T_ext.
Referenced by AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::AxisymFreeSurfaceNozzleAdvDiffRobinProblem().
void Global_Physical_Variables::prescribed_traction | ( | const double & | t, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | traction | ||
) |
Traction applied on the fluid at the left (inflow) boundary.
Traction required at the left boundary.
References P_up.
Referenced by FSICollapsibleChannelProblem< ELEMENT >::actions_after_adapt(), CollapsibleChannelProblem< ELEMENT >::actions_after_adapt(), CollapsibleChannelProblem< ELEMENT >::CollapsibleChannelProblem(), and FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem().
void Global_Physical_Variables::press_load | ( | const Vector< double > & | xi, |
const Vector< double > & | x, | ||
const Vector< double > & | N, | ||
Vector< double > & | load | ||
) |
Load function: Perturbation pressure to force non-axisymmetric deformation.
Load function, normal pressure loading.
Load function: Constant external pressure with cos variation to induce buckling in n=2 mode
Load function: Constant external pressure with cos variation to induce buckling in desired mode
References cos(), i, load(), N, Pcos, Pext_data_pt, and oomph::Data::value().
Referenced by ElasticRingProblem< ELEMENT >::ElasticRingProblem(), PlateProblem< ELEMENT >::PlateProblem(), and ShellProblem< ELEMENT >::ShellProblem().
void Global_Physical_Variables::pulse_wave_solution | ( | const double & | time, |
const Vector< double > & | x, | ||
Vector< double > & | soln | ||
) |
"Exact" solution for propagating pulse wave
References Length, P_inlet_const, Wavespeed, and plotDoE::x.
Referenced by PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::doc_solution().
void Global_Physical_Variables::set_params | ( | ) |
Set the parameters that are used in the code as a function of the Womersley number, the density ratio and H
References Alpha_sq, Density_ratio, H, Lambda_sq, Constitutive_Parameters::Nu, Pcos, Eigen::bfloat16_impl::pow(), Q, GlobalPhysicalVariables::Re, and GlobalPhysicalVariables::ReSt.
Referenced by FSIRingProblem::dynamic_run().
void Global_Physical_Variables::spring_load | ( | const Vector< double > & | xi, |
const Vector< double > & | x, | ||
const Vector< double > & | N, | ||
Vector< double > & | load | ||
) |
Load function for the wall elements.
References H, i, Kstiff, load(), lower_map, N, Non_linear_springs, Pext, Rest_length_linear, sqrt(), and plotDoE::x.
Referenced by AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem().
void Global_Physical_Variables::spring_load_lower | ( | const Vector< double > & | xi, |
const Vector< double > & | x, | ||
const Vector< double > & | N, | ||
Vector< double > & | load | ||
) |
Load function for the wall elements.
References H, i, Kstiff, Ktable, load(), N, Non_linear_springs, Pext, Rest_length_linear, sqrt(), Table_position, upper_map, and plotDoE::x.
Referenced by AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem().
References plotDoE::x.
Timescales for transport equations (identically one from our non-dimensionalisation)
void Global_Physical_Variables::traction_function | ( | const double & | time, |
const Vector< double > & | x, | ||
Vector< double > & | traction | ||
) |
Unused (but assigned) function to specify tractions.
Referenced by oomph::jh_mesh< ELEMENT >::make_traction_elements().
void Global_Physical_Variables::update_dependent_parameters | ( | ) |
Helper function to update dependent parameters.
References ProblemParameters::Density_ratio, Inner_radius, Lambda_sq, OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, Outer_radius, Q, GlobalPhysicalVariables::Re, sqrt(), St, Wavespeed, and Wo.
Referenced by main().
void Global_Physical_Variables::validation_fluid_fsi_boundary_traction | ( | const double & | time, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | result | ||
) |
"fsi" traction applied to the fluid mesh (for validation case in which fluid is driven by prescribed traction on fsi boundary rather than "lagrange multiplier traction" that enforces no slip
References Length, P_inlet_const, Tau, and plotDoE::x.
void Global_Physical_Variables::validation_solid_fsi_boundary_traction | ( | const double & | time, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | result | ||
) |
Traction applied to the solid mesh at fsi interface (for validation only)
Referenced by PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_solid_traction_elements().
Viscosity ratio function modeled following a Arrhenius fashion.
References eta, Eigen::bfloat16_impl::exp(), G, and T_inlet.
Referenced by AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::AxisymFreeSurfaceNozzleAdvDiffRobinProblem().
void Global_Physical_Variables::wall_unit_normal_fct | ( | const Vector< double > & | x, |
Vector< double > & | normal | ||
) |
Function that specifies the wall unit normal.
References WallFunction::normal(), and Wall_normal.
Referenced by CapProblem< ELEMENT >::CapProblem(), PseudoSolidCapProblem< ELEMENT >::create_contact_angle_element(), and RefineableRotatingCylinderProblem< ELEMENT >::finish_problem_setup().
void Global_Physical_Variables::wall_unit_normal_inlet_fct | ( | const Vector< double > & | x, |
Vector< double > & | normal | ||
) |
Function that specifies the wall unit normal at the inlet.
References WallFunction::normal(), and Wall_normal.
Referenced by InclinedPlaneProblem< ELEMENT, INTERFACE_ELEMENT >::make_free_surface_elements().
void Global_Physical_Variables::wall_unit_normal_left_fct | ( | const Vector< double > & | x, |
Vector< double > & | normal | ||
) |
Function that specifies the wall unit normal.
References WallFunction::normal().
void Global_Physical_Variables::wall_unit_normal_outlet_fct | ( | const Vector< double > & | x, |
Vector< double > & | normal | ||
) |
Function that specified the wall unit normal at the outlet.
References i, WallFunction::normal(), and Wall_normal.
Referenced by InclinedPlaneProblem< ELEMENT, INTERFACE_ELEMENT >::make_free_surface_elements().
void Global_Physical_Variables::wall_unit_normal_right_fct | ( | const Vector< double > & | x, |
Vector< double > & | normal | ||
) |
Function that specifies the wall unit normal.
References WallFunction::normal().
void Global_Physical_Variables::wind_function | ( | const Vector< double > & | x, |
Vector< double > & | wind | ||
) |
Wind.
References Radius, and plotDoE::x.
Referenced by RefineableAdvectionDiffusionPipeProblem< ELEMENT >::RefineableAdvectionDiffusionPipeProblem().
double Global_Physical_Variables::A =1.0 |
x-Half axis length
Amplitude of indentation.
Referenced by OscEllipseProblem< ELEMENT, TIMESTEPPER >::OscEllipseProblem().
double Global_Physical_Variables::A_hat =0.1 |
x-Half axis amplitude
Referenced by get_exact_u(), OscEllipseProblem< ELEMENT, TIMESTEPPER >::OscEllipseProblem(), and MyEllipse::position().
bool Global_Physical_Variables::Actually_attach_face_elements =true |
Actually attach elements?
Referenced by main().
int Global_Physical_Variables::adaptive = 0 |
double Global_Physical_Variables::Alpha =1.0 |
Scaling factor for wall thickness (to be used in an exercise)
Angle of incline of the slope (45 degrees)
Thermal expansion coefficient.
Wavelength of the domain.
Biot parameter.
Referenced by PolarNSProblem< ELEMENT >::actions_before_solve(), InterfaceProblem< ELEMENT, TIMESTEPPER >::deform_free_surface(), ThreeDimBethertonProblem< ELEMENT >::doc_solution(), ThreeDimBethertonProblem< ELEMENT >::get_lambda(), oomph::StreamfunctionProblem::header(), main(), oomph::jh_mesh< ELEMENT >::make_traction_elements(), oomph::streamfunction_mesh::make_traction_elements(), ThreeDimBethertonProblem< ELEMENT >::multiply_aspect_ratio(), oomph::StreamfunctionProblem::my_output(), PolarNSProblem< ELEMENT >::PolarNSProblem(), oomph::StreamfunctionProblem::StreamfunctionProblem(), ThermalProblem< ELEMENT >::ThermalProblem(), ThreeDimBethertonProblem< ELEMENT >::ThreeDimBethertonProblem(), and InterfaceProblem< ELEMENT, TIMESTEPPER >::unsteady_run().
double Global_Physical_Variables::Alpha_absorption = 1.0 |
Alpha for absorption kinetics.
double Global_Physical_Variables::Alpha_sq =50.0 |
Square of Womersly number (a frequency parameter)
Referenced by FSIRingProblem::dynamic_run(), and set_params().
double Global_Physical_Variables::Alpha_tanh =100.0 |
Steepness parameter for tanh for pressure incrementation.
Referenced by PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep(), and main().
The contact angle.
Contact angle.
Referenced by LawinenBox::actionsBeforeTimeStep(), AxialSolidQuarterTubeMesh< ELEMENT, INTERFACE_ELEMENT >::AxialSolidQuarterTubeMesh(), AxialSpineQuarterTubeMesh< ELEMENT, INTERFACE_ELEMENT >::AxialSpineQuarterTubeMesh(), PseudoSolidCapProblem< ELEMENT >::create_contact_angle_element(), CapProblem< ELEMENT >::doc_solution(), PseudoSolidCapProblem< ELEMENT >::doc_solution(), RefineableRotatingCylinderProblem< ELEMENT >::finish_problem_setup(), FreeSurfaceRotationProblem< ELEMENT >::FreeSurfaceRotationProblem(), main(), CapProblem< ELEMENT >::parameter_study(), PseudoSolidCapProblem< ELEMENT >::parameter_study(), LawinenBox::rotateChute(), SolidFreeSurfaceRotationProblem< ELEMENT >::SolidFreeSurfaceRotationProblem(), RefineableRotatingCylinderProblem< ELEMENT >::solve(), CapProblem< ELEMENT >::solve_system(), and LawinenBox::writeEneTimeStep().
double Global_Physical_Variables::Beta = 100.0 |
Surface Elasticity number.
Surface Elasticity number (weak case)
Referenced by ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::ConvectionProblem(), InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem(), and oomph::SpineLineMarangoniSurfactantFluidInterfaceElement< ELEMENT >::sigma().
double Global_Physical_Variables::Bi = 0.01 |
Biot number.
Referenced by oomph::SpineLineMarangoniFluidInterfaceElement< ELEMENT >::add_additional_residual_contributions_interface(), oomph::FixedVolumeSpineLineMarangoniFluidInterfaceElement< ELEMENT >::add_additional_residual_contributions_interface(), oomph::SpineLineMarangoniSurfactantFluidInterfaceElement< ELEMENT >::add_additional_residual_contributions_interface(), oomph::SolubleSurfactantTransportInterfaceElement::dflux_from_bulk_dC(), oomph::SolubleSurfactantTransportInterfaceElement::dflux_from_bulk_dC_bulk(), oomph::SolubleSurfactantTransportInterfaceElement::flux_from_bulk(), prescribed_alpha_on_fixed_r_boundary(), prescribed_beta_on_fixed_r_boundary(), Eigen::internal::selfadjoint_matrix_vector_product< Scalar, Index, StorageOrder, UpLo, ConjugateLhs, ConjugateRhs, Version >::run(), and AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::steady_run().
double Global_Physical_Variables::Biot = 0.0 |
Biot number.
Referenced by ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::ConvectionProblem().
double Global_Physical_Variables::Bo = 0.0 |
Bond number.
Referenced by AirwayReopeningProblem< ELEMENT >::actions_after_change_in_global_parameter(), AirwayReopeningProblem< ELEMENT >::doc_solution(), ThreeDimBethertonProblem< ELEMENT >::doc_solution(), AirwayReopeningProblem< ELEMENT >::dump(), main(), AirwayReopeningProblem< ELEMENT >::parameter_study(), and AirwayReopeningProblem< ELEMENT >::read().
WarpedPlane Global_Physical_Variables::Boundary_geom_object | ( | 0. | 0 | ) |
GeomObject specifying the shape of the boundary: Initially it's flat.
Referenced by PrescribedBoundaryDisplacementProblem< ELEMENT >::actions_before_newton_solve(), ContactProblem< ELEMENT >::create_displ_imposition_elements(), PrescribedBoundaryDisplacementProblem< ELEMENT >::create_lagrange_multiplier_elements(), ContactProblem< ELEMENT >::doc_solution(), and main().
double Global_Physical_Variables::C1 = 1.3 |
"Mooney Rivlin" coefficient for generalised Mooney Rivlin law
First "Mooney Rivlin" coefficient.
First "Mooney Rivlin" coefficient for generalised Mooney Rivlin law.
Pseudo-solid Mooney-Rivlin parameter.
Referenced by oomph::GeneralisedHookean::calculate_second_piola_kirchhoff_stress(), SinterLinInteraction::computeNormalForce(), oomph::KirchhoffLoveShellEquations::fill_in_contribution_to_residuals_shell(), oomph::KirchhoffLoveShellEquations::get_energy(), main(), matrixRedux(), Eigen::internal::gebp_kernel< LhsScalar, RhsScalar, Index, DataMapper, mr, nr, ConjugateLhs, ConjugateRhs >::operator()(), Eigen::internal::lhs_process_one_packet< nr, LhsProgress, RhsProgress, LhsScalar, RhsScalar, ResScalar, AccPacket, LhsPacket, RhsPacket, ResPacket, GEBPTraits, LinearMapper, DataMapper >::operator()(), Eigen::internal::lhs_process_fraction_of_packet< nr, LhsProgress, RhsProgress, LhsScalar, RhsScalar, ResScalar, AccPacket, LhsPacket, RhsPacket, ResPacket, GEBPTraits, LinearMapper, DataMapper >::peeled_kc_onestep(), Eigen::internal::lhs_process_one_packet< nr, LhsProgress, RhsProgress, LhsScalar, RhsScalar, ResScalar, AccPacket, LhsPacket, RhsPacket, ResPacket, GEBPTraits, LinearMapper, DataMapper >::peeled_kc_onestep(), Eigen::internal::compute_inverse_size4< Architecture::Target, double, MatrixType, ResultType >::run(), and CFile::writeP4C().
double Global_Physical_Variables::C2 =1.3 |
"Mooney Rivlin" coefficient for generalised Mooney Rivlin law
Second "Mooney Rivlin" coefficient.
Second "Mooney Rivlin" coefficient for generalised Mooney Rivlin law.
Referenced by oomph::GeneralisedHookean::calculate_second_piola_kirchhoff_stress(), SinterLinInteraction::computeNormalForce(), oomph::KirchhoffLoveShellEquations::fill_in_contribution_to_residuals_shell(), oomph::KirchhoffLoveShellEquations::get_energy(), main(), Eigen::internal::gebp_kernel< LhsScalar, RhsScalar, Index, DataMapper, mr, nr, ConjugateLhs, ConjugateRhs >::operator()(), Eigen::internal::lhs_process_one_packet< nr, LhsProgress, RhsProgress, LhsScalar, RhsScalar, ResScalar, AccPacket, LhsPacket, RhsPacket, ResPacket, GEBPTraits, LinearMapper, DataMapper >::operator()(), Eigen::internal::lhs_process_fraction_of_packet< nr, LhsProgress, RhsProgress, LhsScalar, RhsScalar, ResScalar, AccPacket, LhsPacket, RhsPacket, ResPacket, GEBPTraits, LinearMapper, DataMapper >::peeled_kc_onestep(), Eigen::internal::lhs_process_one_packet< nr, LhsProgress, RhsProgress, LhsScalar, RhsScalar, ResScalar, AccPacket, LhsPacket, RhsPacket, ResPacket, GEBPTraits, LinearMapper, DataMapper >::peeled_kc_onestep(), Eigen::internal::compute_inverse_size4< Architecture::Target, double, MatrixType, ResultType >::run(), and CFile::writeP4C().
double Global_Physical_Variables::Ca = 10.0 |
Capillary number.
The Capillary number.
Referenced by AirwayReopeningProblem< ELEMENT >::actions_after_change_in_global_parameter(), AirwayReopeningProblem< ELEMENT >::actions_before_newton_convergence_check(), oomph::SurfactantTransportInterfaceElement::add_additional_residual_contributions_interface(), AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem(), AxialSolidQuarterTubeMesh< ELEMENT, INTERFACE_ELEMENT >::AxialSolidQuarterTubeMesh(), AxialSpineQuarterTubeMesh< ELEMENT, INTERFACE_ELEMENT >::AxialSpineQuarterTubeMesh(), AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::AxisymFreeSurfaceNozzleAdvDiffRobinProblem(), BrethertonProblem< ELEMENT >::BrethertonProblem(), PseudoSolidCapProblem< ELEMENT >::create_contact_angle_element(), PseudoSolidCapProblem< ELEMENT >::create_free_surface_elements(), InterfaceProblem< ELEMENT, TIMESTEPPER >::create_interface_elements(), CapProblem< ELEMENT >::doc_solution(), PseudoSolidCapProblem< ELEMENT >::doc_solution(), AirwayReopeningProblem< ELEMENT >::doc_solution(), BrethertonProblem< ELEMENT >::doc_solution(), ThreeDimBethertonProblem< ELEMENT >::doc_solution(), AirwayReopeningProblem< ELEMENT >::dump(), ElasticInterfaceProblem< ELEMENT, TIMESTEPPER >::ElasticInterfaceProblem(), oomph::PerturbedSpineLinearisedAxisymmetricFluidInterfaceElement< ELEMENT >::fill_in_generic_residual_contribution_interface(), oomph::FluidInterfaceElement::fill_in_generic_residual_contribution_interface(), RefineableRotatingCylinderProblem< ELEMENT >::finish_problem_setup(), FreeSurfaceRotationProblem< ELEMENT >::FreeSurfaceRotationProblem(), InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem(), main(), InclinedPlaneProblem< ELEMENT, INTERFACE_ELEMENT >::make_free_surface_elements(), MeltSpinningProblem< ELEMENT >::MeltSpinningProblem(), BrethertonProblem< ELEMENT >::parameter_study(), AirwayReopeningProblem< ELEMENT >::parameter_study(), AirwayReopeningProblem< ELEMENT >::read(), oomph::SpineLineMarangoniFluidInterfaceElement< ELEMENT >::sigma(), oomph::FixedVolumeSpineLineMarangoniFluidInterfaceElement< ELEMENT >::sigma(), oomph::SpineLineMarangoniSurfactantFluidInterfaceElement< ELEMENT >::sigma(), SolidFreeSurfaceRotationProblem< ELEMENT >::SolidFreeSurfaceRotationProblem(), RefineableRotatingCylinderProblem< ELEMENT >::solve(), MeltSpinningProblem< ELEMENT >::steady_run(), AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::steady_run(), and ThreeDimBethertonProblem< ELEMENT >::ThreeDimBethertonProblem().
double Global_Physical_Variables::Capillary = 0.0045 |
Capillary number.
Capillary number (of which the results are independent for a pinned surface)
Referenced by ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::ConvectionProblem(), and main().
bool Global_Physical_Variables::Consistent_newmark_ic |
Boolean flag to decide if to set IC for Newmark directly or consistently : No Default
Referenced by main(), and ElasticRingProblem< ELEMENT >::unsteady_run().
ConstitutiveLaw * Global_Physical_Variables::Constitutive_law_pt |
Pointer to constitutive law.
We need a constitutive law for the solid mechanics.
Constitutive law used to determine the mesh deformation.
Referenced by UnstructuredTorusProblem< ELEMENT >::actions_after_adapt(), UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_after_adapt(), UnstructuredSolidProblem< ELEMENT, MESH >::actions_after_adapt(), BlockCompressionProblem< ELEMENT >::BlockCompressionProblem(), CantileverProblem< ELEMENT >::CantileverProblem(), CompressedSquareProblem< ELEMENT >::CompressedSquareProblem(), DeformableFishPoissonProblem< ELEMENT >::DeformableFishPoissonProblem(), DiskOscillationProblem< ELEMENT >::DiskOscillationProblem(), DiskShockWaveProblem< ELEMENT, TIMESTEPPER >::DiskShockWaveProblem(), ElasticFishProblem< ELEMENT >::ElasticFishProblem(), ElasticInclinedPlaneProblem< ELEMENT, TIMESTEPPER >::ElasticInclinedPlaneProblem(), ElasticInterfaceProblem< ELEMENT, TIMESTEPPER >::ElasticInterfaceProblem(), main(), UnstructuredFluidProblem< ELEMENT >::set_boundary_conditions(), SheetGlueProblem< ELEMENT >::SheetGlueProblem(), SimpleShearProblem< ELEMENT >::SimpleShearProblem(), StaticDiskCompressionProblem< ELEMENT >::StaticDiskCompressionProblem(), ThermalProblem< ELEMENT >::ThermalProblem(), and UnstructuredTorusProblem< ELEMENT >::UnstructuredTorusProblem().
Diffusivity (identically one from our non-dimensionalisation)
Referenced by oomph::SpineLineMarangoniSurfactantFluidInterfaceElement< ELEMENT >::add_additional_residual_contributions_interface(), main(), and SurfactantProblem< ELEMENT, INTERFACE_ELEMENT >::SurfactantProblem().
double Global_Physical_Variables::DD_s = 1000.0 |
The ratio of bulk diffusion to surface diffusion.
double Global_Physical_Variables::Dean = 100.0 |
The Dean number.
Referenced by axial_pressure_gradient(), and UnstructuredTorusProblem< ELEMENT >::solve_system().
double Global_Physical_Variables::Delta = 0.128 |
The curvature of the torus.
The desired curvature of the pipe.
Referenced by SteadyCurvedTubeProblem< ELEMENT >::actions_before_newton_solve(), SteadyHelicalProblem< ELEMENT >::actions_before_newton_solve(), axial_pressure_gradient(), GeneralCircle::position(), MyCurvedCylinder::position(), MyHelicalCylinder::position(), UnstructuredTorusProblem< ELEMENT >::solve_system(), SteadyCurvedTubeProblem< ELEMENT >::SteadyCurvedTubeProblem(), SteadyHelicalProblem< ELEMENT >::SteadyHelicalProblem(), and TorusProblem< ELEMENT >::TorusProblem().
double Global_Physical_Variables::Density_Ratio = 0.5 |
Ratio of density in upper fluid to density in lower fluid. Reynolds number etc. is based on density in lower fluid.
Referenced by InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem().
double Global_Physical_Variables::Density_ratio =1.0 |
Density ratio of the solid and the fluid.
Density ratio (zero for zero wall inertia)
Referenced by FSIRingProblem::dynamic_run(), and set_params().
double Global_Physical_Variables::Density_ratio_poro =1.0 |
Ratio of the densities of the fluid and solid phases of the poroelastic material
Double relative diffusivities.
Referenced by main().
Gravity vector.
Referenced by AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::AxisymFreeSurfaceNozzleAdvDiffRobinProblem(), ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::ConvectionProblem(), RefineableBuoyantQCrouzeixRaviartElement< DIM >::Default_Physical_Constant_Value(), QCrouzeixRaviartElementWithTwoExternalElement< DIM >::Default_Physical_Constant_Value(), main(), and SurfactantProblem< ELEMENT, INTERFACE_ELEMENT >::SurfactantProblem().
double Global_Physical_Variables::E = 1.0 |
Elastic modulus.
Pseudo-solid Young's modulus.
Young's modulus for solid mechanics.
Define the non-dimensional Young's modulus.
Define the non-dimensional Young's modulus (ratio of actual Young's modulus to the one used to non-dimensionalise (poro-elastic) stresses
Referenced by STSpineMesh< ELEMENT, INTERFACE_ELEMENT >::add_mesh(), TwoDDGProblem< ELEMENT >::apply_initial_conditions(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::check_integrity(), oomph::RefineableQElement< 2 >::check_integrity(), check_singular_cases(), oomph::QuadTreeForest::construct_north_equivalents(), oomph::TopologicallyRectangularDomain::d2macro_element_boundary(), QThermalPVDElement< DIM >::Default_Physical_Constant_Value(), oomph::DeviatoricIsotropicElasticityTensor::DeviatoricIsotropicElasticityTensor(), oomph::TopologicallyRectangularDomain::dmacro_element_boundary(), StaticDiskCompressionProblem< ELEMENT >::doc_solution(), ElasticRefineableTwoLayerMesh< ELEMENT >::ElasticRefineableTwoLayerMesh(), oomph::LinearElasticityEquations< DIM >::fill_in_generic_contribution_to_residuals_linear_elasticity(), oomph::RefineableLinearElasticityEquations< DIM >::fill_in_generic_contribution_to_residuals_linear_elasticity(), oomph::PMLTimeHarmonicLinearElasticityEquations< DIM >::fill_in_generic_contribution_to_residuals_time_harmonic_linear_elasticity(), oomph::RefineableTimeHarmonicLinearElasticityEquations< DIM >::fill_in_generic_contribution_to_residuals_time_harmonic_linear_elasticity(), oomph::TimeHarmonicLinearElasticityEquations< DIM >::fill_in_generic_contribution_to_residuals_time_harmonic_linear_elasticity(), oomph::QuadTreeForest::find_neighbours(), oomph::RefineableQElement< 2 >::get_bcs(), oomph::RefineableQElement< 2 >::get_boundaries(), oomph::RefineableQElement< 2 >::get_edge_bcs(), oomph::RefineableSolidQElement< 2 >::get_edge_solid_bcs(), ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::get_kinetic_energy(), DDConvectionProblem< NST_ELEMENT, AD_ELEMENT >::get_kinetic_energy(), RefineableDDConvectionProblem< NST_ELEMENT, AD_ELEMENT >::get_kinetic_energy(), oomph::RefineableSolidQElement< 2 >::get_solid_bcs(), oomph::LinearElasticityEquations< DIM >::get_stress(), oomph::PoroelasticityEquations< DIM >::get_stress(), oomph::PMLTimeHarmonicLinearElasticityEquations< DIM >::get_stress(), oomph::TimeHarmonicLinearElasticityEquations< DIM >::get_stress(), IntersectionOfWalls::getDistanceAndNormal(), oomph::QuadTree::gteq_edge_neighbour(), Global::initial_left(), Global::initial_right(), oomph::RefineableQElement< 2 >::interpolated_zeta_on_edge(), oomph::IsotropicElasticityTensor::IsotropicElasticityTensor(), mathsFunc::log(), oomph::RectangleWithHoleAndAnnularRegionDomain::macro_element_boundary(), oomph::AnnularDomain::macro_element_boundary(), oomph::FullCircleDomain::macro_element_boundary(), oomph::QuarterCircleSectorDomain::macro_element_boundary(), oomph::TopologicallyRectangularDomain::macro_element_boundary(), oomph::FishDomain::macro_element_boundary(), oomph::ChannelWithLeafletDomain::macro_element_boundary(), oomph::CollapsibleChannelDomain::macro_element_boundary(), CylinderAndInterfaceDomain::macro_element_boundary(), RectangleWithHoleDomain::macro_element_boundary(), oomph::CylinderWithFlagDomain::macro_element_boundary(), oomph::RectangleWithHoleDomain::macro_element_boundary(), main(), oomph::MeshHelper::merge_spine_meshes(), MortaringValidationProblem< ELEMENT, NON_MORTAR_ELEMENT >::MortaringValidationProblem(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::node_created_by_neighbour(), oomph::RefineableQElement< 2 >::node_created_by_neighbour(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::node_created_by_son_of_neighbour(), oomph::PMLTimeHarmonicIsotropicElasticityTensor::PMLTimeHarmonicIsotropicElasticityTensor(), PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PressureWaveFSIProblem(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::quad_hang_helper(), oomph::RefineableQElement< 2 >::quad_hang_helper(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::rebuild_from_sons(), oomph::RefineableQSpectralElement< 2 >::rebuild_from_sons(), RefineablePeriodicLoadProblem< ELEMENT >::RefineablePeriodicLoadProblem(), oomph::RefineableQuadMeshWithMovingCylinder< MyRefineableQTaylorHoodElement >::RefineableQuadMeshWithMovingCylinder(), oomph::RefineableTwoDAnnularMesh< ELEMENT >::RefineableTwoDAnnularMesh(), Global_Parameters::set_parameters(), Membrane::setElasticModulusAndThickness(), oomph::RefineableQElement< 2 >::setup_father_bounds(), oomph::RefineableQElement< 2 >::setup_hang_for_value(), oomph::RefineableQElement< 2 >::setup_hanging_nodes(), oomph::QuadTree::setup_static_data(), test_dynamic_bool(), ThreeDimBethertonProblem< ELEMENT >::ThreeDimBethertonProblem(), oomph::TimeHarmonicIsotropicElasticityTensor::TimeHarmonicIsotropicElasticityTensor(), oomph::IsotropicElasticityTensor::update_constitutive_parameters(), oomph::PMLTimeHarmonicIsotropicElasticityTensor::update_constitutive_parameters(), and oomph::TimeHarmonicIsotropicElasticityTensor::update_constitutive_parameters().
double Global_Physical_Variables::Element_area_fluid =0.002 |
Target element area for fluid mesh.
Referenced by main().
double Global_Physical_Variables::Element_area_solid =0.002 |
Target element area for poro-elasticmesh.
Referenced by main().
double Global_Physical_Variables::Epsilon = 0.1 |
Free surface cosine deform parameter.
Free surface cosine deformation parameter.
Referenced by InterfaceProblem< ELEMENT, TIMESTEPPER >::unsteady_run().
double Global_Physical_Variables::eta = 0.0 |
Eta factor (exponent of the exponecial function)
Referenced by AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::steady_run(), and viscosity_ratio_function().
double Global_Physical_Variables::eta_inlet =1.0 |
double Global_Physical_Variables::eta_outlet =0.0 |
double Global_Physical_Variables::Film_Thickness = 0.2 |
unsigned Global_Physical_Variables::Fixed_timestep_flag =1 |
Flag for fixed timestep: Default = fixed timestep.
Referenced by main(), and ElasticRingProblem< ELEMENT >::unsteady_run().
double Global_Physical_Variables::Fluid_mesh_bl_thickness =0.01 |
Fluid mesh boundary layer thickness.
Direction of gravity.
The Vector direction of gravity, set in main()
Gravity direction.
--— VISCOSITY PARAMETERS --—
Gravity.
Pre-exponetial factor
Referenced by AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem(), BrethertonProblem< ELEMENT >::BrethertonProblem(), ElasticInterfaceProblem< ELEMENT, TIMESTEPPER >::ElasticInterfaceProblem(), FreeSurfaceRotationProblem< ELEMENT >::FreeSurfaceRotationProblem(), InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem(), main(), MeltSpinningProblem< ELEMENT >::MeltSpinningProblem(), RefineableSphereConvectionProblem< ELEMENT >::RefineableSphereConvectionProblem(), and ThreeDimBethertonProblem< ELEMENT >::ThreeDimBethertonProblem().
double Global_Physical_Variables::Gamma = 1.0e-7 |
double Global_Physical_Variables::Gravity =0.0 |
Non-dim gravity.
Body force.
Gravity vector.
Referenced by CompressedSquareProblem< ELEMENT >::doc_solution(), gravity(), main(), QuarterCircleDrivenCavityProblem< ELEMENT >::QuarterCircleDrivenCavityProblem(), ElasticFishProblem< ELEMENT >::run(), SimpleShearProblem< ELEMENT >::run(), CompressedSquareProblem< ELEMENT >::run_it(), CantileverProblem< ELEMENT >::run_it(), and CantileverProblem< ELEMENT >::run_tests().
double Global_Physical_Variables::H =0.05 |
Nondim thickness.
Wall thickness.
Undeformed height of domain.
Half height of beam.
Nondimensional thickness of the beam.
Non-dimensional wall thickness. As in Jensen & Heil (2003) paper.
Non-dimensional wall thickness.
Non-dimensional wall thickness. As in Heil (2004) paper.
Wall thickness – 1/20 for default value of scaling factor.
Non-dimensional thickness.
Referenced by AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem(), CantileverProblem< ELEMENT >::CantileverProblem(), ChannelSpineFlowProblem< ELEMENT >::ChannelSpineFlowProblem(), CantileverProblem< ELEMENT >::doc_solution(), ElasticRingProblem< ELEMENT >::doc_solution(), ElasticBeamProblem::ElasticBeamProblem(), ElasticRingProblem< ELEMENT >::ElasticRingProblem(), FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), FSIDrivenCavityProblem< ELEMENT >::FSIDrivenCavityProblem(), FSIRingProblem::FSIRingProblem(), height(), main(), ElasticBeamProblem::parameter_study(), ElasticRingProblem< ELEMENT >::parameter_study(), PlateProblem< ELEMENT >::PlateProblem(), and FSIRingProblem::set_wall_initial_condition().
double* Global_Physical_Variables::H_lo_pt |
Pointer to film thickness at outflow on the lower wall.
Referenced by BrethertonProblem< ELEMENT >::BrethertonProblem(), and inflow().
double* Global_Physical_Variables::H_up_pt |
Pointer to film thickness at outflow on the upper wall.
Referenced by BrethertonProblem< ELEMENT >::BrethertonProblem(), and inflow().
double Global_Physical_Variables::Height = 1.0 |
double Global_Physical_Variables::Inlet_Angle = 2.0*atan(1.0) |
The contact angle that is imposed at the inlet (pi)
Referenced by InclinedPlaneProblem< ELEMENT, INTERFACE_ELEMENT >::make_free_surface_elements().
bool Global_Physical_Variables::inlet_traction =false |
Referenced by PolarNSProblem< ELEMENT >::actions_after_adapt(), PolarNSProblem< ELEMENT >::actions_before_solve(), PolarNSProblem< ELEMENT >::get_symmetry(), PolarNSProblem< ELEMENT >::header(), oomph::StreamfunctionProblem::header(), oomph::jh_mesh< ELEMENT >::jh_mesh(), main(), oomph::StreamfunctionProblem::my_output(), PolarNSProblem< ELEMENT >::pin_boundaries(), PolarNSProblem< ELEMENT >::pin_boundaries_to_zero(), PolarNSProblem< ELEMENT >::PolarNSProblem(), and oomph::jh_mesh< ELEMENT >::remove_traction_elements().
double Global_Physical_Variables::Inner_radius =0.5 |
Inner radius of tube.
Referenced by PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PressureWaveFSIProblem(), and update_dependent_parameters().
double Global_Physical_Variables::Inverse_Prandtl =1.0 |
1/Prandtl number
Referenced by ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::ConvectionProblem(), DDConvectionProblem< NST_ELEMENT, AD_ELEMENT >::DDConvectionProblem(), QCrouzeixRaviartElementWithTwoExternalElement< DIM >::Default_Physical_Constant_Value(), RefineableConvectionProblem< NST_ELEMENT, AD_ELEMENT >::RefineableConvectionProblem(), and RefineableDDConvectionProblem< NST_ELEMENT, AD_ELEMENT >::RefineableDDConvectionProblem().
double Global_Physical_Variables::Inverse_slip_rate_coefficient =0.0 |
Inverse slip rate coefficient.
double Global_Physical_Variables::K = 0.01 |
The ratio of adsorption-desorption times.
Set the wavenumber.
K parameter that describes solubility number
Referenced by InclinedPlaneProblem< ELEMENT, INTERFACE_ELEMENT >::actions_before_implicit_timestep().
Huge stiffness for hitting.
Referenced by AirwayReopeningProblem< ELEMENT >::dump(), and AirwayReopeningProblem< ELEMENT >::read().
double Global_Physical_Variables::Kstiff = 0.5*50.0e-7 |
Spring stiffness.
Referenced by AirwayReopeningProblem< ELEMENT >::dump(), AirwayReopeningProblem< ELEMENT >::parameter_study(), AirwayReopeningProblem< ELEMENT >::read(), spring_load(), and spring_load_lower().
double Global_Physical_Variables::Ktable = 0.0001 |
Huge stiffness for the table.
Referenced by AirwayReopeningProblem< ELEMENT >::dump(), AirwayReopeningProblem< ELEMENT >::read(), and spring_load_lower().
double Global_Physical_Variables::L = 8.0 |
Length of beam.
Length of indented region.
Referenced by CantileverProblem< ELEMENT >::CantileverProblem(), CantileverProblem< ELEMENT >::doc_solution(), SurfactantProblem< ELEMENT, INTERFACE_ELEMENT >::doc_solution(), height(), and SurfactantProblem< ELEMENT, INTERFACE_ELEMENT >::SurfactantProblem().
double Global_Physical_Variables::L_total =4.0 |
Total length of domain.
Referenced by ChannelSpineFlowProblem< ELEMENT >::ChannelSpineFlowProblem().
double Global_Physical_Variables::Lambda = 1.414 |
double Global_Physical_Variables::lambda =1.0 |
Referenced by SphericalSpinUpProblem< ELEMENT >::SphericalSpinUpProblem().
double Global_Physical_Variables::Lambda_lame = 0.0 |
Lambda - first Lame parameter – dependent parameter; compute from nu.
double * Global_Physical_Variables::Lambda_pt |
Referenced by BratuProblem< ELEMENT >::BratuProblem(), GelfandBratuElement< NNODE_1D >::fill_in_generic_dresidual_contribution(), GelfandBratuElement< NNODE_1D >::lambda(), PredatorPreyElement::lambda(), GelfandBratuElement< NNODE_1D >::lambda_pt(), PredatorPreyElement::lambda_pt(), main(), PredPreyProblem< ELEMENT >::PredPreyProblem(), BratuProblem< ELEMENT >::solve(), and PredPreyProblem< ELEMENT >::solve().
double Global_Physical_Variables::Lambda_sq =0.0 |
Pseudo-solid mass density.
Timescale ratio.
Square of the nondimensional "density" – dependent parameter; compute.
Timescale ratio (non-dimensation density)
Pseudo-solid (mesh) "density" Set to zero because we don't want inertia in the node update!
Square of timescale ratio (i.e. non-dimensional density)
– 1.0 for default value of scaling factor
Timescale ratio for solid (dependent parameter assigned in set_parameters())
Define the poroelasticity inertia parameter – dependent parameter; compute from Re, Q and density ratio
Square of timescale ratio (i.e. non-dimensional density) – 1.0 for default value of scaling factor
Referenced by UnstructuredTorusProblem< ELEMENT >::actions_after_adapt(), DiskOscillationProblem< ELEMENT >::DiskOscillationProblem(), doc_dependent_parameters(), oomph::KirchhoffLoveBeamEquations::fill_in_contribution_to_residuals_beam(), oomph::LinearElasticityEquations< DIM >::fill_in_generic_contribution_to_residuals_linear_elasticity(), FSIDrivenCavityProblem< ELEMENT >::FSIDrivenCavityProblem(), FSIRingProblem::FSIRingProblem(), oomph::KirchhoffLoveBeamEquations::get_energy(), oomph::ImmersedRigidBodyElement::get_residuals_rigid_body_generic(), multiplier(), PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PressureWaveFSIProblem(), Global_Parameters::set_parameters(), set_params(), UnstructuredTorusProblem< ELEMENT >::UnstructuredTorusProblem(), and update_dependent_parameters().
double Global_Physical_Variables::Length =10.0 |
Length of the pipe.
The length of the domain to fit the desired number of waves.
Length of tube.
Referenced by oomph::OneDMesh< ELEMENT >::build_mesh(), CombCanSpineMesh< ELEMENT, INTERFACE_ELEMENT >::build_single_layer_mesh(), CombTipSpineMesh< ELEMENT, INTERFACE_ELEMENT >::build_single_layer_mesh(), RotatingProblem< ELEMENT >::change_length(), CylinderAndInterfaceDomain::CylinderAndInterfaceDomain(), ElasticRingProblem< ELEMENT >::doc_solution(), RectangleWithHoleMesh< ELEMENT >::length(), Leaflet::length(), main(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_III(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_IV(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_IX(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_V(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_VI(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_VII(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_VIII(), Leaflet::position(), OscillatingWall::position(), PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PressureWaveFSIProblem(), protectiveWall::protectiveWall(), pulse_wave_solution(), RectangleWithHoleMesh< ELEMENT >::RectangleWithHoleMesh(), RefineableAdvectionDiffusionPipeProblem< ELEMENT >::RefineableAdvectionDiffusionPipeProblem(), Eigen::internal::redux_vec_unroller< Func, Evaluator, Start, Length >::run(), Eigen::internal::redux_vec_linear_unroller< Func, Evaluator, Start, Length >::run(), RefineableAdvectionDiffusionPipeProblem< ELEMENT >::set_initial_condition(), T_protectiveWall::T_protectiveWall(), and validation_fluid_fsi_boundary_traction().
double Global_Physical_Variables::Length_can = 1.5 |
double Global_Physical_Variables::Length_liq = 1.0 |
double Global_Physical_Variables::Length_tip = 0.50 |
double Global_Physical_Variables::lenScale = 1 |
double Global_Physical_Variables::Lewis = 10.0 |
bool Global_Physical_Variables::log_mesh =true |
unsigned Global_Physical_Variables::Long_run_flag =1 |
Flag for long/short run: Default = perform long run.
Referenced by main(), and ElasticRingProblem< ELEMENT >::unsteady_run().
map<double,pair<GeomObject*,Vector<double> > > Global_Physical_Variables::lower_map |
Lower wall map.
Referenced by AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem(), and spring_load().
GeomObject* Global_Physical_Variables::Lower_wall_pt |
Pointer to the lower wall.
Referenced by AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem(), oomph::BrethertonSpineMesh< ELEMENT, SpineLineFluidInterfaceElement< ELEMENT > >::initial_element_reorder(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::reposition_spines(), and AirwayReopeningProblem< ELEMENT >::~AirwayReopeningProblem().
double Global_Physical_Variables::Marangoni = 125.0 |
Marangoni number.
Marangoni number (just above the threshold for linear instability)
Referenced by ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::ConvectionProblem(), and main().
ConstitutiveLaw* Global_Physical_Variables::Mesh_constitutive_law_pt =0 |
Pointer to constitutive law for the mesh.
Referenced by UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_after_adapt(), and main().
double Global_Physical_Variables::Mu = 0.0 |
Parameter that switches between circle (1.0) and square (0.0) cross section
Referenced by GeneralCircle::position(), and UnstructuredTorusProblem< ELEMENT >::solve_system().
double Global_Physical_Variables::Mu_lame = 0.0 |
mu - second Lame parameter – dependent parameter; compute from nu
double * Global_Physical_Variables::Mu_pt |
Referenced by BratuProblem< ELEMENT >::BratuProblem(), GelfandBratuElement< NNODE_1D >::fill_in_generic_dresidual_contribution(), main(), GelfandBratuElement< NNODE_1D >::mu(), PredatorPreyElement::mu(), GelfandBratuElement< NNODE_1D >::mu_pt(), PredatorPreyElement::mu_pt(), PredPreyProblem< ELEMENT >::PredPreyProblem(), BratuProblem< ELEMENT >::solve(), and PredPreyProblem< ELEMENT >::solve().
double Global_Physical_Variables::N_wave = 3 |
Set the number of waves desired in the domain.
unsigned Global_Physical_Variables::Nbuckl =3 |
Buckling wavenumber.
Referenced by ElasticRingProblem< ELEMENT >::ElasticRingProblem().
unsigned Global_Physical_Variables::Ncan = 2 |
bool Global_Physical_Variables::new_outlet_region =true |
unsigned Global_Physical_Variables::Nliq = 2 |
bool Global_Physical_Variables::Non_linear_springs = false |
Do we include the non-linear springs.
Referenced by spring_load(), and spring_load_lower().
unsigned Global_Physical_Variables::Ntip = 2 |
double Global_Physical_Variables::Nu = 0.3 |
Poisson's ratio.
Poisson's ratio for Hooke's law.
Poisson ratio for solid mechanics.
Poisson's ratio of drained poro-elastic medium.
Define Poisson's ratio Nu.
Poisson ratio.
The Poisson ratio.
Pseudo-solid (mesh) Poisson ratio.
Pseudo-solid Poisson ratio.
Referenced by CompressedSquareProblem< ELEMENT >::doc_solution(), StaticDiskCompressionProblem< ELEMENT >::doc_solution(), InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem(), main(), PlateProblem< ELEMENT >::PlateProblem(), PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PressureWaveFSIProblem(), PseudoSolidCapProblem< ELEMENT >::PseudoSolidCapProblem(), RefineableRotatingCylinderProblem< ELEMENT >::RefineableRotatingCylinderProblem(), DiskOscillationProblem< ELEMENT >::run(), SolidFreeSurfaceRotationProblem< ELEMENT >::SolidFreeSurfaceRotationProblem(), and SurfactantProblem< ELEMENT, INTERFACE_ELEMENT >::SurfactantProblem().
double Global_Physical_Variables::Omega = 0.0 |
Rotation rate.
Referenced by FreeSurfaceRotationProblem< ELEMENT >::FreeSurfaceRotationProblem().
double Global_Physical_Variables::Outer_radius =1.0 |
Outer radius of tube.
Referenced by main(), PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PressureWaveFSIProblem(), and update_dependent_parameters().
bool Global_Physical_Variables::outlet_traction =true |
Referenced by PolarNSProblem< ELEMENT >::actions_after_adapt(), PolarNSProblem< ELEMENT >::actions_before_solve(), PolarNSProblem< ELEMENT >::get_symmetry(), PolarNSProblem< ELEMENT >::header(), oomph::StreamfunctionProblem::header(), oomph::jh_mesh< ELEMENT >::jh_mesh(), main(), oomph::StreamfunctionProblem::my_output(), PolarNSProblem< ELEMENT >::pin_boundaries(), PolarNSProblem< ELEMENT >::pin_boundaries_to_zero(), PolarNSProblem< ELEMENT >::PolarNSProblem(), and oomph::jh_mesh< ELEMENT >::remove_traction_elements().
double Global_Physical_Variables::P = 0.0 |
Uniform pressure.
Referenced by Slide::actionsBeforeTimeStep(), ParticleHandler::addExistingObject(), ParticleHandler::addGhostObject(), InteractionHandler::addInteraction(), BoundaryHandler::addObject(), ParticleHandler::addObject(), PeriodicBoundaryHandler::addObject(), BaseInteraction::BaseInteraction(), bug890(), HomogenisationProblem< ELEMENT >::calculate_coefficients(), AngledPeriodicBoundary::checkBoundaryAfterParticleMoved(), CircularPeriodicBoundary::checkBoundaryAfterParticleMoved(), ParticleHandler::checkExtrema(), ParticleHandler::checkExtremaOnDelete(), HomogenisationProblem< ELEMENT >::complete_problem_setup(), Eigen::internal::MatrixFunctionAtomic< MatrixType >::compute(), Global_Parameters::constant_pressure(), constant_pressure(), oomph::TriangleMesh< ELEMENT >::convex_hull(), MPIInteraction< NormalForceInteraction, FrictionForceInteraction, AdhesiveForceInteraction >::copyFromInteraction(), MPIInteraction< NormalForceInteraction, FrictionForceInteraction, AdhesiveForceInteraction >::copyToInteraction(), Matrix3D::deviator(), AngledPeriodicBoundary::distance(), UnstructuredSolidProblem< ELEMENT, MESH >::doc_solution(), CantileverProblem< ELEMENT >::doc_solution(), StaticDiskCompressionProblem< ELEMENT >::doc_solution(), oomph::DShape::DShape(), ElasticRefineableQuarterCircleSectorMesh< ELEMENT >::ElasticRefineableQuarterCircleSectorMesh(), mathsFunc::exp(), LiquidMigrationLSInteraction::form(), LiquidMigrationWilletInteraction::form(), InsertionBoundary::generateParticle(), FixedClusterInsertionBoundary::generateParticle(), BidisperseCubeInsertionBoundary::generateParticle(), PolydisperseInsertionBoundary::generateParticle(), NurbsSurface::getDistance(), Screw::getDistanceAndNormal(), BasicIntersectionOfWalls::getDistanceAndNormal(), CylindricalWall::getDistanceAndNormal(), InfiniteWallWithHole::getDistanceAndNormal(), BaseWall::getDistanceNormalOverlap(), InteractionHandler::getExistingInteraction(), ChuteWithPeriodicInflow::getInfo(), SegregationPeriodic::getInfo(), InteractionHandler::getInteraction(), BaseParticle::getInteractionWith(), MixedSpecies< NormalForceSpecies, FrictionForceSpecies, AdhesiveForceSpecies >::getNewInteraction(), Species< NormalForceSpecies, FrictionForceSpecies, AdhesiveForceSpecies >::getNewInteraction(), PossibleContact::getNext(), PossibleContact::getOtherParticle(), PossibleContact::getPrevious(), CGFields::GradVelocityField::getSquared(), CGFields::LiquidMigrationFields::getSquared(), CGFields::StandardFields::getSquared(), Eigen::internal::idrs(), BaseInteraction::importP(), ChuteWithPeriodicInflow::InPeriodicBox(), BaseParticle::isInContactWith(), LawinenBox::LawinenBox(), mathsFunc::log(), main(), DPMBase::mpiInsertParticleCheck(), oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >::oc_hang_helper(), CGFields::DisplacementField::operator+=(), CGFields::GradVelocityField::operator+=(), CGFields::LiquidMigrationFields::operator+=(), CGFields::OrientationField::operator+=(), CGFields::StandardFields::operator+=(), CGFields::DisplacementField::operator-=(), CGFields::GradVelocityField::operator-=(), CGFields::LiquidMigrationFields::operator-=(), CGFields::OrientationField::operator-=(), CGFields::StandardFields::operator-=(), StaticDiskCompressionProblem< ELEMENT >::parameter_study(), PolydisperseInsertionBoundary::placeParticle(), MyHelicalCylinder::position(), Global_Parameters::press_load(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::quad_hang_helper(), DPMBase::readNextFStatFile(), PossibleContactList::remove_ParticlePosibleContacts(), InteractionHandler::removeObjectKeepingPeriodics(), oomph::DShape::resize(), CircularPeriodicBoundary::rotateParticle(), Eigen::internal::visitor_impl< Visitor, Derived, UnrollCount, Vectorize, false, ShortCircuitEvaluation >::run(), Eigen::internal::visitor_impl< Visitor, Derived, UnrollCount, Vectorize, true, ShortCircuitEvaluation >::run(), SheetGlueProblem< ELEMENT >::run(), BlockCompressionProblem< ELEMENT >::run(), DiskShockWaveProblem< ELEMENT, TIMESTEPPER >::run(), CantileverProblem< ELEMENT >::run_it(), LiquidMigrationLSInteraction::rupture(), LiquidMigrationWilletInteraction::rupture(), BaseInteraction::setFStatData(), PossibleContact::setNextPosition(), BaseInteraction::setP(), PossibleContact::setPreviousPosition(), ParameterStudy1DDemo::setupInitialConditions(), ParameterStudy2DDemo::setupInitialConditions(), ParameterStudy3DDemo::setupInitialConditions(), GetDistanceAndNormalForTriangleWalls::setupInitialConditions(), RollingOverTriangleWalls::setupInitialConditions(), ParticleParticleInteraction::setupInitialConditions(), ParticleParticleInteractionWithPlasticForces::setupInitialConditions(), ParticleWallInteraction::setupInitialConditions(), EnergyUnitTest::setupInitialConditions(), AngledPeriodicBoundary::shiftPosition(), SingleParticle< SpeciesType >::SingleParticle(), ABCProblem< ELEMENT, TIMESTEPPERT >::solve(), HomogenisationProblem< ELEMENT >::solve(), WearableNurbsWall::storeDebris(), WearableTriangulatedWall::storeDebris(), test1(), test2(), Eigen::umfpack_get_numeric(), DPMBase::updateGhostGrid(), CFile::writeP4P(), and WallHandler::writeWallDetailsVTKBoundingBox().
double Global_Physical_Variables::P_ext = 0.0 |
External pressure.
Pressure load.
Referenced by AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::AxisymFreeSurfaceNozzleAdvDiffRobinProblem(), FSICollapsibleChannelProblem< ELEMENT >::doc_solution(), ElasticCollapsibleChannelMesh< ELEMENT >::ElasticCollapsibleChannelMesh(), ElasticRefineableCollapsibleChannelMesh< ELEMENT >::ElasticRefineableCollapsibleChannelMesh(), InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem(), load(), main(), MeltSpinningProblem< ELEMENT >::MeltSpinningProblem(), and ElasticBeamProblem::parameter_study().
Data* Global_Physical_Variables::P_ext_data_pt =0 |
Pointer to Data object that stores external pressure.
Referenced by FSICollapsibleChannelProblem< ELEMENT >::doc_solution_steady(), SegregatedFSICollapsibleChannelProblem< ELEMENT >::doc_solution_steady(), FSICollapsibleChannelProblem< ELEMENT >::dump_it(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), SegregatedFSICollapsibleChannelProblem< ELEMENT >::identify_fluid_and_solid_dofs(), load(), FSICollapsibleChannelProblem< ELEMENT >::restart(), FSICollapsibleChannelProblem< ELEMENT >::steady_run(), SegregatedFSICollapsibleChannelProblem< ELEMENT >::steady_run(), FSICollapsibleChannelProblem< ELEMENT >::unsteady_run(), and SegregatedFSICollapsibleChannelProblem< ELEMENT >::unsteady_run().
double Global_Physical_Variables::P_inlet_const =Length*4.0/(Inner_radius*Inner_radius) |
Constant inlet pressure (for steady Poiseuille flow)
Actual (possibly time varying) inlet pressure – initialised to P_inlet_initial.
Referenced by PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep(), fluid_inflow_boundary_traction(), main(), pulse_wave_solution(), and validation_fluid_fsi_boundary_traction().
double Global_Physical_Variables::P_inlet_initial =500.0 |
Constant inlet pressure (for steady Poiseuille flow)
Referenced by PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep(), and main().
double Global_Physical_Variables::P_inlet_step =P_inlet_initial |
Increment for pressure (default: double the inlet pressure over duration of then tanh step)
Referenced by PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep(), and main().
double Global_Physical_Variables::P_outside_scale =0.0 |
Pressure growth factor for pressure acting on the outside of the solid wall
Referenced by outside_solid_boundary_traction().
double Global_Physical_Variables::P_step =0.0 |
Jump in pressure after a restart – used to give a steady solution a kick before starting a time-dependent run
Referenced by Flags::doc_flags(), main(), FSICollapsibleChannelProblem< ELEMENT >::restart(), and Flags::segregated_doc_flags().
double Global_Physical_Variables::P_up =0.0 |
Default pressure on the left boundary.
Default pressure on the left boundary when controlling flow by a pressure drop
Referenced by ElasticCollapsibleChannelMesh< ELEMENT >::ElasticCollapsibleChannelMesh(), ElasticRefineableCollapsibleChannelMesh< ELEMENT >::ElasticRefineableCollapsibleChannelMesh(), main(), prescribed_traction(), and CollapsibleChannelProblem< ELEMENT >::unsteady_run().
double Global_Physical_Variables::P_wall =1.0 |
Constant wall pressure for validation.
Referenced by validation_solid_fsi_boundary_traction().
double Global_Physical_Variables::Pcos =0.0 |
Perturbation pressure.
Referenced by ShellProblem< ELEMENT >::doc_solution(), ElasticRingProblem< ELEMENT >::dump_it(), FSIRingProblem::dynamic_run(), ElasticRingProblem< ELEMENT >::parameter_study(), pcos_load(), press_load(), ElasticRingProblem< ELEMENT >::restart(), ShellProblem< ELEMENT >::run_it(), set_params(), and ShellProblem< ELEMENT >::solve().
double Global_Physical_Variables::Pe = 10000.0 |
Peclet number.
--— ENERGY PROBLEM --—
Peclet number
Referenced by AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::AxisymFreeSurfaceNozzleAdvDiffRobinProblem(), EultingSphereProblem< ELEMENT >::doc_solution(), RefineableElutingSphereProblem< ELEMENT >::doc_solution(), EultingSphereProblem< ELEMENT >::EultingSphereProblem(), RefineableElutingSphereProblem< ELEMENT >::RefineableElutingSphereProblem(), RefineableSphereConvectionProblem< ELEMENT >::RefineableSphereConvectionProblem(), and AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::steady_run().
double Global_Physical_Variables::Pe_reference_scale =1.0 |
double Global_Physical_Variables::Peclet =200.0 |
Peclet number.
Peclet number (identically one from our non-dimensionalisation)
Peclet number (identically one from our non-dimensionalisation) in both cases
Referenced by ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::ConvectionProblem(), DDConvectionProblem< NST_ELEMENT, AD_ELEMENT >::DDConvectionProblem(), RefineableAdvectionDiffusionPipeProblem< ELEMENT >::RefineableAdvectionDiffusionPipeProblem(), RefineableConvectionProblem< NST_ELEMENT, AD_ELEMENT >::RefineableConvectionProblem(), and RefineableDDConvectionProblem< NST_ELEMENT, AD_ELEMENT >::RefineableDDConvectionProblem().
double Global_Physical_Variables::Peclet_S = 1.0 |
Surface Peclet number.
Referenced by ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::ConvectionProblem(), and InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem().
double Global_Physical_Variables::Peclet_St = 1.0 |
Peclet number multiplied by Strouhal number.
double Global_Physical_Variables::Peclet_St_S = 100.0 |
\shorT Sufrace Peclet number multiplied by Strouhal number
Sufrace Peclet number multiplied by Strouhal number.
Referenced by ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::ConvectionProblem(), and InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem().
double Global_Physical_Variables::Period =2.0 |
Period for fluctuations in flux.
Referenced by CollapsibleChannelProblem< ELEMENT >::CollapsibleChannelProblem(), flux(), and CollapsibleChannelProblem< ELEMENT >::unsteady_run().
double Global_Physical_Variables::Permeability =5.0 |
Non-dim permeability – ratio of typical porous flux to fluid veloc scale
Referenced by main().
double Global_Physical_Variables::Pext = 0.0 |
External Pressure.
The external pressure.
Referenced by AxisymmetricVibratingShellProblem< ELEMENT >::AxisymmetricVibratingShellProblem(), AirwayReopeningProblem< ELEMENT >::dump(), FSIRingProblem::dynamic_run(), pcos_load(), AirwayReopeningProblem< ELEMENT >::read(), spring_load(), spring_load_lower(), and VibratingShellProblem< ELEMENT >::VibratingShellProblem().
Data * Global_Physical_Variables::Pext_data_pt =0 |
Pointer to pressure load.
Pointer to pressure load (stored in Data so it can become an unknown in the problem when displacement control is used
Referenced by ElasticRingProblem< ELEMENT >::doc_solution(), ElasticRingProblem< ELEMENT >::ElasticRingProblem(), external_pressure(), oomph::PolarNavierStokesTractionElement< ELEMENT >::fill_in_generic_residual_contribution(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), ElasticRingProblem< ELEMENT >::parameter_study(), PlateProblem< ELEMENT >::PlateProblem(), press_load(), ShellProblem< ELEMENT >::ShellProblem(), and ShellProblem< ELEMENT >::solve().
const double Global_Physical_Variables::Pi =MathematicalConstants::Pi |
Set the value of Pi.
Referenced by main().
bool Global_Physical_Variables::Pin_fluid_on_fsi =false |
For validation only.
Referenced by main(), and PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PressureWaveFSIProblem().
bool Global_Physical_Variables::pinv =true |
Referenced by PolarNSProblem< ELEMENT >::actions_before_solve(), Eigen::IncompleteCholesky< Scalar, UpLo_, OrderingType_ >::analyzePattern(), cod(), cod_fixedsize(), PolarNSProblem< ELEMENT >::header(), oomph::StreamfunctionProblem::header(), main(), oomph::StreamfunctionProblem::my_output(), and PolarNSProblem< ELEMENT >::pin_boundaries().
double Global_Physical_Variables::Pitch = 1.0 |
Referenced by SteadyHelicalProblem< ELEMENT >::SteadyHelicalProblem().
double Global_Physical_Variables::Pmax =2.0 |
Max. pressure. Only used in steady runs during parameter incrementation. Use 2.0 for Re=250; 3.7 for Re=0 to span the range in Heil (2004) paper.
Referenced by FSICollapsibleChannelProblem< ELEMENT >::steady_run(), SegregatedFSICollapsibleChannelProblem< ELEMENT >::steady_run(), FSICollapsibleChannelProblem< ELEMENT >::unsteady_run(), and SegregatedFSICollapsibleChannelProblem< ELEMENT >::unsteady_run().
double Global_Physical_Variables::Pmin =1.5 |
Min. pressure. Only used in steady runs during parameter incrementation. Use 1.5 for values of Re to span the range in Heil (2004) paper.
Referenced by FSICollapsibleChannelProblem< ELEMENT >::steady_run(), and SegregatedFSICollapsibleChannelProblem< ELEMENT >::steady_run().
double Global_Physical_Variables::Poro_elastic_to_navier_stokes_fluid_density =1.0 |
Ratio of poro-elastic fluid to Navier-Stokes fluid densities – almost certainly one; we allow a variable value to be able to switch off wall inertia without having to set the Reynolds number to zero.
Referenced by main().
Data * Global_Physical_Variables::Pout_data_pt |
Pointer to Data holding downstream pressure load.
Referenced by CollapsibleChannelProblem< ELEMENT >::setup_outflow_flux_control_elements().
double Global_Physical_Variables::Prescribed_y = 1.0 |
Prescribed position of control point.
Prescribed y coordinate of control point.
Referenced by FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), main(), ShellProblem< ELEMENT >::ShellProblem(), and ShellProblem< ELEMENT >::solve().
double Global_Physical_Variables::Prescribed_z = 0.0 |
Prescribed position of control point.
Referenced by main(), and PlateProblem< ELEMENT >::PlateProblem().
double Global_Physical_Variables::Pressure_wavespeed =0.0 |
Storage for pressure wavespeed in solid – dependent parameter!
Referenced by doc_dependent_parameters().
ofstream Global_Physical_Variables::Pvd_file |
Pvd file – a wrapper for all the different vtu output files plus information about continuous time to facilitate animations in paraview
Referenced by InterfaceProblem< ELEMENT, TIMESTEPPER >::doc_solution(), and InterfaceProblem< ELEMENT, TIMESTEPPER >::unsteady_run().
double Global_Physical_Variables::Q =1.0e-2 |
Ratio of scales.
FSI parameter.
Stress ratio.
Fluid structure interaction parameter: Ratio of stresses used for non-dimensionalisation of fluid to solid stresses. As in Heil (2004) paper
Fluid structure interaction parameter: Ratio of stresses used for non-dimensionalisation of fluid to solid stresses.
Fluid structure interaction parameter: Ratio of stresses used for non-dimensionalisation of fluid to solid stresses.
Referenced by AirwayReopeningProblem< ELEMENT >::actions_after_change_in_global_parameter(), AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem(), UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_fsi_traction_elements(), PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_poro_face_elements(), PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_solid_traction_elements(), Flags::doc_flags(), AirwayReopeningProblem< ELEMENT >::dump(), FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), FSIDrivenCavityProblem< ELEMENT >::FSIDrivenCavityProblem(), FSIRingProblem::FSIRingProblem(), main(), UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::output_strain_and_dissipation(), AirwayReopeningProblem< ELEMENT >::read(), Flags::segregated_doc_flags(), FSICollapsibleChannelProblem< ELEMENT >::steady_run(), SegregatedFSICollapsibleChannelProblem< ELEMENT >::steady_run(), FSICollapsibleChannelProblem< ELEMENT >::unsteady_run(), SegregatedFSICollapsibleChannelProblem< ELEMENT >::unsteady_run(), SegregatedFSICollapsibleChannelProblem< ELEMENT >::write_zone_info_for_convergence_history(), and SegregatedFSIDrivenCavityProblem< ELEMENT >::write_zone_info_for_convergence_history().
double Global_Physical_Variables::R_l =0.01 |
double Global_Physical_Variables::R_r =1. |
Referenced by oomph::StreamfunctionProblem::my_output().
double Global_Physical_Variables::Ra = 10.0 |
Rayleigh number.
Referenced by RefineableSphereConvectionProblem< ELEMENT >::doc_solution(), main(), and RefineableSphereConvectionProblem< ELEMENT >::RefineableSphereConvectionProblem().
double Global_Physical_Variables::Radius =1.0 |
Radius of the pipe.
The radius of the torus.
Referenced by Vreman::add_particles(), CombCanSpineMesh< ELEMENT, INTERFACE_ELEMENT >::build_single_layer_mesh(), CombTipSpineMesh< ELEMENT, INTERFACE_ELEMENT >::build_single_layer_mesh(), STSpineMesh< ELEMENT, INTERFACE_ELEMENT >::build_single_layer_mesh(), MyCanyonMesh< ELEMENT, INTERFACE_ELEMENT >::change_radius(), MyTipMesh< ELEMENT, INTERFACE_ELEMENT >::change_radius(), inflowFromPeriodic::Check_and_Duplicate_Periodic_Particle(), Slide::create_rough_wall(), HomogenisationProblem< ELEMENT >::HomogenisationProblem(), ThreeDimBethertonProblem< ELEMENT >::multiply_aspect_ratio(), FilledCircle::position(), GeneralCircle::position(), MyCurvedCylinder::position(), MyHelicalCylinder::position(), MyCylinder::position(), MyCanyonMesh< ELEMENT, INTERFACE_ELEMENT >::radius(), MyTipMesh< ELEMENT, INTERFACE_ELEMENT >::radius(), RefineableAdvectionDiffusionPipeProblem< ELEMENT >::RefineableAdvectionDiffusionPipeProblem(), Slide::set_Walls(), CGHandlerSelfTest::setupInitialConditions(), NewtonsCradleSelftest::setupInitialConditions(), NewtonsCradleSelfTest::setupInitialConditions(), SquarePacking::setupInitialConditions(), Siegen::Siegen(), Slide::Slide(), ThreeDimBethertonProblem< ELEMENT >::ThreeDimBethertonProblem(), TorusProblem< ELEMENT >::TorusProblem(), UnstructuredTorusProblem< ELEMENT >::UnstructuredTorusProblem(), GlobalParameters::update_mesh_parameters(), and wind_function().
double Global_Physical_Variables::Rat_press = 2.87 |
double Global_Physical_Variables::Rayleigh = 1800.0 |
Rayleigh number.
Rayleigh number, set to be greater than the threshold for linear instability
Rayleigh number, set to be zero so that there are no gravitational effects
Referenced by ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::ConvectionProblem(), RefineableBuoyantQCrouzeixRaviartElement< DIM >::Default_Physical_Constant_Value(), and RefineableConvectionProblem< NST_ELEMENT, AD_ELEMENT >::RefineableConvectionProblem().
double Global_Physical_Variables::Rayleigh_S = -1000 |
double Global_Physical_Variables::Rayleigh_T = 1800.0 |
Thermal Rayleigh number, set to be greater than the threshold for linear instability
Referenced by DDConvectionProblem< NST_ELEMENT, AD_ELEMENT >::DDConvectionProblem(), QCrouzeixRaviartElementWithTwoExternalElement< DIM >::Default_Physical_Constant_Value(), and RefineableDDConvectionProblem< NST_ELEMENT, AD_ELEMENT >::RefineableDDConvectionProblem().
double Global_Physical_Variables::Re = 0.1 |
Reynolds number.
Reynolds number, based on the average velocity within the fluid film.
--— KINEMATIC AND DYNAMIC PROBLEM --—
The Reynolds number.
Reynolds number
Referenced by UnstructuredTorusProblem< ELEMENT >::actions_after_adapt(), UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_after_adapt(), AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem(), AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::AxisymFreeSurfaceNozzleAdvDiffRobinProblem(), BrethertonProblem< ELEMENT >::BrethertonProblem(), RefineableDrivenCavityProblem< ELEMENT >::build_mesh(), ChannelSpineFlowProblem< ELEMENT >::ChannelSpineFlowProblem(), ChannelWithLeafletProblem< ELEMENT >::ChannelWithLeafletProblem(), CollapsibleChannelProblem< ELEMENT >::CollapsibleChannelProblem(), Flags::doc_flags(), SteadyCurvedTubeProblem< ELEMENT >::doc_solution(), SteadyHelicalProblem< ELEMENT >::doc_solution(), SteadyTubeProblem< ELEMENT >::doc_solution(), AirwayReopeningProblem< ELEMENT >::doc_solution(), RefineableSphericalCouetteProblem< ELEMENT >::doc_solution(), DrivenCavityProblem< ELEMENT, MESH >::DrivenCavityProblem(), ElasticInterfaceProblem< ELEMENT, TIMESTEPPER >::ElasticInterfaceProblem(), EntryFlowProblem< ELEMENT >::EntryFlowProblem(), OscRingNStProblem< ELEMENT >::finish_problem_setup(), FlowPastBoxProblem< ELEMENT >::FlowPastBoxProblem(), FreeSurfaceRotationProblem< ELEMENT >::FreeSurfaceRotationProblem(), FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), FSIDrivenCavityProblem< ELEMENT >::FSIDrivenCavityProblem(), FSIRingProblem::FSIRingProblem(), InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem(), main(), MeltSpinningProblem< ELEMENT >::MeltSpinningProblem(), NavierStokesProblem< ELEMENT >::NavierStokesProblem(), OscEllipseProblem< ELEMENT, TIMESTEPPER >::OscEllipseProblem(), OscRingNStProblem< ELEMENT >::OscRingNStProblem(), SphericalSteadyRotationProblem< ELEMENT >::parameter_study(), PolarNSProblem< ELEMENT >::PolarNSProblem(), PRefineableDrivenCavityProblem< ELEMENT >::PRefineableDrivenCavityProblem(), Global_Parameters::pressure_couette(), PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PressureWaveFSIProblem(), QuarterCircleDrivenCavityProblem< ELEMENT >::QuarterCircleDrivenCavityProblem(), RectangularDrivenCavityProblem< ELEMENT >::RectangularDrivenCavityProblem(), RefineableDrivenCavityProblem< ELEMENT >::RefineableDrivenCavityProblem(), RefineableSphereConvectionProblem< ELEMENT >::RefineableSphereConvectionProblem(), RefineableSphericalCouetteProblem< ELEMENT >::RefineableSphericalCouetteProblem(), RefineableSphericalSpinUpProblem< ELEMENT >::RefineableSphericalSpinUpProblem(), ExactSolution::rigid_body_rotation(), ExactSolution::rigid_body_rotation_dr(), ExactSolution::rigid_body_rotation_dtheta(), RotatingCylinderProblem< ELEMENT, TIMESTEPPER >::RotatingCylinderProblem(), Flags::segregated_doc_flags(), UnstructuredFluidProblem< ELEMENT >::set_boundary_conditions(), SphericalSpinUpProblem< ELEMENT >::SphericalSpinUpProblem(), SphericalSteadyRotationProblem< ELEMENT >::SphericalSteadyRotationProblem(), MeltSpinningProblem< ELEMENT >::steady_run(), FSICollapsibleChannelProblem< ELEMENT >::steady_run(), SegregatedFSICollapsibleChannelProblem< ELEMENT >::steady_run(), AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::steady_run(), SteadyCurvedTubeProblem< ELEMENT >::SteadyCurvedTubeProblem(), SteadyHelicalProblem< ELEMENT >::SteadyHelicalProblem(), SteadyTubeProblem< ELEMENT >::SteadyTubeProblem(), SurfactantProblem< ELEMENT, INTERFACE_ELEMENT >::SurfactantProblem(), ThreeDimBethertonProblem< ELEMENT >::ThreeDimBethertonProblem(), FSICollapsibleChannelProblem< ELEMENT >::unsteady_run(), SegregatedFSICollapsibleChannelProblem< ELEMENT >::unsteady_run(), OscRingNStProblem< ELEMENT >::write_trace_file_header(), OscRingNStProblem< ELEMENT >::write_trace_file_header_historic(), SegregatedFSICollapsibleChannelProblem< ELEMENT >::write_zone_info_for_convergence_history(), and SegregatedFSIDrivenCavityProblem< ELEMENT >::write_zone_info_for_convergence_history().
double Global_Physical_Variables::Re_invFr =100 |
Reynolds/Froude number.
Referenced by body_force(), and QuarterCircleDrivenCavityProblem< ELEMENT >::QuarterCircleDrivenCavityProblem().
double Global_Physical_Variables::ReCa =0.0 |
Reynolds divided by Capillary number.
Referenced by AirwayReopeningProblem< ELEMENT >::actions_after_change_in_global_parameter().
double Global_Physical_Variables::ReInvFr = 0.01 |
Product of Reynolds number and inverse of Froude number.
Product of Reynolds and Froude number.
The product of Reynolds number and inverse Froude number is set to two in this problem, which gives the free surface velocity to be sin(alpha). [Set to three in order to get the same scale as used by Yih, Benjamin, etc]
Referenced by AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem(), AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::AxisymFreeSurfaceNozzleAdvDiffRobinProblem(), BrethertonProblem< ELEMENT >::BrethertonProblem(), ElasticInterfaceProblem< ELEMENT, TIMESTEPPER >::ElasticInterfaceProblem(), FreeSurfaceRotationProblem< ELEMENT >::FreeSurfaceRotationProblem(), InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem(), main(), MeltSpinningProblem< ELEMENT >::MeltSpinningProblem(), SurfactantProblem< ELEMENT, INTERFACE_ELEMENT >::SurfactantProblem(), and ThreeDimBethertonProblem< ELEMENT >::ThreeDimBethertonProblem().
double Global_Physical_Variables::ReSt = 5.0 |
Womersley number.
Reynolds x Strouhal number.
Womersley number: Product of Reynolds and Strouhal numbers.
Womersley = Reynolds times Strouhal.
Womersley number (Reynolds x Strouhal, computed automatically)
Womersley number (Reynolds x Strouhal)
Referenced by AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem(), BrethertonProblem< ELEMENT >::BrethertonProblem(), CollapsibleChannelProblem< ELEMENT >::CollapsibleChannelProblem(), DrivenCavityProblem< ELEMENT, MESH >::DrivenCavityProblem(), ElasticInterfaceProblem< ELEMENT, TIMESTEPPER >::ElasticInterfaceProblem(), OscRingNStProblem< ELEMENT >::finish_problem_setup(), FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), FSIDrivenCavityProblem< ELEMENT >::FSIDrivenCavityProblem(), FSIRingProblem::FSIRingProblem(), InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem(), main(), OscEllipseProblem< ELEMENT, TIMESTEPPER >::OscEllipseProblem(), OscRingNStProblem< ELEMENT >::OscRingNStProblem(), RefineableSphericalSpinUpProblem< ELEMENT >::RefineableSphericalSpinUpProblem(), RotatingCylinderProblem< ELEMENT, TIMESTEPPER >::RotatingCylinderProblem(), SphericalSpinUpProblem< ELEMENT >::SphericalSpinUpProblem(), CollapsibleChannelProblem< ELEMENT >::unsteady_run(), OscRingNStProblem< ELEMENT >::write_trace_file_header(), and OscRingNStProblem< ELEMENT >::write_trace_file_header_historic().
double Global_Physical_Variables::Rest_length_linear =1.0 |
Rest length of the linear springs.
Referenced by spring_load(), and spring_load_lower().
double Global_Physical_Variables::Reynolds =10.0 |
Reynolds number.
Referenced by RefineableBuoyantQCrouzeixRaviartElement< DIM >::Default_Physical_Constant_Value().
double Global_Physical_Variables::Rho_f_over_rho = 0.0 |
Ratio of the pore fluid density to the compound density – dependent parameter compute from density ratio and porosity.
double Global_Physical_Variables::Scaled_Bond = 0.0 |
Scaled Bond number (Bo/Ca), set to be zero so that there are no gravitational effects
Scaled Bond number (Bo/Ca) This is set to zero so that there are no gravitational effects
Referenced by ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::ConvectionProblem().
double Global_Physical_Variables::Sigma0 =1.0e3 |
2nd Piola Kirchhoff pre-stress
2nd Piola Kirchhoff pre-stress. As in Jensen & Heil (2003) paper.
2nd Piola Kirchhoff pre-stress. As in Heil (2004) paper.
Referenced by ElasticBeamProblem::ElasticBeamProblem(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), main(), ElasticBeamProblem::parameter_study(), and PlateProblem< ELEMENT >::PlateProblem().
double Global_Physical_Variables::Solid_mesh_bl_thickness =0.01 |
Poro-elastic mesh boundary layer thickness.
double Global_Physical_Variables::St = 1.0 |
Strouhal number.
Stokes number.
The Strouhal number.
Referenced by ChangingTOIParticle::actionsAfterTimeStep(), PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_fluid_traction_elements(), InterfaceProblem< ELEMENT, TIMESTEPPER >::create_interface_elements(), oomph::PerturbedSpineLinearisedAxisymmetricFluidInterfaceElement< ELEMENT >::fill_in_generic_residual_contribution_interface(), oomph::FluidInterfaceElement::fill_in_generic_residual_contribution_interface(), get_exact_u(), InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem(), main(), update_dependent_parameters(), and GlobalParameters::update_physical_parameters().
bool Global_Physical_Variables::stokes =false |
Referenced by PolarNSProblem< ELEMENT >::actions_before_solve().
StrainEnergyFunction * Global_Physical_Variables::Strain_energy_function_pt =0 |
Pointer to strain energy function.
Referenced by main().
double Global_Physical_Variables::T = 0.0 |
Period of oscillations.
Referenced by AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem(), OscEllipseProblem< ELEMENT, TIMESTEPPER >::OscEllipseProblem(), and AirwayReopeningProblem< ELEMENT >::read().
double Global_Physical_Variables::T_cos =0.0 |
Timescale for ramping up pressure via cos profile (if zero we have an impulsive start)
Referenced by fluid_inflow_boundary_traction().
double Global_Physical_Variables::T_ext = 0.0 |
Exterior temperature.
Referenced by prescribed_beta_on_fixed_r_boundary().
double Global_Physical_Variables::T_inlet = 1.0 |
Inlet temperature.
Referenced by AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::actions_before_newton_solve(), and viscosity_ratio_function().
double Global_Physical_Variables::T_kick |
Duration of transient load.
double Global_Physical_Variables::T_pcos_end =10.0 |
Only keep p_cos switched on until T_pcos_end.
Referenced by ShellProblem< ELEMENT >::run_it().
double Global_Physical_Variables::T_tanh =0.25 |
Parameter for tanh origin for pressure incrementation.
Referenced by PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep(), and main().
double Global_Physical_Variables::Table_position = 10.78 |
Position of the table.
Referenced by spring_load_lower().
Vector<double> Global_Physical_Variables::Tau(2, 1.0) =2.0/Inner_radius |
Shear stress (for steady Poiseuille flow)
Timescales for transport equations (identically one from our non-dimensionalisation)
Referenced by SurfactantProblem< ELEMENT, INTERFACE_ELEMENT >::SurfactantProblem(), and validation_fluid_fsi_boundary_traction().
double Global_Physical_Variables::timeScale = 1 |
Time scale.
Referenced by VolumeCoupling::getInvCoupledMassPerTime(), main(), oomph::VolumeCoupledElement< ELEMENT >::output(), and CoupledBeam::setupOomph().
double Global_Physical_Variables::Tube_width = 10.0 |
Natural width of the open tube.
Referenced by AirwayReopeningProblem< ELEMENT >::doc_solution(), AirwayReopeningProblem< ELEMENT >::dump(), AirwayReopeningProblem< ELEMENT >::parameter_study(), and AirwayReopeningProblem< ELEMENT >::read().
int Global_Physical_Variables::uniform = 0 |
double Global_Physical_Variables::Uniform_gamma =1.1 |
Uniform volumetric expansion.
Referenced by StaticDiskCompressionProblem< ELEMENT >::doc_solution(), and ElasticRefineableQuarterCircleSectorMesh< ELEMENT >::ElasticRefineableQuarterCircleSectorMesh().
map<double,pair<GeomObject*,Vector<double> > > Global_Physical_Variables::upper_map |
Upper wall map.
Referenced by AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem(), and spring_load_lower().
GeomObject* Global_Physical_Variables::Upper_wall_pt |
Pointer to the upper wall.
Referenced by AirwayReopeningProblem< ELEMENT >::AirwayReopeningProblem(), oomph::BrethertonSpineMesh< ELEMENT, SpineLineFluidInterfaceElement< ELEMENT > >::initial_element_reorder(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::reposition_spines(), and AirwayReopeningProblem< ELEMENT >::~AirwayReopeningProblem().
double Global_Physical_Variables::Viscosity_Ratio = 0.1 |
Ratio of viscosity in upper fluid to viscosity in lower fluid. Reynolds number etc. is based on viscosity in lower fluid.
Referenced by SpineGravityTractionElement< ELEMENT >::add_generic_residual_contribution(), InterfaceProblem< ELEMENT, TIMESTEPPER >::create_interface_elements(), and InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem().
double Global_Physical_Variables::Volume = 1.2 |
The volume of the domain.
Referenced by Eigen::BVIntersect(), Eigen::BVMinimize(), CapProblem< ELEMENT >::create_volume_constraint_elements(), PseudoSolidCapProblem< ELEMENT >::create_volume_constraint_elements(), RefineableRotatingCylinderProblem< ELEMENT >::create_volume_constraint_elements(), and SolidFreeSurfaceRotationProblem< ELEMENT >::create_volume_constraint_elements().
Direction of the wall normal vector.
Direction of the wall normal vector (at the inlet)
Referenced by CapProblem< ELEMENT >::CapProblem(), main(), PseudoSolidCapProblem< ELEMENT >::PseudoSolidCapProblem(), RefineableRotatingCylinderProblem< ELEMENT >::RefineableRotatingCylinderProblem(), wall_unit_normal_fct(), wall_unit_normal_inlet_fct(), and wall_unit_normal_outlet_fct().
double Global_Physical_Variables::Wavespeed =0.0 |
Storage for Moens Korteweg wavespeed – dependent parameter!
Referenced by doc_dependent_parameters(), main(), pulse_wave_solution(), and update_dependent_parameters().
double Global_Physical_Variables::Wo = 0.0 |
The Womersley number – dependent parameter; compute from Re and St
Referenced by doc_dependent_parameters(), PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PressureWaveFSIProblem(), and update_dependent_parameters().
double Global_Physical_Variables::X_indent_start =0.5 |
Start of indented region.
Referenced by height().
int Global_Physical_Variables::xmesh =30 |
double Global_Physical_Variables::Xprescr = 1.0 |
Prescribed position (only used for displacement control)
Referenced by ElasticRingProblem< ELEMENT >::ElasticRingProblem(), and ElasticRingProblem< ELEMENT >::parameter_study().
double* Global_Physical_Variables::Y_lo_pt |
Pointer to y-position at inflow on the lower wall.
Referenced by BrethertonProblem< ELEMENT >::BrethertonProblem(), and inflow().
double* Global_Physical_Variables::Y_up_pt |
Pointer to y-position at inflow on the upper wall.
Referenced by BrethertonProblem< ELEMENT >::BrethertonProblem(), and inflow().
int Global_Physical_Variables::ymesh =15 |
double Global_Physical_Variables::Yprescr = 1.0 |
Current prescribed vertical position of control point (only used for displacement control)
Referenced by FSICollapsibleChannelProblem< ELEMENT >::doc_solution_steady(), SegregatedFSICollapsibleChannelProblem< ELEMENT >::doc_solution_steady(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), FSICollapsibleChannelProblem< ELEMENT >::steady_run(), and SegregatedFSICollapsibleChannelProblem< ELEMENT >::steady_run().
double Global_Physical_Variables::Yprescr_min =0.6 |
Min. of prescribed vertical position of conrol point (only used during parameter study with displacement control). 0.6 corresponds to the value in Heil (2004) paper for static runs.
Referenced by main(), and FSICollapsibleChannelProblem< ELEMENT >::steady_run().