![]() |
|
Namespace for global parameters. More...
Functions | |
void | boundary_traction (const double &time, const Vector< double > &x, const Vector< double > &n, Vector< double > &result) |
The traction function at r=Rmin: (t_r, t_z, t_theta) More... | |
void | body_force (const double &time, const Vector< double > &x, Vector< double > &result) |
void | exact_solution_th (const Vector< double > &x, Vector< double > &u) |
double | u_r (const double &time, const Vector< double > &x) |
Calculate the time dependent form of the r-component of displacement. More... | |
double | u_z (const double &time, const Vector< double > &x) |
Calculate the time dependent form of the z-component of displacement. More... | |
double | u_theta (const double &time, const Vector< double > &x) |
Calculate the time dependent form of the theta-component of displacement. More... | |
double | d_u_r_dt (const double &time, const Vector< double > &x) |
Calculate the time dependent form of the r-component of velocity. More... | |
double | d_u_z_dt (const double &time, const Vector< double > &x) |
Calculate the time dependent form of the z-component of velocity. More... | |
double | d_u_theta_dt (const double &time, const Vector< double > &x) |
Calculate the time dependent form of the theta-component of velocity. More... | |
double | d2_u_r_dt2 (const double &time, const Vector< double > &x) |
Calculate the time dependent form of the r-component of acceleration. More... | |
double | d2_u_z_dt2 (const double &time, const Vector< double > &x) |
Calculate the time dependent form of the z-component of acceleration. More... | |
double | d2_u_theta_dt2 (const double &time, const Vector< double > &x) |
Calculate the time dependent form of the theta-component of acceleration. More... | |
void | exact_solution (const double &time, const Vector< double > &x, Vector< double > &u) |
std::complex< double > | Eigenfunction_normalisation (1.0, 0.0) |
TimeHarmonicIsotropicElasticityTensor | E (Nu) |
The elasticity tensor for the solid. More... | |
void | update_parameter_values () |
Function to update dependent parameter values. More... | |
void | solid_boundary_displacement (const Vector< double > &x, Vector< std::complex< double > > &u) |
Displacement field on inner boundary of solid. More... | |
std::complex< double > | HankelH1 (const double &k, const double &x) |
Interface to Hankel function in maple style. More... | |
std::complex< double > | axisym_coefficient () |
void | exact_axisym_potential (const Vector< double > &x, Vector< double > &soln) |
Exact solution for Helmholtz potential for axisymmetric solution. More... | |
double | exact_axisym_radiated_power () |
Exact radiated power for axisymmetric solution. More... | |
Vector< double > | Omega_sq (2, 0.0) |
Square of non-dim frequency for the two regions – dependent variable! More... | |
Vector< double > | Density_ratio (2, 0.1) |
Density ratio for the two regions: solid to fluid. More... | |
void | pressure_load (const Vector< double > &x, const Vector< double > &n, Vector< std::complex< double > > &traction) |
Pressure load (real and imag part) More... | |
std::complex< double > | Nu (std::complex< double >(0.3, 0.0)) |
Poisson's ratio Nu. More... | |
std::complex< double > | Omega_sq (std::complex< double >(100.0, 0.0)) |
Non-dim square of frequency for solid – dependent variable! More... | |
Vector< std::complex< double > > | E (2, std::complex< double >(1.0, 0.0)) |
Define the non-dimensional Young's modulus. More... | |
Vector< std::complex< double > > | Omega_sq (2, std::complex< double >(100.0, 0.0)) |
Non-dim square of frequency for solid – dependent variable! More... | |
Vector< double > | Density_ratio (2, 1.0) |
Density ratio: solid to fluid. More... | |
void | press_load (const Vector< double > &xi, const Vector< double > &x, const Vector< double > &N, Vector< double > &load) |
Load function for wall. More... | |
double | flux (const double &t) |
Flux: Pulsatile flow. More... | |
void | gravity (const double &time, const Vector< double > &xi, Vector< double > &b) |
Non-dimensional gravity as body force. More... | |
void | set_parameters (const string &case_id) |
Set parameters for the various test cases. More... | |
bool | is_on_fsi_boundary (Node *nod_pt) |
Boolean to identify if node is on fsi boundary. More... | |
void | prescribed_inflow_traction (const double &t, const Vector< double > &x, const Vector< double > &n, Vector< double > &traction) |
Applied traction on fluid at the inflow boundary. More... | |
void | prescribed_outflow_traction (const double &t, const Vector< double > &x, const Vector< double > &n, Vector< double > &traction) |
Applied traction on fluid at the inflow boundary. More... | |
void | exact_solution (const Vector< double > &x, Vector< double > &u) |
The exact solution for infinite depth case. More... | |
void | periodic_traction (const double &time, const Vector< double > &x, const Vector< double > &n, Vector< double > &result) |
The traction function. More... | |
double | blend (const Vector< double > &x, const Vector< double > &x_c) |
Blend function, centred at x_c. More... | |
Vector< double > | grad_blend (const Vector< double > &x, const Vector< double > &x_c) |
Gradient of blend function, centred at x_c. More... | |
Vector< double > | velocity_couette (const Vector< double > &x) |
Couette flow. More... | |
double | pressure_couette (const Vector< double > &x) |
Couette Pressure. More... | |
void | exact_couette (const Vector< double > &x, Vector< double > &soln) |
Combined exact solution (u,v,p) More... | |
Vector< double > | velocity_pseudo_singularity_for_couette (const Vector< double > &x) |
Pseudo_singularity for computation of Couette flow. More... | |
Vector< Vector< double > > | grad_velocity_pseudo_singularity_for_couette (const Vector< double > &x) |
Pseudo_singularity for computation of Couette flow: grad[i][j] = du_i/dx_j. More... | |
double | pressure_pseudo_singularity_for_couette (const Vector< double > &x) |
Pseudo_singularity for computation of Couette flow. More... | |
Vector< double > | blended_velocity_pseudo_singularity_for_couette (const Vector< double > &x) |
Blended Pseudo_singularity for computation of Couette flow. More... | |
Vector< Vector< double > > | blended_grad_velocity_pseudo_singularity_for_couette (const Vector< double > &x) |
double | blended_pressure_pseudo_singularity_for_couette (const Vector< double > &x) |
Blended Pseudo_singularity for computation of Couette flow. More... | |
Vector< double > | velocity_singularity1 (const Vector< double > &x) |
Function that computes the fitting velocity solution near the corner (0,0) More... | |
Vector< double > | velocity_singularity2 (const Vector< double > &x) |
Function that computes the fitting velocity solution near the corner (1,0) More... | |
Vector< Vector< double > > | grad_velocity_singularity1 (const Vector< double > &coord) |
Vector< Vector< double > > | grad_velocity_singularity2 (const Vector< double > &coord) |
double | pressure_singularity1 (const Vector< double > &x) |
Function that computes the fitting pressure solution near the corner (0,0) More... | |
double | pressure_singularity2 (const Vector< double > &x) |
Function that computes the fitting pressure solution near the corner (1,0) More... | |
Vector< double > | grad_pressure_singularity1 (const Vector< double > &coord) |
void | analytic_solution1 (const Vector< double > &x, Vector< double > &solution) |
Function that computes the fitting solutions near the corner (0,0) More... | |
void | analytic_solution2 (const Vector< double > &x, Vector< double > &solution) |
Function that computes the fitting solutions near the corner (1,0) More... | |
Vector< double > | G (3) |
Gravity. More... | |
void | compute_dependent_parameters () |
Function to compute dependent parameters. More... | |
void | Hankel_first (const unsigned &n, const double &x, Vector< std::complex< double > > &h, Vector< std::complex< double > > &hp) |
void | exact_u (const Vector< double > &x, Vector< double > &u) |
Exact solution as a Vector: {u_x_real, u_y_real, u_x_imag, u_y_imag}. More... | |
void | body_force (const Vector< double > &x, Vector< std::complex< double > > &b) |
Body force. More... | |
void | constant_pressure (const Vector< double > &xi, const Vector< double > &x, const Vector< double > &n, Vector< double > &traction) |
std::complex< double > | Nu (0.3, 0.05) |
Define Poisson's ratio Nu. More... | |
std::complex< double > | E (1.0, 0.01) |
Define the non-dimensional Young's modulus. More... | |
std::complex< double > | Omega_sq (10.0, 5.0) |
const std::complex< double > | I (0.0, 1.0) |
Define the imaginary unit. More... | |
void | boundary_traction (const Vector< double > &x, const Vector< double > &n, Vector< std::complex< double > > &result) |
The traction function at r=rmin: (t_r, t_z, t_theta) More... | |
std::complex< double > | Omega_sq (10.0, 0.0) |
void | solid_boundary_displacement (const Vector< double > &x, Vector< double > &u) |
Real-valued, radial displacement field on inner boundary. More... | |
void | constant_pressure (const Vector< double > &x, const Vector< double > &n, Vector< std::complex< double > > &traction) |
Constant pressure load (real and imag part) More... | |
double | BesselY (const double &n, const double &x) |
Helper function to evaluate Y_n(x) from bloody maple output. More... | |
double | BesselJ (const double &n, const double &x) |
Helper function to evaluate J_n(x) from bloody maple output. More... | |
Variables | |
double | Nu = 0.3 |
Define Poisson's ratio Nu. More... | |
double | E = 1.0 |
Define the non-dimensional Young's modulus. More... | |
double | Lambda = E*Nu/(1.0+Nu)/(1.0-2.0*Nu) |
Lame parameters. More... | |
double | Mu = E/2.0/(1.0+Nu) |
double | Omega_sq = 0.5 |
Square of the frequency of the time dependence. More... | |
unsigned | Nr = 5 |
Number of elements in r-direction. More... | |
unsigned | Nz = 10 |
Number of elements in z-direction. More... | |
double | Lr = 1.0 |
Length of domain in r direction. More... | |
double | Lz = 2.0 |
Length of domain in z-direction. More... | |
double | Rmin = 0.1 |
Set up min r coordinate. More... | |
double | Zmin = 0.3 |
Set up min z coordinate. More... | |
double | Rmax = Rmin+Lr |
Set up max r coordinate. More... | |
double | Zmax = Zmin+Lz |
Set up max z coordinate. More... | |
double | Re =75.0 |
reynolds number More... | |
double | B =0.7 |
double | Alpha =0.0 |
Peakiness parameter for pressure load. More... | |
bool | Read_in_eigenfunction_from_disk = true |
double | K_squared =10.0 |
Square of wavenumber for the Helmholtz equation. More... | |
double | Outer_radius =4.0 |
Radius of outer boundary of Helmholtz domain. More... | |
double | Q =0.0 |
FSI parameter. More... | |
double | H_coating =0.3 |
Non-dim thickness of elastic coating. More... | |
double | Density_ratio =0.0 |
Density ratio: solid to fluid. More... | |
unsigned | N =0 |
string | Directory ="RESLT" |
Output directory. More... | |
unsigned | El_multiplier =1 |
Multiplier for number of elements. More... | |
unsigned | ABC_order =3 |
Order of absorbing/appproximate boundary condition. More... | |
Vector< TimeHarmonicIsotropicElasticityTensor * > | E_pt |
The elasticity tensors for the two regions. More... | |
double | P = 0.1 |
Uniform pressure. More... | |
int | Fourier_wavenumber =0 |
Define azimuthal Fourier wavenumber. More... | |
unsigned | M =4 |
double | L =12.0 |
tube length More... | |
double | Lup =1.5 |
upstream length More... | |
double | Ldown =3.0 |
downstream length More... | |
double | H =0.15 |
wall thickness More... | |
unsigned | N_slice =4 |
number of axial slices in fluid mesh More... | |
ConstitutiveLaw * | Constitutive_law_wall_pt =0 |
Pointer to constitutive law for the wall. More... | |
ConstitutiveLaw * | Constitutive_law_pseudo_elastic_pt =0 |
Pointer to constitutive law for the pseudo elastic node update elements. More... | |
double | Nu_wall =0.3 |
double | Nu_pseudo_elastic =0.1 |
double | Pcos = 2.0e-4 |
Perturbation pressure. More... | |
double | Lambda_sq =0.0 |
Timescale ratio (non-dim density) for solid. More... | |
double | T =1.0 |
Period of periodic variation in inflow pressure. More... | |
double | Dt =0.01 |
Timestep. More... | |
unsigned | Nstep_per_period =40 |
Number of steps per period. More... | |
unsigned | Nperiod =5 |
Number of periods. More... | |
double | Leaflet_x0 = 1.0 |
x-position of root of leaflet More... | |
double | Leaflet_height =0.5 |
height of leaflet More... | |
double | Fluid_length_left =1.0 |
length of fluid mesh to left of leaflet More... | |
double | Fluid_length_right =3.0 |
length of fluid mesh to right of leaflet More... | |
double | Fluid_height =1.0 |
height of fluid mesh More... | |
unsigned | Mesh_nleft =4 |
Num elements to left of leaflet in coarse mesh. More... | |
unsigned | Mesh_nright =12 |
Num elements to right of leaflet in coarse mesh. More... | |
unsigned | Mesh_ny1 =2 |
Num elements in fluid mesh in y dirn adjacent to leaflet. More... | |
unsigned | Mesh_ny2 =2 |
Num elements in fluid mesh in y dirn above leaflet. More... | |
double | ReSt =50.0 |
Womersley number: Product of Reynolds and Strouhal numbers. More... | |
double | U_base =1.0 |
Min. flux. More... | |
double | U_perturbation =0.5 |
Max. flux. More... | |
double | Lambda_sq_beam =0.0 |
Beam mass density. More... | |
string | Case_ID ="FSI1" |
Default case ID. More... | |
double | St =0.5 |
Strouhal number (default assignment for FSI1 test case) More... | |
double | Centre_x =2.0 |
x position of centre of cylinder More... | |
double | Centre_y =2.0 |
y position of centre of cylinder More... | |
double | Radius =0.5 |
Radius of cylinder. More... | |
ConstitutiveLaw * | Constitutive_law_pt =0 |
Pointer to constitutive law. More... | |
bool | Ignore_fluid_loading =false |
Ignore fluid (default assignment for FSI1 test case) More... | |
double | Gravity =0.0 |
Non-dim gravity (default assignment for FSI1 test case) More... | |
double | Ramp_period =2.0 |
Period for ramping up in flux. More... | |
double | Min_flux =0.0 |
Min. flux. More... | |
double | Max_flux =1.0 |
Max. flux. More... | |
bool | Prescribe_pressure =false |
Boolean to choose if inflow pressure (true) or volume flux are prescribed. More... | |
double | P_in_max =0.0025 |
Max. inflow pressure (during periodic variation) More... | |
double | Period =0.1 |
Period of periodic variation in inflow pressure. More... | |
double | P_in =0.0 |
Fluid pressure on inflow boundary. More... | |
double | P_out =-0.25 |
Fluid pressure on outflow boundary. More... | |
double | Peak_prescribed_flow_rate =-1.0 |
Peak prescribed flow rate. More... | |
double | Prescribed_flow_rate =Peak_prescribed_flow_rate |
Prescribed flow rate. More... | |
Data * | P_in_data_pt =0 |
double | Amplitude = 1.0 |
Amplitude of traction applied. More... | |
bool | Finite =false |
double | Lx = 1.0 |
Length of domain in x direction. More... | |
double | Ly = 2.0 |
Length of domain in y direction. More... | |
double | Box_half_width = 1.5 |
(Half-)width of the box More... | |
double | Box_half_length = 1.0 |
(Half)height of the box More... | |
std::string | Gmsh_command_line_invocation ="/home/mheil/gmesh/bin/bin/gmsh" |
Specify how to call gmsh from the command line. More... | |
double | Initial_element_volume =1.0 |
double | Pr = 0.73 |
Prandtl number. More... | |
double | Pe = Re*Pr |
Peclet number. More... | |
double | Ra = 0.0 |
Rayleigh number. More... | |
Vector< double > | G |
Gravity. More... | |
double | Sphere_centre_z = 0.0 |
Location of the centre of the sphere on the axis. More... | |
unsigned | Nnode_1d =2 |
The number of nodes in one direction (default=2) More... | |
unsigned | Min_refinement_level =2 |
The minimum level of uniform refinement. More... | |
unsigned | Add_refinement_level =1 |
The additional levels of uniform refinement. More... | |
unsigned | N_adaptations =1 |
The number of adaptations allowed by the Newton solver. More... | |
unsigned | Use_adaptation_flag =0 |
unsigned | Pre_smoother_flag =0 |
unsigned | Post_smoother_flag =0 |
unsigned | Linear_solver_flag =1 |
unsigned | Output_management_flag =0 |
unsigned | Doc_convergence_flag =0 |
DocInfo | Doc_info |
DocInfo object used for documentation of the solution. More... | |
unsigned | Element_multiplier = 1 |
unsigned | N_x =10 |
unsigned | N_y =10 |
double | L_x =1.0 |
double | L_y =1.0 |
unsigned | Direction = 1 |
double | R_blend_inner =0.2 |
Inner blending radius. More... | |
double | R_blend_outer =0.8 |
Outer blending radius. More... | |
double | A_couette =1.0 |
Amplitude of linearly varying part. More... | |
double | B_couette =1.0 |
Amplitude of singular part. More... | |
Vector< double > | X_c_couette (2, 0.0) |
Random center for blended couette pseudo singularity. More... | |
unsigned | Long_run_flag =1 |
Flag for long/short run: Default = perform long run. More... | |
unsigned | Impulsive_start_flag =0 |
double | Visc_Ratio = 2.0 |
double | Box_width = 3.0 |
double | Box_length = 10.0 |
double | Ca = 1.0 |
Set the Capillary number. More... | |
double | Volume = -16.0*atan(1.0)*Radius*Radius*Radius/3.0 |
double | ReInvFr = 0.0 |
The Reynolds INverse Froude number. More... | |
double | Element_area = 0.01 |
helper to set target mesh element size More... | |
double | T_start = 0.0 |
helpers to time the code More... | |
double | T_end = 0.0 |
unsigned | N_pml_multiplier = 1 |
PML width in elements for the right layer. More... | |
double | L_pml_multiplier = 1.0 |
unsigned | N_x_right_pml = 8 |
PML width in elements for the right layer. More... | |
unsigned | N_y_top_pml = 8 |
PML width in elements for the top layer. More... | |
unsigned | N_x_left_pml = 8 |
PML width in elements for the left layer. More... | |
unsigned | N_y_bottom_pml = 8 |
PML width in elements for the left layer. More... | |
double | Width_x_right_pml = 2.0 |
double | Width_y_top_pml = 2.0 |
double | Width_x_left_pml = 2.0 |
double | Width_y_bottom_pml = 2.0 |
double | H_annulus =0.5 |
Thickness of annulus. More... | |
std::complex< double > | lambda = E*Nu/(1.0+Nu)/(1.0-2.0*Nu) |
std::complex< double > | mu = E/2.0/(1.0+Nu) |
double | rmin = 0.1 |
double | zmin = 0.3 |
double | rmax = rmin+Lr |
double | zmax = zmin+Lz |
double | Displacement_amplitude =0.1 |
Displacement amplitude on inner radius. More... | |
unsigned | Ntheta =20 |
Number of elements in azimuthal direction. More... | |
Vector< double > | Omega_sq_region (2, Omega_sq) |
Square of non-dim frequency for the two regions. More... | |
Namespace for global parameters.
Namepspace for global parameters.
Namespace for problem parameters.
Namespace for physical parameters.
Global variables.
Global parameters.
/////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////
////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////
//////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////
/////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////
//////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////////
/////////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////////
//////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////
//////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////
anonymous enum |
IDs for the two types of Lagrange multipliers used in this problem
Enumerator | |
---|---|
Parallel_flow_lagrange_multiplier_id | |
FSI_interface_displacement_lagrange_multiplier_id |
anonymous enum |
void Global_Parameters::analytic_solution1 | ( | const Vector< double > & | x, |
Vector< double > & | solution | ||
) |
Function that computes the fitting solutions near the corner (0,0)
Polar coordinates centered at the point (0,0)
Value of the U component at the angle theta
Value of the V component at the angle theta
Value of P at the angle theta
References atan2(), cos(), BiharmonicTestFunctions2::Pi, UniformPSDSelfTest::r, sin(), BiharmonicTestFunctions1::solution(), sqrt(), BiharmonicTestFunctions2::theta, and plotDoE::x.
void Global_Parameters::analytic_solution2 | ( | const Vector< double > & | x, |
Vector< double > & | solution | ||
) |
Function that computes the fitting solutions near the corner (1,0)
Polar coordinates centered at the point (1,0)
Value of the U component at the angle theta
Value of the V component at the angle theta
Value of P at the angle theta
References atan2(), cos(), BiharmonicTestFunctions2::Pi, UniformPSDSelfTest::r, sin(), BiharmonicTestFunctions1::solution(), sqrt(), BiharmonicTestFunctions2::theta, plotDoE::x, and Global_parameters::x1().
std::complex<double> Global_Parameters::axisym_coefficient | ( | ) |
Coefficient in front of Hankel function for axisymmetric solution of Helmholtz potential
References H_coating, HankelH1(), K_squared, Constitutive_Parameters::Nu, Q, and sqrt().
Referenced by exact_axisym_potential(), and exact_axisym_radiated_power().
Helper function to evaluate J_n(x) from bloody maple output.
References CRBond_Bessel::bessjy01a(), n, and plotDoE::x.
Helper function to evaluate Y_n(x) from bloody maple output.
References CRBond_Bessel::bessjy01a(), n, and plotDoE::x.
Blend function, centred at x_c.
References cos(), BiharmonicTestFunctions2::Pi, UniformPSDSelfTest::r, R_blend_inner, R_blend_outer, sqrt(), and plotDoE::x.
Referenced by blended_grad_velocity_pseudo_singularity_for_couette(), blended_pressure_pseudo_singularity_for_couette(), blended_velocity_pseudo_singularity_for_couette(), and packetmath().
Vector<Vector<double> > Global_Parameters::blended_grad_velocity_pseudo_singularity_for_couette | ( | const Vector< double > & | x | ) |
Blended Pseudo_singularity for computation of Couette flow: grad[i][j] = du_i/dx_j
References b, blend(), grad_blend(), grad_velocity_pseudo_singularity_for_couette(), i, j, velocity_pseudo_singularity_for_couette(), plotDoE::x, and X_c_couette.
Referenced by main().
double Global_Parameters::blended_pressure_pseudo_singularity_for_couette | ( | const Vector< double > & | x | ) |
Blended Pseudo_singularity for computation of Couette flow.
References b, blend(), p, pressure_pseudo_singularity_for_couette(), plotDoE::x, and X_c_couette.
Vector<double> Global_Parameters::blended_velocity_pseudo_singularity_for_couette | ( | const Vector< double > & | x | ) |
Blended Pseudo_singularity for computation of Couette flow.
References b, blend(), i, velocity_pseudo_singularity_for_couette(), plotDoE::x, and X_c_couette.
Referenced by main().
void Global_Parameters::body_force | ( | const double & | time, |
const Vector< double > & | x, | ||
Vector< double > & | result | ||
) |
The body force function; returns vector of doubles in the order (b_r, b_z, b_theta)
References cos(), Lambda, Mu, Omega_sq, Eigen::bfloat16_impl::pow(), sin(), and plotDoE::x.
Referenced by AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::AxisymmetricLinearElasticityProblem(), AxisymmetricVibratingShellProblem< ELEMENT >::doc_solution(), VibratingShellProblem< ELEMENT >::doc_solution(), oomph::LinearElasticityEquations< DIM >::fill_in_generic_contribution_to_residuals_linear_elasticity(), oomph::RefineableLinearElasticityEquations< DIM >::fill_in_generic_contribution_to_residuals_linear_elasticity(), oomph::RefineablePVDEquations< DIM >::fill_in_generic_contribution_to_residuals_pvd(), oomph::PVDEquations< DIM >::fill_in_generic_contribution_to_residuals_pvd(), oomph::ScaleCoupledElement< ELEMENT >::fill_in_generic_contribution_to_residuals_pvd(), oomph::VolumeCoupledElement< ELEMENT >::fill_in_generic_contribution_to_residuals_pvd(), 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::AxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_axi_nst(), oomph::LinearisedAxisymmetricNavierStokesEquations::fill_in_generic_residual_contribution_lin_axi_nst(), oomph::RefineableSpaceTimeNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::RefineableSpaceTimeNavierStokesMixedOrderEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::SpaceTimeNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::RefineableGeneralisedNewtonianNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::NavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::RefineableNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::RefineablePVDEquationsWithPressure< DIM >::fill_in_generic_residual_contribution_pvd_with_pressure(), oomph::PVDEquationsWithPressure< DIM >::fill_in_generic_residual_contribution_pvd_with_pressure(), oomph::RefineableSphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::SphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::FourierDecomposedTimeHarmonicLinearElasticityProblem(), RefineableQAxisymCrouzeixRaviartBoussinesqElement::get_body_force_axi_nst(), oomph::AxisymmetricNavierStokesEquations::get_body_force_gradient_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_body_force_gradient_axi_nst(), oomph::LinearisedAxisymmetricNavierStokesEquations::get_body_force_gradient_base_flow(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::get_body_force_gradient_nst(), oomph::NavierStokesEquations< DIM >::get_body_force_gradient_nst(), oomph::SpaceTimeNavierStokesEquations< DIM >::get_body_force_gradient_nst(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::get_body_force_gradient_nst(), oomph::RefineableNavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::get_body_force_nst(), oomph::AxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations::get_dresidual_dnodal_coordinates(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::RefineableGeneralisedNewtonianNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::NavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::RefineableNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::SpaceTimeNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::RefineableSpaceTimeNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), and SolidProblem< ELEMENT_TYPE >::writeToVTK().
void Global_Parameters::body_force | ( | const Vector< double > & | x, |
Vector< std::complex< double > > & | result | ||
) |
Body force.
The body force function; returns vector of complex doubles in the order (b_r, b_z, b_theta)
Define the magnitude of the forcing
Define the decay rate
The forcing used is of damped exponential type to generate axisymmetric results after post-processing
Assign the source in each dimension
References alpha, b, Eigen::bfloat16_impl::exp(), oomph::VectorHelpers::magnitude(), sqrt(), and plotDoE::x.
void Global_Parameters::boundary_traction | ( | const double & | time, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | result | ||
) |
The traction function at r=Rmin: (t_r, t_z, t_theta)
References cos(), Lambda, Mu, Eigen::bfloat16_impl::pow(), sin(), and plotDoE::x.
Referenced by AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::AxisymmetricLinearElasticityProblem(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::complete_problem_setup(), and FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::FourierDecomposedTimeHarmonicLinearElasticityProblem().
void Global_Parameters::boundary_traction | ( | const Vector< double > & | x, |
const Vector< double > & | n, | ||
Vector< std::complex< double > > & | result | ||
) |
The traction function at r=rmin: (t_r, t_z, t_theta)
References cos(), Fourier_wavenumber, I, lambda, mu, Eigen::bfloat16_impl::pow(), sin(), and plotDoE::x.
void Global_Parameters::compute_dependent_parameters | ( | ) |
Function to compute dependent parameters.
Adjust number of PML elements, set to be equal for all layers
Adjust physical size of PML layers, set to be equal for all layers
Adjust number of PML elements, set to be equal for all layers
Adjust physical size of PML layers, set to be equal for all layers
Adjust number of PML elements, set to be equal for all layers
Adjust physical size of PML layers, set to be equal for all layers
References L_pml_multiplier, N_pml_multiplier, N_x_left_pml, N_x_right_pml, N_y_bottom_pml, N_y_top_pml, Width_x_left_pml, Width_x_right_pml, Width_y_bottom_pml, and Width_y_top_pml.
Referenced by main().
void Global_Parameters::constant_pressure | ( | const Vector< double > & | x, |
const Vector< double > & | n, | ||
Vector< std::complex< double > > & | traction | ||
) |
void Global_Parameters::constant_pressure | ( | const Vector< double > & | xi, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | traction | ||
) |
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.
References i, n, and Global_Physical_Variables::P.
Referenced by UnstructuredSolidProblem< ELEMENT, MESH >::create_traction_elements(), and AnnularDiskProblem< ELASTICITY_ELEMENT >::create_traction_elements().
Calculate the time dependent form of the r-component of acceleration.
References cos(), exact_solution_th(), and plotDoE::x.
Referenced by exact_solution(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_boundary_conditions(), and AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_initial_conditions().
Calculate the time dependent form of the theta-component of acceleration.
References cos(), exact_solution_th(), and plotDoE::x.
Referenced by exact_solution(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_boundary_conditions(), and AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_initial_conditions().
Calculate the time dependent form of the z-component of acceleration.
References cos(), exact_solution_th(), and plotDoE::x.
Referenced by exact_solution(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_boundary_conditions(), and AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_initial_conditions().
Calculate the time dependent form of the r-component of velocity.
References exact_solution_th(), sin(), and plotDoE::x.
Referenced by exact_solution(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_boundary_conditions(), and AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_initial_conditions().
Calculate the time dependent form of the theta-component of velocity.
References exact_solution_th(), sin(), and plotDoE::x.
Referenced by exact_solution(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_boundary_conditions(), and AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_initial_conditions().
Calculate the time dependent form of the z-component of velocity.
References exact_solution_th(), sin(), and plotDoE::x.
Referenced by exact_solution(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_boundary_conditions(), and AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_initial_conditions().
Density ratio for the two regions: solid to fluid.
std::complex<double> Global_Parameters::E | ( | 1. | 0, |
0. | 01 | ||
) |
Define the non-dimensional Young's modulus.
Define the non-dimensional Young's modulus.
TimeHarmonicIsotropicElasticityTensor Global_Parameters::E | ( | Nu | ) |
The elasticity tensor for the solid.
The elasticity tensor.
std::complex<double> Global_Parameters::Eigenfunction_normalisation | ( | 1. | 0, |
0. | 0 | ||
) |
Referenced by FlowAroundCylinderProblem< ELEMENT >::add_eigenproblem().
void Global_Parameters::exact_axisym_potential | ( | const Vector< double > & | x, |
Vector< double > & | soln | ||
) |
Exact solution for Helmholtz potential for axisymmetric solution.
References axisym_coefficient(), HankelH1(), imag(), K_squared, UniformPSDSelfTest::r, sqrt(), and plotDoE::x.
Referenced by CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution().
double Global_Parameters::exact_axisym_radiated_power | ( | ) |
Exact radiated power for axisymmetric solution.
References axisym_coefficient(), Hankel_first(), imag(), K_squared, BiharmonicTestFunctions2::Pi, UniformPSDSelfTest::r, and sqrt().
Referenced by CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution().
Combined exact solution (u,v,p)
References pressure_couette(), velocity_couette(), and plotDoE::x.
void Global_Parameters::exact_solution | ( | const double & | time, |
const Vector< double > & | x, | ||
Vector< double > & | u | ||
) |
The exact solution in a vector: 0: u_r, 1: u_z, 2: u_theta and their 1st and 2nd derivs
References d2_u_r_dt2(), d2_u_theta_dt2(), d2_u_z_dt2(), d_u_r_dt(), d_u_theta_dt(), d_u_z_dt(), u_r(), u_theta(), u_z(), and plotDoE::x.
Referenced by cod(), cod_fixedsize(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::doc_solution(), PeriodicLoadProblem< ELEMENT >::doc_solution(), RefineablePeriodicLoadProblem< ELEMENT >::doc_solution(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::doc_solution(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::FourierDecomposedTimeHarmonicLinearElasticityProblem(), oomph::MyProblem::get_error_norm(), PeriodicLoadProblem< ELEMENT >::PeriodicLoadProblem(), RefineablePeriodicLoadProblem< ELEMENT >::RefineablePeriodicLoadProblem(), and AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_boundary_conditions().
The exact solution for infinite depth case.
The exact solution in a flat-packed vector:
References Amplitude, cos(), Eigen::bfloat16_impl::exp(), Lx, Ly, Constitutive_Parameters::Nu, BiharmonicTestFunctions2::Pi, sin(), and plotDoE::x.
Helper function - spatial components of the exact solution in a vector. This is necessary because we need to multiply this by different things to obtain the velocity and acceleration 0: u_r, 1: u_z, 2: u_theta
References cos(), Eigen::bfloat16_impl::pow(), sin(), and plotDoE::x.
Referenced by d2_u_r_dt2(), d2_u_theta_dt2(), d2_u_z_dt2(), d_u_r_dt(), d_u_theta_dt(), d_u_z_dt(), u_r(), u_theta(), and u_z().
Exact solution as a Vector: {u_x_real, u_y_real, u_x_imag, u_y_imag}.
Exact solution as a Vector.
References Hankel_first(), k, lambda, mu, Constitutive_Parameters::Nu, Omega_sq, UniformPSDSelfTest::r, sqrt(), and plotDoE::x.
Referenced by ElasticAnnulusProblem< ELASTICITY_ELEMENT >::complete_problem_setup(), AnnularDiskProblem< ELASTICITY_ELEMENT >::doc_solution(), and ElasticAnnulusProblem< ELASTICITY_ELEMENT >::doc_solution().
Flux: Pulsatile flow.
Flux increases between Min_flux and Max_flux over period Ramp_period
References cos(), BiharmonicTestFunctions2::Pi, plotPSD::t, U_base, and U_perturbation.
Referenced by FSIChannelWithLeafletProblem< ELEMENT >::actions_before_implicit_timestep(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::build_mesh(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::doc_solution(), and TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem().
Vector<double> Global_Parameters::grad_blend | ( | const Vector< double > & | x, |
const Vector< double > & | x_c | ||
) |
Gradient of blend function, centred at x_c.
References BiharmonicTestFunctions2::Pi, UniformPSDSelfTest::r, R_blend_inner, R_blend_outer, sin(), sqrt(), and plotDoE::x.
Referenced by blended_grad_velocity_pseudo_singularity_for_couette().
Function that computes the gradient of the fitting pressure solution near the corner (0,0)
References BiharmonicTestFunctions2::Pi, sqrt(), plotDoE::x, and y.
Vector<Vector<double> > Global_Parameters::grad_velocity_pseudo_singularity_for_couette | ( | const Vector< double > & | x | ) |
Pseudo_singularity for computation of Couette flow: grad[i][j] = du_i/dx_j.
References k, and plotDoE::x.
Referenced by blended_grad_velocity_pseudo_singularity_for_couette().
Vector<Vector<double> > Global_Parameters::grad_velocity_singularity1 | ( | const Vector< double > & | coord | ) |
Function that computes the gradient of the fitting velocity solution near the corner (0,0): grad[i][j] = du_i/dx_j
References atan2(), k, BiharmonicTestFunctions2::Pi, Eigen::bfloat16_impl::pow(), sqrt(), plotDoE::x, and y.
Vector<Vector<double> > Global_Parameters::grad_velocity_singularity2 | ( | const Vector< double > & | coord | ) |
Function that computes the gradient of the fitting velocity solution near the corner (1,0): grad[i][j] = du_i/dx_j
References atan2(), k, BiharmonicTestFunctions2::Pi, Eigen::bfloat16_impl::pow(), sqrt(), plotDoE::x, and y.
void Global_Parameters::gravity | ( | const double & | time, |
const Vector< double > & | xi, | ||
Vector< double > & | b | ||
) |
Non-dimensional gravity as body force.
Referenced by TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::build_mesh(), and TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem().
void Global_Parameters::Hankel_first | ( | const unsigned & | n, |
const double & | x, | ||
Vector< std::complex< double > > & | h, | ||
Vector< std::complex< double > > & | hp | ||
) |
Compute Hankel function of the first kind of orders 0...n and its derivates at coordinate x. The function returns the vector then its derivative.
References CRBond_Bessel::bessjyna(), i, n, OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, and plotDoE::x.
Referenced by exact_axisym_radiated_power(), exact_u(), and HankelH1().
Interface to Hankel function in maple style.
References assert, Hankel_first(), k, and plotDoE::x.
Referenced by axisym_coefficient(), and exact_axisym_potential().
const std::complex< double > Global_Parameters::I | ( | 0. | 0, |
1. | 0 | ||
) |
Define the imaginary unit.
Boolean to identify if node is on fsi boundary.
References oomph::Node::x().
Referenced by FluidTriangleMesh< ELEMENT >::FluidTriangleMesh(), MySolidTriangleMesh< ELEMENT >::MySolidTriangleMesh(), and oomph::ThinLayerBrickOnTetMesh< ELEMENT >::ThinLayerBrickOnTetMesh().
std::complex<double> Global_Parameters::Nu | ( | 0. | 3, |
0. | 05 | ||
) |
Define Poisson's ratio Nu.
std::complex<double> Global_Parameters::Omega_sq | ( | 10. | 0, |
0. | 0 | ||
) |
Define the non-dimensional square angular frequency of time-harmonic motion
std::complex<double> Global_Parameters::Omega_sq | ( | 10. | 0, |
5. | 0 | ||
) |
Define the non-dimensional square angular frequency of time-harmonic motion
Square of non-dim frequency for the two regions – dependent variable!
Non-dim square of frequency for solid – dependent variable!
Non-dim square of frequency for solid – dependent variable!
void Global_Parameters::periodic_traction | ( | const double & | time, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | result | ||
) |
The traction function.
References Amplitude, cos(), Lx, BiharmonicTestFunctions2::Pi, sin(), and plotDoE::x.
Referenced by RefineablePeriodicLoadProblem< ELEMENT >::assign_traction_elements(), and PeriodicLoadProblem< ELEMENT >::PeriodicLoadProblem().
void Global_Parameters::prescribed_inflow_traction | ( | const double & | t, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | traction | ||
) |
Applied traction on fluid at the inflow boundary.
References P_in.
Referenced by UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_fluid_traction_elements(), and UnstructuredFluidProblem< ELEMENT >::create_fluid_traction_elements().
void Global_Parameters::prescribed_outflow_traction | ( | const double & | t, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | traction | ||
) |
Applied traction on fluid at the inflow boundary.
References P_out.
Referenced by UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_fluid_traction_elements(), and UnstructuredFluidProblem< ELEMENT >::create_fluid_traction_elements().
void Global_Parameters::press_load | ( | const Vector< double > & | xi, |
const Vector< double > & | x, | ||
const Vector< double > & | N, | ||
Vector< double > & | load | ||
) |
Load function for wall.
References atan2(), cos(), i, load(), N, Global_Physical_Variables::P, and Pcos.
Referenced by PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_solid_traction_elements().
Couette Pressure.
References A_couette, B_couette, Eigen::bfloat16_impl::log(), UniformPSDSelfTest::r, Global_Physical_Variables::Re, sqrt(), and plotDoE::x.
Referenced by exact_couette().
void Global_Parameters::pressure_load | ( | const Vector< double > & | x, |
const Vector< double > & | n, | ||
Vector< std::complex< double > > & | traction | ||
) |
Pressure load (real and imag part)
Constant pressure load (real and imag part)
References TanhSolnForAdvectionDiffusion::Alpha, atan2(), Eigen::bfloat16_impl::exp(), i, oomph::VectorHelpers::magnitude(), n, P, BiharmonicTestFunctions2::Pi, Eigen::bfloat16_impl::pow(), and plotDoE::x.
Referenced by CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::create_solid_traction_elements(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::create_solid_traction_elements(), and RingWithTRibProblem< ELASTICITY_ELEMENT >::create_traction_elements().
Pseudo_singularity for computation of Couette flow.
References plotDoE::x.
Referenced by blended_pressure_pseudo_singularity_for_couette().
Function that computes the fitting pressure solution near the corner (0,0)
References atan2(), cos(), isinf, p, BiharmonicTestFunctions2::Pi, UniformPSDSelfTest::r, sin(), sqrt(), BiharmonicTestFunctions2::theta, and plotDoE::x.
Function that computes the fitting pressure solution near the corner (1,0)
Polar coordinates centered at the point (1,0)
References atan2(), cos(), isinf, p, BiharmonicTestFunctions2::Pi, UniformPSDSelfTest::r, sin(), sqrt(), BiharmonicTestFunctions2::theta, plotDoE::x, and Global_parameters::x1().
void Global_Parameters::set_parameters | ( | const string & | case_id | ) |
Set parameters for the various test cases.
References Case_ID, Constitutive_law_pt, ProblemParameters::Density_ratio, ProblemParameters::Dt, Global_Physical_Variables::E, Ignore_fluid_loading, Global_Physical_Variables::Lambda_sq, Max_flux, Constitutive_Parameters::Nu, oomph::oomph_info, Q, Ramp_period, GlobalPhysicalVariables::Re, GlobalPhysicalVariables::ReSt, and St.
Referenced by main().
void Global_Parameters::solid_boundary_displacement | ( | const Vector< double > & | x, |
Vector< double > & | u | ||
) |
Real-valued, radial displacement field on inner boundary.
References Displacement_amplitude, WallFunction::normal(), sqrt(), and plotDoE::x.
void Global_Parameters::solid_boundary_displacement | ( | const Vector< double > & | x, |
Vector< std::complex< double > > & | u | ||
) |
Displacement field on inner boundary of solid.
References atan2(), cos(), N, WallFunction::normal(), sqrt(), and plotDoE::x.
Referenced by AnnularDiskProblem< ELASTICITY_ELEMENT >::AnnularDiskProblem(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedDiskProblem(), and CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedSphereProblem().
Calculate the time dependent form of the r-component of displacement.
References cos(), exact_solution_th(), and plotDoE::x.
Referenced by exact_solution(), oomph::AxisymmetricPoroelasticityEquations::fill_in_generic_residual_contribution(), oomph::RefineableSphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::SphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::MinModLimiter::limit(), oomph::SphericalNavierStokesEquations::output(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_boundary_conditions(), and AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_initial_conditions().
Calculate the time dependent form of the theta-component of displacement.
References cos(), exact_solution_th(), and plotDoE::x.
Referenced by Global::exact_solution(), exact_solution(), oomph::RefineableSphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::SphericalNavierStokesEquations::fill_in_generic_residual_contribution_spherical_nst(), oomph::SphericalNavierStokesEquations::output(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_boundary_conditions(), and AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_initial_conditions().
Calculate the time dependent form of the z-component of displacement.
References cos(), exact_solution_th(), and plotDoE::x.
Referenced by exact_solution(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_boundary_conditions(), and AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::set_initial_conditions().
void Global_Parameters::update_parameter_values | ( | ) |
Function to update dependent parameter values.
References Density_ratio, Omega_sq, and Q.
Referenced by main().
Couette flow.
References A_couette, atan2(), B_couette, cos(), oomph::VectorHelpers::magnitude(), UniformPSDSelfTest::r, sin(), sqrt(), BiharmonicTestFunctions2::theta, and plotDoE::x.
Referenced by exact_couette().
Vector<double> Global_Parameters::velocity_pseudo_singularity_for_couette | ( | const Vector< double > & | x | ) |
Pseudo_singularity for computation of Couette flow.
References plotDoE::x.
Referenced by blended_grad_velocity_pseudo_singularity_for_couette(), and blended_velocity_pseudo_singularity_for_couette().
Function that computes the fitting velocity solution near the corner (0,0)
References atan2(), cos(), BiharmonicTestFunctions2::Pi, sin(), BiharmonicTestFunctions2::theta, and plotDoE::x.
Function that computes the fitting velocity solution near the corner (1,0)
Polar coordinates centered at the point (1,0)
Value of the U component at the angle theta
Value of the V component at the angle theta
References atan2(), cos(), BiharmonicTestFunctions2::Pi, sin(), BiharmonicTestFunctions2::theta, plotDoE::x, and Global_parameters::x1().
double Global_Parameters::A_couette =1.0 |
Amplitude of linearly varying part.
Referenced by pressure_couette(), and velocity_couette().
unsigned Global_Parameters::ABC_order =3 |
Order of absorbing/appproximate boundary condition.
Referenced by CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::create_helmholtz_ABC_elements().
unsigned Global_Parameters::Add_refinement_level =1 |
The additional levels of uniform refinement.
Referenced by main().
double Global_Parameters::Alpha =0.0 |
Peakiness parameter for pressure load.
Referenced by main(), and FlowAroundCylinderProblem< ELEMENT >::set_boundary_conditions().
double Global_Parameters::Amplitude = 1.0 |
Amplitude of traction applied.
Referenced by exact_solution(), and periodic_traction().
double Global_Parameters::B =0.7 |
Referenced by GeneralEllipse::b(), and main().
double Global_Parameters::B_couette =1.0 |
Amplitude of singular part.
Referenced by pressure_couette(), and velocity_couette().
double Global_Parameters::Box_half_length = 1.0 |
(Half)height of the box
Referenced by TetmeshPoissonProblem< ELEMENT >::TetmeshPoissonProblem().
double Global_Parameters::Box_half_width = 1.5 |
(Half-)width of the box
Referenced by TetmeshPoissonProblem< ELEMENT >::TetmeshPoissonProblem().
double Global_Parameters::Box_length = 10.0 |
double Global_Parameters::Box_width = 3.0 |
double Global_Parameters::Ca = 1.0 |
Set the Capillary number.
Referenced by RisingBubbleProblem< ELEMENT >::create_free_surface_elements(), and RisingBubbleProblem< ELEMENT >::RisingBubbleProblem().
string Global_Parameters::Case_ID ="FSI1" |
Default case ID.
Referenced by main(), and set_parameters().
double Global_Parameters::Centre_x =2.0 |
x position of centre of cylinder
Referenced by TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::build_mesh(), GeneralEllipse::centre_x(), RectangleWithHoleDomain::centre_x(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_IV(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_V(), FilledCircle::position(), GeneralCircle::position(), GeneralEllipse::position(), RectangleWithHoleDomain::RectangleWithHoleDomain(), and TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem().
double Global_Parameters::Centre_y =2.0 |
y position of centre of cylinder
Referenced by TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::build_mesh(), GeneralEllipse::centre_y(), RectangleWithHoleDomain::centre_y(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_IV(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_V(), FilledCircle::position(), GeneralCircle::position(), GeneralEllipse::position(), RectangleWithHoleDomain::RectangleWithHoleDomain(), and TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem().
ConstitutiveLaw * Global_Parameters::Constitutive_law_pseudo_elastic_pt =0 |
Pointer to constitutive law for the pseudo elastic node update elements.
Referenced by main(), and PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PseudoElasticCollapsibleChannelProblem().
ConstitutiveLaw * Global_Parameters::Constitutive_law_pt =0 |
Pointer to constitutive law.
Create constitutive law.
Constitutive law used to determine the mesh deformation.
Constitutive law for the solid (and pseudo-solid) mechanics.
Referenced by RisingBubbleProblem< ELEMENT >::actions_after_adapt(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::build_mesh(), main(), RisingBubbleProblem< ELEMENT >::RisingBubbleProblem(), set_parameters(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem(), UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::UnstructuredFSIProblem(), and TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::~TurekProblem().
ConstitutiveLaw * Global_Parameters::Constitutive_law_wall_pt =0 |
Pointer to constitutive law for the wall.
Referenced by main(), and PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PseudoElasticCollapsibleChannelProblem().
double Global_Parameters::Density_ratio =0.0 |
Density ratio: solid to fluid.
Density ratio for the two regions: solid to fluid.
Density ratio (solid to fluid; default assignment for FSI1 test case)
Referenced by CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), main(), and update_parameter_values().
unsigned Global_Parameters::Direction = 1 |
string Global_Parameters::Directory ="RESLT" |
Output directory.
Referenced by AnnularDiskProblem< ELASTICITY_ELEMENT >::AnnularDiskProblem(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedDiskProblem(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedSphereProblem(), ElasticAnnulusProblem< ELASTICITY_ELEMENT >::ElasticAnnulusProblem(), main(), and RingWithTRibProblem< ELASTICITY_ELEMENT >::RingWithTRibProblem().
double Global_Parameters::Displacement_amplitude =0.1 |
Displacement amplitude on inner radius.
Referenced by solid_boundary_displacement().
unsigned Global_Parameters::Doc_convergence_flag =0 |
Variable used to decide whether or not convergence information is displayed: 0 = Don't display convergence information 1 = Display convergence information
Referenced by main().
DocInfo Global_Parameters::Doc_info |
DocInfo object used for documentation of the solution.
Referenced by FluxPoissonMGProblem< ELEMENT, MESH >::doc_solution(), UnitCubePoissonMGProblem< ELEMENT, MESH >::doc_solution(), and main().
double Global_Parameters::Dt =0.01 |
Timestep.
Timestep for simulation: 40 steps per period.
Referenced by main(), and PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::unsteady_run().
TimeHarmonicIsotropicElasticityTensor Global_Parameters::E = 1.0 |
Define the non-dimensional Young's modulus.
The elasticity tensor.
Elastic modulus.
The elasticity tensor for the solid.
Referenced by AnnularDiskProblem< ELASTICITY_ELEMENT >::AnnularDiskProblem(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::AxisymmetricLinearElasticityProblem(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedDiskProblem(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::complete_problem_setup(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::complete_problem_setup(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::FourierDecomposedTimeHarmonicLinearElasticityProblem(), main(), PeriodicLoadProblem< ELEMENT >::PeriodicLoadProblem(), and RefineablePeriodicLoadProblem< ELEMENT >::RefineablePeriodicLoadProblem().
Vector< TimeHarmonicIsotropicElasticityTensor * > Global_Parameters::E_pt |
The elasticity tensors for the two regions.
The elasticity tensor.
Referenced by Problem_Parameter::bulk_elasticity_tensor_pt(), oomph::HomogenisedLinearElasticityEquations< DIM >::calculate_effective_modulus(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::complete_problem_setup(), ElasticAnnulusProblem< ELASTICITY_ELEMENT >::complete_problem_setup(), RingWithTRibProblem< ELASTICITY_ELEMENT >::complete_problem_setup(), Problem_Parameter::fibre_elasticity_tensor_pt(), oomph::HomogenisedLinearElasticityEquations< DIM >::fill_in_generic_contribution_to_residuals_linear_elasticity(), oomph::HomogenisedLinearElasticityEquationsBase::get_E_pt(), main(), and RingWithTRibProblem< ELASTICITY_ELEMENT >::RingWithTRibProblem().
unsigned Global_Parameters::El_multiplier =1 |
Multiplier for number of elements.
Referenced by CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedDiskProblem(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedSphereProblem(), and main().
double Global_Parameters::Element_area = 0.01 |
helper to set target mesh element size
Referenced by ElasticAnnulusProblem< ELASTICITY_ELEMENT >::ElasticAnnulusProblem(), and main().
bool Global_Parameters::Finite =false |
Specify problem to be solved (boundary conditons for finite or infinite domain).
Referenced by PeriodicLoadProblem< ELEMENT >::PeriodicLoadProblem(), and RefineablePeriodicLoadProblem< ELEMENT >::RefineablePeriodicLoadProblem().
double Global_Parameters::Fluid_height =1.0 |
height of fluid mesh
Referenced by FSIChannelWithLeafletProblem< ELEMENT >::actions_before_implicit_timestep(), and FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem().
double Global_Parameters::Fluid_length_left =1.0 |
length of fluid mesh to left of leaflet
Referenced by FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem().
double Global_Parameters::Fluid_length_right =3.0 |
length of fluid mesh to right of leaflet
Referenced by FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem().
int Global_Parameters::Fourier_wavenumber =0 |
Define azimuthal Fourier wavenumber.
Define Fourier wavenumber.
Referenced by boundary_traction(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedSphereProblem(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::complete_problem_setup(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::complete_problem_setup(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), and FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::FourierDecomposedTimeHarmonicLinearElasticityProblem().
std::string Global_Parameters::Gmsh_command_line_invocation ="/home/mheil/gmesh/bin/bin/gmsh" |
Specify how to call gmsh from the command line.
Referenced by main(), and TetmeshPoissonProblem< ELEMENT >::TetmeshPoissonProblem().
double Global_Parameters::Gravity =0.0 |
Non-dim gravity (default assignment for FSI1 test case)
Non-dim gravity.
Referenced by Global_Physical_Variables::body_force(), gravity(), and main().
double Global_Parameters::H =0.15 |
wall thickness
Height of flag.
Non-dimensional wall thickness.
Referenced by TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::build_mesh(), FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem(), PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PseudoElasticCollapsibleChannelProblem(), and TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem().
double Global_Parameters::H_annulus =0.5 |
Thickness of annulus.
Referenced by AnnularDiskProblem< ELASTICITY_ELEMENT >::AnnularDiskProblem(), and RingWithTRibProblem< ELASTICITY_ELEMENT >::RingWithTRibProblem().
double Global_Parameters::H_coating =0.3 |
Non-dim thickness of elastic coating.
Referenced by axisym_coefficient(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedDiskProblem(), and CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedSphereProblem().
bool Global_Parameters::Ignore_fluid_loading =false |
Ignore fluid (default assignment for FSI1 test case)
Referenced by TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_after_adapt(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_after_distribute(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::generic_actions_after(), set_parameters(), and TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem().
unsigned Global_Parameters::Impulsive_start_flag =0 |
Flag for impulsive start: Default = start from exact time-periodic solution.
Referenced by main(), RayleighProblem< ELEMENT, TIMESTEPPER >::unsteady_run(), and RayleighTractionProblem< ELEMENT, TIMESTEPPER >::unsteady_run().
double Global_Parameters::Initial_element_volume =1.0 |
double Global_Parameters::K_squared =10.0 |
Square of wavenumber for the Helmholtz equation.
Referenced by axisym_coefficient(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedDiskProblem(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedSphereProblem(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::complete_problem_setup(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), exact_axisym_potential(), exact_axisym_radiated_power(), and main().
double Global_Parameters::L =12.0 |
double Global_Parameters::L_pml_multiplier = 1.0 |
Referenced by compute_dependent_parameters(), and main().
Lame parameters.
Referenced by body_force(), boundary_traction(), QCrouzeixRaviartElementWithTwoExternalElement< DIM >::Default_Physical_Constant_Value(), oomph::deriv_functions::SimpleStiffTest::derivative(), oomph::deriv_functions::OrderReductionTest::derivative(), oomph::deriv_functions::SimpleStiffTest::operator()(), oomph::deriv_functions::OrderReductionTest::OrderReductionTest(), and oomph::deriv_functions::SimpleStiffTest::SimpleStiffTest().
Referenced by boundary_traction().
double Global_Parameters::Lambda_sq =0.0 |
Timescale ratio (non-dim density) for solid.
Pseudo-solid mass density.
Timescale ratio for solid (dependent parameter assigned in set_parameters())
Referenced by TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::build_mesh(), FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem(), PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PseudoElasticCollapsibleChannelProblem(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem(), and UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::UnstructuredFSIProblem().
double Global_Parameters::Lambda_sq_beam =0.0 |
Beam mass density.
Referenced by FSIChannelWithLeafletProblem< ELEMENT >::doc_parameters(), and FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem().
double Global_Parameters::Ldown =3.0 |
downstream length
Referenced by PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_after_adapt(), CollapsibleChannelProblem< ELEMENT >::CollapsibleChannelProblem(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PseudoElasticCollapsibleChannelProblem(), and CollapsibleChannelProblem< ELEMENT >::unsteady_run().
double Global_Parameters::Leaflet_height =0.5 |
height of leaflet
Referenced by FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem().
double Global_Parameters::Leaflet_x0 = 1.0 |
x-position of root of leaflet
Referenced by FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem().
unsigned Global_Parameters::Linear_solver_flag =1 |
The choice of linear solver 0 = SuperLU 1 = Multigrid
Referenced by main(), and UnitCubePoissonMGProblem< ELEMENT, MESH >::~UnitCubePoissonMGProblem().
unsigned Global_Parameters::Long_run_flag =1 |
Flag for long/short run: Default = perform long run.
Referenced by main(), RayleighProblem< ELEMENT, TIMESTEPPER >::unsteady_run(), and RayleighTractionProblem< ELEMENT, TIMESTEPPER >::unsteady_run().
double Global_Parameters::Lr = 1.0 |
Length of domain in r direction.
Referenced by InterfaceProblem< ELEMENT, TIMESTEPPER >::deform_free_surface(), InterfaceProblem< ELEMENT, TIMESTEPPER >::InterfaceProblem(), and main().
double Global_Parameters::Lup =1.5 |
upstream length
Referenced by PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_after_adapt(), CollapsibleChannelProblem< ELEMENT >::CollapsibleChannelProblem(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PseudoElasticCollapsibleChannelProblem(), and CollapsibleChannelProblem< ELEMENT >::unsteady_run().
double Global_Parameters::Lx = 1.0 |
Length of domain in x direction.
Referenced by ChannelSpineFlowProblem< ELEMENT >::ChannelSpineFlowProblem(), InterfaceProblem< ELEMENT, TIMESTEPPER >::deform_free_surface(), exact_solution(), Eigen::SimplicialCholeskyBase< Derived >::factorize_preordered(), FSIDrivenCavityProblem< ELEMENT >::FSIDrivenCavityProblem(), LinearWaveProblem< ELEMENT, TIMESTEPPER >::LinearWaveProblem(), main(), periodic_traction(), oomph::SimpleRectangularQuadMesh< ELEMENT >::SimpleRectangularQuadMesh(), TwoDDGMesh< ELEMENT >::TwoDDGMesh(), Eigen::umfpack_get_numeric(), and ElasticInterfaceProblem< ELEMENT, TIMESTEPPER >::unsteady_run().
double Global_Parameters::Ly = 2.0 |
Length of domain in y direction.
Referenced by SpikedChannelSpineFlowProblem< ELEMENT >::actions_before_newton_solve(), ChannelSpineFlowProblem< ELEMENT >::ChannelSpineFlowProblem(), CollapsibleChannelProblem< ELEMENT >::CollapsibleChannelProblem(), doc_sparse_node_update(), exact_solution(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), FSIDrivenCavityProblem< ELEMENT >::FSIDrivenCavityProblem(), LinearWaveProblem< ELEMENT, TIMESTEPPER >::LinearWaveProblem(), main(), FSICollapsibleChannelProblem< ELEMENT >::set_initial_condition(), CollapsibleChannelProblem< ELEMENT >::set_initial_condition(), CollapsibleChannelProblem< ELEMENT >::set_poiseuille_outflow(), oomph::SimpleRectangularQuadMesh< ELEMENT >::SimpleRectangularQuadMesh(), SpikedChannelSpineFlowProblem< ELEMENT >::SpikedChannelSpineFlowProblem(), TwoDDGMesh< ELEMENT >::TwoDDGMesh(), and ElasticInterfaceProblem< ELEMENT, TIMESTEPPER >::unsteady_run().
double Global_Parameters::Lz = 2.0 |
Length of domain in z-direction.
Referenced by SinusoidalWall::d2position(), SinusoidalWall::dposition(), main(), and SinusoidalWall::position().
unsigned Global_Parameters::M =4 |
Wavenumber "zenith"-variation of imposed displacement of coating on inner boundary
Referenced by main().
double Global_Parameters::Max_flux =1.0 |
Max. flux.
Referenced by set_parameters().
unsigned Global_Parameters::Mesh_nleft =4 |
Num elements to left of leaflet in coarse mesh.
Referenced by FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem().
unsigned Global_Parameters::Mesh_nright =12 |
Num elements to right of leaflet in coarse mesh.
Referenced by FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem().
unsigned Global_Parameters::Mesh_ny1 =2 |
Num elements in fluid mesh in y dirn adjacent to leaflet.
Referenced by FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem().
unsigned Global_Parameters::Mesh_ny2 =2 |
Num elements in fluid mesh in y dirn above leaflet.
Referenced by FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem().
double Global_Parameters::Min_flux =0.0 |
Min. flux.
unsigned Global_Parameters::Min_refinement_level =2 |
The minimum level of uniform refinement.
Referenced by main().
Referenced by body_force(), boundary_traction(), and SilbertPeriodic::set_study().
Referenced by PolarNSProblem< ELEMENT >::actions_before_solve(), boundary_traction(), Eigen::internal::MatrixFunctionAtomic< MatrixType >::compute(), exact_u(), Eigen::internal::fdjac1(), oomph::AxisymmetricLinearElasticityEquations::fill_in_generic_contribution_to_residuals_axisymmetric_linear_elasticity(), oomph::TimeHarmonicFourierDecomposedLinearElasticityEquations::fill_in_generic_contribution_to_residuals_fourier_decomp_time_harmonic_linear_elasticity(), GelfandBratuElement< NNODE_1D >::fill_in_generic_dresidual_contribution(), oomph::AxisymmetricPoroelasticityEquations::fill_in_generic_residual_contribution(), PredatorPreyElement::fill_in_generic_residual_contribution(), GelfandBratuElement< NNODE_1D >::fill_in_generic_residual_contribution(), oomph::IsotropicElasticityTensor::IsotropicElasticityTensor(), particleParticleTest(), oomph::PMLTimeHarmonicIsotropicElasticityTensor::PMLTimeHarmonicIsotropicElasticityTensor(), Eigen::BDCSVD< MatrixType_, Options_ >::secularEq(), oomph::IsotropicElasticityTensor::set_lame_coefficients(), oomph::PMLTimeHarmonicIsotropicElasticityTensor::set_lame_coefficients(), oomph::TimeHarmonicIsotropicElasticityTensor::set_lame_coefficients(), SilbertPeriodic::set_study(), my_problem::set_WallFriction(), Binary::setWallFriction(), SilbertPeriodic::SilbertPeriodic(), oomph::TimeHarmonicIsotropicElasticityTensor::TimeHarmonicIsotropicElasticityTensor(), Eigen::internal::tridiagonal_qr_step(), oomph::IsotropicElasticityTensor::update_constitutive_parameters(), oomph::PMLTimeHarmonicIsotropicElasticityTensor::update_constitutive_parameters(), oomph::TimeHarmonicIsotropicElasticityTensor::update_constitutive_parameters(), and wallParticleTest().
unsigned Global_Parameters::N =0 |
Azimuthal wavenumber for imposed displacement of coating on inner boundary
Referenced by main().
unsigned Global_Parameters::N_adaptations =1 |
The number of adaptations allowed by the Newton solver.
Referenced by main().
unsigned Global_Parameters::N_pml_multiplier = 1 |
PML width in elements for the right layer.
Referenced by compute_dependent_parameters(), and main().
unsigned Global_Parameters::N_slice =4 |
number of axial slices in fluid mesh
Referenced by PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PseudoElasticCollapsibleChannelProblem().
unsigned Global_Parameters::N_x =10 |
unsigned Global_Parameters::N_x_left_pml = 8 |
PML width in elements for the left layer.
Referenced by compute_dependent_parameters(), ElasticAnnulusProblem< ELASTICITY_ELEMENT >::create_pml_meshes(), and main().
unsigned Global_Parameters::N_x_right_pml = 8 |
PML width in elements for the right layer.
Referenced by compute_dependent_parameters(), ElasticAnnulusProblem< ELASTICITY_ELEMENT >::create_pml_meshes(), and main().
unsigned Global_Parameters::N_y =10 |
unsigned Global_Parameters::N_y_bottom_pml = 8 |
PML width in elements for the left layer.
Referenced by compute_dependent_parameters(), ElasticAnnulusProblem< ELASTICITY_ELEMENT >::create_pml_meshes(), and main().
unsigned Global_Parameters::N_y_top_pml = 8 |
PML width in elements for the top layer.
Referenced by compute_dependent_parameters(), ElasticAnnulusProblem< ELASTICITY_ELEMENT >::create_pml_meshes(), and main().
unsigned Global_Parameters::Nnode_1d =2 |
The number of nodes in one direction (default=2)
Referenced by main().
unsigned Global_Parameters::Nperiod =5 |
Number of periods.
Referenced by PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::unsteady_run().
unsigned Global_Parameters::Nr = 5 |
Number of elements in r-direction.
Number of elements in radial direction.
Referenced by AnnularDiskProblem< ELASTICITY_ELEMENT >::AnnularDiskProblem(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::AxisymmetricLinearElasticityProblem(), CapProblem< ELEMENT >::CapProblem(), main(), and SphericalSteadyRotationProblem< ELEMENT >::parameter_study().
unsigned Global_Parameters::Nstep_per_period =40 |
Number of steps per period.
Referenced by main(), and PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::unsteady_run().
unsigned Global_Parameters::Ntheta =20 |
Number of elements in azimuthal direction.
Referenced by AnnularDiskProblem< ELASTICITY_ELEMENT >::AnnularDiskProblem(), main(), and SphericalSteadyRotationProblem< ELEMENT >::parameter_study().
double Global_Parameters::Nu = 0.3 |
Define Poisson's ratio Nu.
Poisson's ratio Nu.
Define Poisson coefficient Nu.
Poisson's ratio for generalised Hookean constitutive equation.
Pseudo-solid Poisson ratio.
Poisson's ratio.
Referenced by AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::AxisymmetricLinearElasticityProblem(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedSphereProblem(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::complete_problem_setup(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::complete_problem_setup(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::FourierDecomposedTimeHarmonicLinearElasticityProblem(), FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem(), main(), and RingWithTRibProblem< ELASTICITY_ELEMENT >::RingWithTRibProblem().
double Global_Parameters::Nu_pseudo_elastic =0.1 |
Poisson's ratio for generalised Hookean constitutive equation for the pseudo elastic bulk
Referenced by main().
double Global_Parameters::Nu_wall =0.3 |
Poisson's ratio for generalised Hookean constitutive equation for the wall
Referenced by main().
unsigned Global_Parameters::Nz = 10 |
Number of elements in z-direction.
Referenced by Vreman::add_particles(), NautaMixer::addParticlesAtWall(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::AxisymmetricLinearElasticityProblem(), oomph::ExtrudedCubeMeshFromQuadMesh< ELEMENT >::build_mesh(), oomph::SimpleCubicMesh< ELEMENT >::build_mesh(), MyCanyonMesh< ELEMENT, INTERFACE_ELEMENT >::build_single_layer_mesh(), MyTipMesh< ELEMENT, INTERFACE_ELEMENT >::build_single_layer_mesh(), oomph::SingleLayerCubicSpineMesh< ELEMENT >::build_single_layer_mesh(), and CoilSelfTest::setupInitialConditions().
double Global_Parameters::Omega_sq = 0.5 |
Square of the frequency of the time dependence.
Square of non-dim frequency.
Square of non-dim frequency for the two regions – dependent variable!
Non-dim square of frequency for solid – dependent variable!
Define the non-dimensional square angular frequency of time-harmonic motion
Referenced by AnnularDiskProblem< ELASTICITY_ELEMENT >::AnnularDiskProblem(), AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::AxisymmetricLinearElasticityProblem(), body_force(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedDiskProblem(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedSphereProblem(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::complete_problem_setup(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::complete_problem_setup(), ElasticAnnulusProblem< ELASTICITY_ELEMENT >::complete_problem_setup(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::complete_problem_setup(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), exact_u(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::FourierDecomposedTimeHarmonicLinearElasticityProblem(), main(), and update_parameter_values().
Square of non-dim frequency for the two regions.
Referenced by RingWithTRibProblem< ELASTICITY_ELEMENT >::complete_problem_setup(), and main().
double Global_Parameters::Outer_radius =4.0 |
Radius of outer boundary of Helmholtz domain.
Referenced by CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedDiskProblem(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedSphereProblem(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::create_helmholtz_ABC_elements(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), and main().
unsigned Global_Parameters::Output_management_flag =0 |
The MG solver allows for five different levels of output: 0 = Outputs everything 1 = Outputs everything and plots refinement and unrefinement patterns 2 = Outputs everything except the smoother timings 3 = Outputs setup information but no V-cycle timings 4 = Suppresses all output Note: choosing '1' will also keep the coarser problems alive
Referenced by main().
double Global_Parameters::P = 0.1 |
Uniform pressure.
Uniform pressure acting on wall.
Referenced by PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::doc_parameters(), main(), pressure_load(), and PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::steady_run().
double Global_Parameters::P_in =0.0 |
Fluid pressure on inflow boundary.
Referenced by UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep(), UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_parallel_flow_lagrange_elements(), UnstructuredFluidProblem< ELEMENT >::create_parallel_outflow_lagrange_elements(), and prescribed_inflow_traction().
Data* Global_Parameters::P_in_data_pt =0 |
Pointer to Data object whose one and only value stores the upstream pressure used to enforce flow rate
Referenced by UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_parallel_flow_lagrange_elements().
double Global_Parameters::P_in_max =0.0025 |
Max. inflow pressure (during periodic variation)
Referenced by UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep().
double Global_Parameters::P_out =-0.25 |
Fluid pressure on outflow boundary.
Referenced by UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_parallel_flow_lagrange_elements(), UnstructuredFluidProblem< ELEMENT >::create_parallel_outflow_lagrange_elements(), and prescribed_outflow_traction().
double Global_Parameters::Pcos = 2.0e-4 |
Perturbation pressure.
Referenced by PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::doc_parameters(), and press_load().
Peclet number.
Referenced by RefineableBuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::RefineableBuoyantQAxisymCrouzeixRaviartElement::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::RefineableBuoyantQSphericalCrouzeixRaviartElement::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), FlowAroundHalfCylinderProblem< ELEMENT >::FlowAroundHalfCylinderProblem(), and main().
double Global_Parameters::Peak_prescribed_flow_rate =-1.0 |
Peak prescribed flow rate.
Referenced by UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep().
double Global_Parameters::Period =0.1 |
Period of periodic variation in inflow pressure.
Referenced by UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep(), UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::doc_parameters(), and main().
unsigned Global_Parameters::Post_smoother_flag =0 |
The choice of post-smoother: 0 = Damped Jacobi 1 = Gauss-Seidel
Referenced by main().
unsigned Global_Parameters::Pre_smoother_flag =0 |
The choice of pre-smoother: 0 = Damped Jacobi 1 = Gauss-Seidel
Referenced by main().
bool Global_Parameters::Prescribe_pressure =false |
Boolean to choose if inflow pressure (true) or volume flux are prescribed.
Referenced by UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep(), UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_parallel_flow_lagrange_elements(), and UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::UnstructuredFSIProblem().
double Global_Parameters::Prescribed_flow_rate =Peak_prescribed_flow_rate |
double Global_Parameters::Q =0.0 |
FSI parameter.
FSI parameter (default assignment for FSI1 test case)
Default FSI parameter.
Fluid structure interaction parameter: Ratio of stresses used for non-dimensionalisation of fluid to solid stresses.
Referenced by TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_after_distribute(), axisym_coefficient(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::build_mesh(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::create_fsi_traction_elements(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::create_fsi_traction_elements(), PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_fsi_traction_elements(), UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::create_fsi_traction_elements(), PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::doc_parameters(), FSIChannelWithLeafletProblem< ELEMENT >::doc_parameters(), UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::doc_parameters(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::generic_actions_after(), main(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem(), and update_parameter_values().
double Global_Parameters::R_blend_inner =0.2 |
Inner blending radius.
Referenced by blend(), and grad_blend().
double Global_Parameters::R_blend_outer =0.8 |
Outer blending radius.
Referenced by blend(), and grad_blend().
double Global_Parameters::Ra = 0.0 |
Rayleigh number.
Referenced by RefineableBuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::RefineableBuoyantQAxisymCrouzeixRaviartElement::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::RefineableBuoyantQSphericalCrouzeixRaviartElement::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::BuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), oomph::RefineableBuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic(), FlowAroundHalfCylinderProblem< ELEMENT >::FlowAroundHalfCylinderProblem(), and main().
double Global_Parameters::Radius =0.5 |
Radius of cylinder.
Set bubble radius.
Referenced by TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::build_mesh(), RisingBubbleProblem< ELEMENT >::RisingBubbleProblem(), RisingBubbleProblem< ELEMENT >::snap_onto_sphere(), and TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem().
double Global_Parameters::Ramp_period =2.0 |
Period for ramping up in flux.
Referenced by set_parameters().
double Global_Parameters::Re =75.0 |
reynolds number
Default Reynolds number.
Reynolds number (default assignment for FSI1 test case)
Reynolds number.
Referenced by FallingBlockProblem< ELEMENT >::actions_after_adapt(), RisingBubbleProblem< ELEMENT >::actions_after_adapt(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::build_mesh(), PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::doc_parameters(), FSIChannelWithLeafletProblem< ELEMENT >::doc_parameters(), UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::doc_parameters(), FallingBlockProblem< ELEMENT >::FallingBlockProblem(), FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), FlowAroundHalfCylinderProblem< ELEMENT >::FlowAroundHalfCylinderProblem(), FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem(), main(), PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::PseudoElasticCollapsibleChannelProblem(), RayleighProblem< ELEMENT, TIMESTEPPER >::RayleighProblem(), RayleighTractionProblem< ELEMENT, TIMESTEPPER >::RayleighTractionProblem(), RisingBubbleProblem< ELEMENT >::RisingBubbleProblem(), TurekNonFSIProblem< ELEMENT >::TurekNonFSIProblem(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem(), and UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::UnstructuredFSIProblem().
bool Global_Parameters::Read_in_eigenfunction_from_disk = true |
Referenced by FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), and main().
double Global_Parameters::ReInvFr = 0.0 |
The Reynolds INverse Froude number.
Referenced by RisingBubbleProblem< ELEMENT >::actions_after_adapt(), main(), and RisingBubbleProblem< ELEMENT >::RisingBubbleProblem().
double Global_Parameters::ReSt =50.0 |
Womersley number: Product of Reynolds and Strouhal numbers.
Womersley = Reynolds times Strouhal.
Product of Reynolds and Strouhal numbers (default assignment for FSI1 test case)
Referenced by TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::build_mesh(), FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem(), ExactSoln::get_exact_u(), main(), ExactSoln::prescribed_traction(), RayleighProblem< ELEMENT, TIMESTEPPER >::RayleighProblem(), RayleighTractionProblem< ELEMENT, TIMESTEPPER >::RayleighTractionProblem(), and TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem().
Set up max r coordinate.
Referenced by AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::AxisymmetricLinearElasticityProblem().
Referenced by adjoint(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::FourierDecomposedTimeHarmonicLinearElasticityProblem(), oomph::QuarterPipeDomain::macro_element_boundary(), main(), oomph::QuarterPipeDomain::QuarterPipeDomain(), oomph::QuarterPipeMesh< ELEMENT >::QuarterPipeMesh(), oomph::QuarterPipeDomain::r_B(), oomph::QuarterPipeDomain::r_F(), oomph::QuarterPipeDomain::r_L(), oomph::QuarterPipeDomain::r_R(), oomph::QuarterPipeDomain::r_U(), and StressStrainControl::setupInitialConditions().
double Global_Parameters::Rmin = 0.1 |
Set up min r coordinate.
Referenced by AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::AxisymmetricLinearElasticityProblem().
double Global_Parameters::rmin = 0.1 |
Referenced by adjoint(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::FourierDecomposedTimeHarmonicLinearElasticityProblem(), ChuteWithHopper::getTimeStepRatio(), oomph::QuarterPipeDomain::macro_element_boundary(), main(), oomph::QuarterPipeDomain::QuarterPipeDomain(), oomph::QuarterPipeMesh< ELEMENT >::QuarterPipeMesh(), oomph::QuarterPipeDomain::r_B(), oomph::QuarterPipeDomain::r_D(), oomph::QuarterPipeDomain::r_F(), oomph::QuarterPipeDomain::r_L(), oomph::QuarterPipeDomain::r_R(), and StressStrainControl::setupInitialConditions().
double Global_Parameters::Sphere_centre_z = 0.0 |
Location of the centre of the sphere on the axis.
Referenced by StokesFlowExactWind::get_wind(), and main().
double Global_Parameters::St =0.5 |
Strouhal number (default assignment for FSI1 test case)
Referenced by set_parameters(), and TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem().
double Global_Parameters::T =1.0 |
Period of periodic variation in inflow pressure.
Period for fluctuations in flux.
Referenced by PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep(), PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::doc_parameters(), FSIChannelWithLeafletProblem< ELEMENT >::doc_parameters(), and main().
double Global_Parameters::T_end = 0.0 |
Referenced by ElasticAnnulusProblem< ELASTICITY_ELEMENT >::doc_solution(), and main().
double Global_Parameters::T_start = 0.0 |
helpers to time the code
Referenced by ElasticAnnulusProblem< ELASTICITY_ELEMENT >::doc_solution(), and main().
unsigned Global_Parameters::Use_adaptation_flag =0 |
The choice of whether or not to use adaptation 0 = Uniform refinement 1 = Adaptive refinement
Referenced by main().
double Global_Parameters::Visc_Ratio = 2.0 |
Volume is negative becuase the volume is enclosed by the bulk fluid
Referenced by main(), and RisingBubbleProblem< ELEMENT >::RisingBubbleProblem().
double Global_Parameters::Width_x_left_pml = 2.0 |
double Global_Parameters::Width_x_right_pml = 2.0 |
double Global_Parameters::Width_y_bottom_pml = 2.0 |
double Global_Parameters::Width_y_top_pml = 2.0 |
Random center for blended couette pseudo singularity.
Referenced by blended_grad_velocity_pseudo_singularity_for_couette(), blended_pressure_pseudo_singularity_for_couette(), and blended_velocity_pseudo_singularity_for_couette().
Set up max z coordinate.
Referenced by AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::AxisymmetricLinearElasticityProblem(), oomph::ExtrudedCubeMeshFromQuadMesh< ELEMENT >::build_mesh(), oomph::SimpleCubicMesh< ELEMENT >::build_mesh(), MyCanyonMesh< ELEMENT, INTERFACE_ELEMENT >::change_radius(), and MyTipMesh< ELEMENT, INTERFACE_ELEMENT >::change_radius().
Referenced by statistics_while_running< T >::auto_set_z(), CFile::copy(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::FourierDecomposedTimeHarmonicLinearElasticityProblem(), BaseParticle::getDisplacement2(), oomph::QuarterPipeDomain::macro_element_boundary(), main(), oomph::QuarterPipeDomain::r_D(), oomph::QuarterPipeDomain::r_F(), oomph::QuarterPipeDomain::r_L(), oomph::QuarterPipeDomain::r_R(), and oomph::QuarterPipeDomain::r_U().
double Global_Parameters::Zmin = 0.3 |
Set up min z coordinate.
Referenced by AxisymmetricLinearElasticityProblem< ELEMENT, TIMESTEPPER >::AxisymmetricLinearElasticityProblem(), oomph::ExtrudedCubeMeshFromQuadMesh< ELEMENT >::build_mesh(), oomph::SimpleCubicMesh< ELEMENT >::build_mesh(), MyCanyonMesh< ELEMENT, INTERFACE_ELEMENT >::change_radius(), and MyTipMesh< ELEMENT, INTERFACE_ELEMENT >::change_radius().
double Global_Parameters::zmin = 0.3 |
Referenced by statistics_while_running< T >::auto_set_z(), CFile::copy(), FourierDecomposedTimeHarmonicLinearElasticityProblem< ELEMENT >::FourierDecomposedTimeHarmonicLinearElasticityProblem(), BaseParticle::getDisplacement2(), oomph::QuarterPipeDomain::macro_element_boundary(), main(), oomph::QuarterPipeDomain::r_B(), oomph::QuarterPipeDomain::r_D(), oomph::QuarterPipeDomain::r_L(), oomph::QuarterPipeDomain::r_R(), and oomph::QuarterPipeDomain::r_U().