![]() |
|
Global parameters. More...
Classes | |
class | TestPMLMapping |
Enumerations | |
enum | Cases { Spherical_cap_in_cylinder_pinned , All_pinned , Barrel_shape , T_junction_with_nonzero_contact_angle } |
Enumeration for the possible cases. More... | |
Functions | |
void | get_pressure (const Vector< double > &x, double &pressure) |
Pressure depending on the position (x,y) More... | |
void | zero (const Vector< double > &x, Vector< double > &u) |
void | update_parameters () |
Update parameters. More... | |
void | get_source (const double &time, const Vector< double > &x, double &source) |
Source function. More... | |
void | get_exact_u (const double &time, const Vector< double > &x, Vector< double > &u) |
Exact solution as a Vector. More... | |
double | melt_flux (const double &t) |
double | radius (const double &t) |
Exact radius of inner circle. More... | |
double | incoming_sb_inside (const double &t) |
Incoming sb radiation on inside. More... | |
double | incoming_sb_outside (const double &t) |
Incoming sb radiation on outside. More... | |
std::complex< double > | I (0.0, 1.0) |
Imaginary unit. More... | |
void | get_exact_u (const Vector< double > &x, Vector< double > &u) |
Exact solution as a Vector. More... | |
void | prescribed_incoming_flux (const Vector< double > &x, complex< double > &flux) |
double | step_position (const double &time) |
Position of step (x-axis intercept) More... | |
void | get_exact_u (const double &time, const Vector< double > &x, double &u) |
Exact solution as a scalar. More... | |
void | prescribed_flux_on_fixed_y_boundary (const double &time, const Vector< double > &x, double &flux) |
Flux required by the exact solution on a boundary on which y is fixed. More... | |
void | get_simple_exact_u (const Vector< double > &x, Vector< double > &u) |
Get the exact solution, u, at the spatial position, x. More... | |
bool | is_in_pinned_region (const Vector< double > &x) |
void | get_exact_u (const Vector< double > &x, Vector< double > &u, const double &alpha=0.25 *MathematicalConstants::Pi) |
void | get_exact_u_bessel (const Vector< double > &x, Vector< double > &u) |
void | default_get_exact_u (const Vector< double > &x, Vector< double > &u) |
double | calculate_strouhal_number (const double &re) |
void | update_simulation_parameters () |
void | doc_navier_stokes_parameters () |
Document the value of the Reynolds number and Womersley number. More... | |
void | doc_maximum_central_box_deformation () |
Document the maximum deformation inside the central box. More... | |
double | round (const double &d) |
---------------------------------------—DOCUMENTATION HELPERS---— More... | |
void | update_physical_parameters () |
void | update_mesh_parameters () |
void | set_up_dof_to_block_mapping (Vector< unsigned > &dof_to_block_map) |
std::string | parameter_to_string (const double *const parameter_pt) |
void | find_node_on_centerline (Mesh *mesh_pt, FiniteElement **el_centerline_pt, unsigned &node_index) |
--------------------—Documentation Helpers----------------------— More... | |
void | sin_cos_velocity_field (const Vector< double > &x, Vector< double > &u) |
void | sin_cos_vorticity (const Vector< double > &x, Vector< Vector< double > > &vort_and_derivs) |
void | synthetic_velocity_field (const Vector< double > &x, Vector< double > &veloc) |
Synthetic velocity field for validation. More... | |
void | synthetic_vorticity (const Vector< double > &x, Vector< Vector< double > > &vort_and_derivs) |
Synthetic vorticity field and derivs for validation. More... | |
void | initial_condition (const Vector< double > &x, Vector< double > &u) |
Initial condition for velocity. More... | |
double | get_exact_kappa () |
Exact kappa. More... | |
void | spine_base_function (const Vector< double > &x, Vector< double > &spine_B, Vector< Vector< double > > &dspine_B) |
void | spine_function (const Vector< double > &x, Vector< double > &spine, Vector< Vector< double > > &dspine) |
void | setup_dependent_parameters_and_sanity_check () |
Setup dependent parameters and perform sanity check. More... | |
void | spine_base_function (const Vector< double > &x, Vector< double > &spine_B, Vector< Vector< double > > &dspine_B) |
void | spine_function (const Vector< double > &xx, Vector< double > &spine, Vector< Vector< double > > &dspine) |
double | distorted_y (const double &y_normalised) |
Function to distort mesh. More... | |
void | get_source (const Vector< double > &x, double &source) |
Source function required to make the solution above an exact solution. More... | |
Variables | |
double | Eta = 2.39e6 |
FvK parameter. More... | |
double | R_b = 0.1 |
The "bubble" radius. More... | |
double | Pressure =0.0 |
The pressure. More... | |
double | Re =100.0 |
Reynolds number. More... | |
double | L_z =3.0 |
Length of the mesh in the z-direction. More... | |
unsigned | N_z =5 |
Number of elements in the z-direction. More... | |
DocInfo | Doc_info |
Helper for documenting. More... | |
OscillatingCylinder * | Cylinder_pt =0 |
---------------------------------—TIME-INTEGRATION PARAMETERS---— More... | |
double | Radius =0.5 |
Radius of the cylinder. More... | |
double | Amplitude =0.50 |
Amplitude of the cylinder motion. More... | |
double | Length_of_box =10.0 |
----------------------—Cylinder Properties----------------------— More... | |
double | Length_z =1.0 |
The length of the extruded mesh in the z-direction. More... | |
unsigned | N_element_z =10 |
Number of elements in the z-direction (in the extruded mesh) More... | |
unsigned | N_uniform_refinement_before_solve =2 |
Number of uniform refinements before any solve. More... | |
double | Annular_region_radius =1.0 |
The radius of the annular region surrounding the cylinder. More... | |
string | Directory ="RESLT" |
Output directory. More... | |
unsigned | Nintpt =10 |
Number of integration points for new integration scheme (if used) More... | |
double | Sigma = 1.0e-2 |
Non-dim Stefan Boltzmann constant. More... | |
double | Theta_0 =1.0 |
Zero degrees Celsius offset in Stefan Boltzmann law. More... | |
double | Alpha0 =1.0 |
Thermal inertia in inner region. More... | |
double | Alpha1 =1.0 |
Thermal inertia in outer annular region. More... | |
double | Beta0 =0.05 |
Thermal conductivity in inner region. More... | |
double | Beta1 =1.5 |
Thermal conductivity in outer annular region. More... | |
double | Target_area =0.05 |
Target element size. More... | |
double | Radius_innermost =0.5 |
Radius of inner circle. More... | |
double | Radius_inner =1.0 |
Inner radius of annular region. More... | |
double | Radius_outer =1.5 |
Outer radius of annular region. More... | |
double | U0 = 0.8288627710 |
Temperature on boundary of inner circle. More... | |
double | S0 =0.1 |
Strength of source function in inner region. More... | |
double | S1 =1.0 |
Strength of source function in outer region. More... | |
double | Lambda_sq =0.0 |
Non-dim density for pseudo-solid. More... | |
double | Nu =0.3 |
Poisson's ratio for pseudo-solid. More... | |
ConstitutiveLaw * | Constitutive_law_pt =0 |
Pointer to constitutive law. More... | |
double | Melt_temperature =0.8288627710 |
Melt-temperature. More... | |
double | R_hat =0.1 |
Temporal variation in inner radius (for exact solution) More... | |
double | V0 =1.0 |
Coeff for (time-)constant variation of temperature in inner circle. More... | |
double | V0_hat =0.5 |
Coeff for time variation inner circle. More... | |
double | K_squared =10.0 |
Square of the wavenumber. More... | |
bool | DtN_BC =false |
unsigned | ABC_order =3 |
Flag to choose wich order to use. More... | |
double | Outer_radius =1.5 |
Radius of outer boundary (must be a circle!) More... | |
unsigned | N_fourier =10 |
std::string | Restart_file ="" |
Name of restart file. More... | |
std::string | Partitioning_file ="" |
Name of file specifying the partitioning of the problem. More... | |
double | Alpha =1.0 |
Parameter for steepness of step. More... | |
double | Beta =1.0 |
Parameter for amplitude of step translation. More... | |
double | Gamma = MathematicalConstants::Pi/4.0 |
Parameter for timescale of step translation. More... | |
double | TanPhi =0.0 |
Parameter for angle of step. More... | |
unsigned | Nnode_1d =2 |
The number of nodes in one direction (default=2) More... | |
unsigned | Min_refinement_level =1 |
The minimum level of uniform refinement. More... | |
unsigned | Add_refinement_level =0 |
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 |
std::ostream * | Stream_pt |
double | Lx =1.0 |
double | Ly =1.0 |
double | Lz =1.0 |
unsigned | Nx =7 |
Number of elements in each direction (used by SimpleCubicMesh) More... | |
unsigned | Ny =7 |
unsigned | Nz =7 |
double | Element_width =Lx/double(Nx) |
The element width. More... | |
double | Pml_thickness =Element_width |
Length of cube in each direction. More... | |
double | Pi =MathematicalConstants::Pi |
Store the value of Pi. More... | |
double | Alpha_shift =0.0 |
double | Wavenumber =sqrt(K_squared) |
Wavenumber (also known as k),k=omega/c. More... | |
double | Centre =Lx/2.0 |
The x and y coordinate of the centre of the cube. More... | |
FiniteElement::SteadyExactSolutionFctPt | simple_exact_u_pt =&get_simple_exact_u |
TestPMLMapping * | Test_pml_mapping_pt =new TestPMLMapping |
Set the new PML mapping. More... | |
unsigned | Enable_test_pml_mapping_flag =0 |
double | Eps =1.0e-12 |
The tolerance for a point relative to the bounding inner square. More... | |
unsigned | N_pml_element =1 |
The number of elements in the PML layer. More... | |
unsigned | Disable_pml_flag =0 |
unsigned | N_boundary_segment =6 |
The number of segments used to define the circular boundary. More... | |
double | Period_ratio =1.0 |
The ratio T_e/T_s. More... | |
double | Re_target =20.0 |
Reynolds number for unsteady run. More... | |
double | St =1.0 |
The default Strouhal number (overloaded with input value if given) More... | |
double | ReSt =Re*St |
The Womersley number. More... | |
unsigned | N_period_unsteady =1 |
------------------------------------—NAVIER-STOKES PARAMETERS---— More... | |
unsigned | N_step_per_period_unsteady =100 |
Number of timesteps per period for unsteady run. More... | |
double | Height =20.0 |
Height of domain. More... | |
double | X_left =-10.0 |
X-coordinate of upstream end of domain. More... | |
double | X_right =40.0 |
X-coordinate of downstream end of domain. More... | |
double | Length_of_central_box =10.0 |
Side-length of the square box in the mesh surrounding the cylinder. More... | |
unsigned | N_plot_point =2 |
-------------------------------------------—DOMAIN PROPERTIES---— More... | |
double | Amplitude_target =0.50 |
unsigned | N_amplitude_step =5 |
The number of steps used to reach the target amplitude. More... | |
double | Period_ratio_target =1.0 |
unsigned | N_period_ratio_step =1 |
The number of steps used to reach the target Period_ratio value. More... | |
unsigned | N_re_step =2 |
double | L_t =1.0 |
The length of the mesh in the time direction. More... | |
unsigned | N_t =25 |
The number of elements in the time direction. More... | |
unsigned | Preconditioner =0 |
----------------------—Domain Properties------------------------— More... | |
unsigned | N_dof_type =0 |
std::ofstream | Trace_file |
Trace file to doc. asymmetry norm data in. More... | |
bool | Document_solution =true |
Helper variable to indicate whether or not to document the solution. More... | |
double | Length =2.0*MathematicalConstants::Pi |
Length of computational domain. More... | |
double | Kinematic_viscosity =1.0 |
The value of the kinematic viscosity (assumed to be the same everywhere) More... | |
double | L_x =1.0 |
------------------—Unsteady Heat Parameters---------------------— More... | |
double | L_y =1.0 |
Length of the mesh in the y-direction. More... | |
unsigned | N_x =10 |
Number of elements in the x-direction. More... | |
unsigned | N_y =10 |
Number of elements in the y-direction. More... | |
unsigned | Element_order =1 |
The order of the FE interpolation. More... | |
bool | Apply_time_periodic_boundary_conditions =true |
Should we apply time-periodic boundary conditions? More... | |
double | Controlled_height = 0.0 |
Height control value. More... | |
double | Alpha_min = MathematicalConstants::Pi/2.0*1.5 |
Min. spine angle against horizontal plane. More... | |
double | Alpha_max = MathematicalConstants::Pi/2.0*0.5 |
Max. spine angle against horizontal plane. More... | |
bool | Use_spines = true |
Use spines (true) or not (false) More... | |
bool | Use_height_control = true |
Use height control (true) or not (false)? More... | |
int | Case = All_pinned |
What case are we considering: Choose one from the enumeration Cases. More... | |
double | Cos_gamma =cos(Gamma) |
Cos of contact angle. More... | |
Data * | Kappa_pt = 0 |
Pointer to Data object that stores the prescribed curvature. More... | |
double | Kappa_initial = 0.0 |
Initial value for kappa. More... | |
int | Step_sign = 1 |
Increase or decrease the value of the control parameters? More... | |
unsigned | Nsteps = 5 |
Number of steps. More... | |
double | Kappa_increment = -0.05 |
Increment for prescribed curvature. More... | |
double | Controlled_height_increment = 0.1 |
Increment for height control. More... | |
unsigned | Control_element = 0 |
double | Beta_min = MathematicalConstants::Pi/2.0 |
Min. second spine angle against horizontal plane. More... | |
double | Beta_max = MathematicalConstants::Pi/2.0 |
Max. second pine angle against horizontal plane. More... | |
bool | Rotate_spines_in_both_directions = true |
Should the spines rotate in the x and y directions (true)? More... | |
Global parameters.
Namespace for exact solution for Poisson equation with "sharp step".
Namespace for "global" problem parameters.
Namespace for global parameters.
Namespace for the Helmholtz problem parameters.
Namespace for the problem parameters.
Global parameters for the problem.
//////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////
///////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////
////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////
//////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////// Namespace for exact solution of unsteady heat equation with sharp step
/////////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////////
Enumeration for the possible cases.
Enumerator | |
---|---|
Spherical_cap_in_cylinder_pinned | |
All_pinned | |
Barrel_shape | |
T_junction_with_nonzero_contact_angle |
Function to calculate the appropriate Strouhal number for the simulation. Some noteworthy Re-St values: (1) Re=100 --> St=0.1643 (2) Re=200 --> St=0.198 NOTE: The Re-St values for 46<Re<180 can be found in: Williamson, C.H.K, (1988)."Defining a universal and continuous Strouhal–Reynolds number relationship for the laminar vortex shedding of a circular cylinder".
Function to calculate the Strouhal number appropriate for this simulation. The value chosen corresponds to the Strouhal number associated with the vortex-shedding frequency of the flow past a stationary cylinder.
NOTE (1): The Re-St values for 46<Re<180 can be found in: Williamson, C.H.K, (1988)."Defining a universal and continuous Strouhal–Reynolds number relationship for the laminar vortex shedding of a circular cylinder". Noteworthy Re-St value(s): (i) Re=100 --> St=0.1643.
NOTE (2): This should only be used for Reynolds numbers above 46 (where the Hopf bifurcation occurs for the flow past a stationary cylinder) and below (roughly) 180 (where a secondary bifurcation occurs at which point the flow becomes 3D).
NOTE (3): This should only ever be called through the function update_physical_parameter(); to compute the Strouhal number. It should never be used on its own (as it will only be appropriate for a unit Period_ratio value).
References a, b, calibrate::c, OOMPH_CURRENT_FUNCTION, and OOMPH_EXCEPTION_LOCATION.
Referenced by update_physical_parameters(), and update_simulation_parameters().
void GlobalParameters::doc_maximum_central_box_deformation | ( | ) |
Document the maximum deformation inside the central box.
References Amplitude, Annular_region_radius, Length_of_central_box, OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, and oomph::oomph_info.
Referenced by NavierStokesProblem< ELEMENT >::create_spacetime_mesh().
void GlobalParameters::doc_navier_stokes_parameters | ( | ) |
Document the value of the Reynolds number and Womersley number.
References oomph::oomph_info, Re, oomph::ANSIEscapeCode::Red, oomph::ANSIEscapeCode::Reset, and ReSt.
Referenced by main(), and FlowAroundCylinderProblem< ELEMENT >::unsteady_simulation().
void GlobalParameters::find_node_on_centerline | ( | Mesh * | mesh_pt, |
FiniteElement ** | el_centerline_pt, | ||
unsigned & | node_index | ||
) |
--------------------—Documentation Helpers----------------------—
------------------------—Miscellaneous--------------------------— Find a node on the centerline N.B. We are modifying the pointer el_centerline_pt not the actual data. If we just pass a pointer to the element in then (from outside) we are only given a copy of the pointer which is discarded after the function call (but we need it to stay alive!). To edit the pointer itself we have to pass a pointer to the pointer (hence the **).
References abs(), oomph::Mesh::finite_element_pt(), i, oomph::Data::is_pinned(), j, k, Length_of_central_box, oomph::Mesh::nelement(), oomph::FiniteElement::nnode(), oomph::FiniteElement::node_pt(), plotDoE::x, and oomph::Node::x().
double GlobalParameters::get_exact_kappa | ( | ) |
Exact kappa.
References Controlled_height.
Referenced by YoungLaplaceProblem< ELEMENT >::doc_solution().
Exact solution as a scalar.
References Alpha, Beta, cos(), Gamma, BiharmonicTestFunctions2::Pi, Eigen::bfloat16_impl::tanh(), TanPhi, plotDoE::x, X, and Y.
void GlobalParameters::get_exact_u | ( | const double & | time, |
const Vector< double > & | x, | ||
Vector< double > & | u | ||
) |
Exact solution as a Vector.
References Beta0, Beta1, Eigen::bfloat16_impl::log(), Eigen::bfloat16_impl::pow(), UniformPSDSelfTest::r, Radius_inner, Radius_innermost, Radius_outer, S0, S1, Sigma, sqrt(), Theta_0, U0, and plotDoE::x.
Referenced by StefanBoltzmannProblem< ELEMENT >::actions_before_implicit_timestep(), RefineableUnsteadyHeatProblem< ELEMENT >::actions_before_implicit_timestep(), RefineableUnsteadyHeatProblem< ELEMENT >::doc_solution(), StefanBoltzmannProblem< ELEMENT >::doc_solution(), ScatteringProblem< ELEMENT >::doc_solution(), RefineableUnsteadyHeatProblem< ELEMENT >::set_initial_condition(), and StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
Exact solution as a Vector.
Exact solution for scattered field (vector returns real and impaginary parts).
References atan2(), CRBond_Bessel::bessjyna(), Eigen::bfloat16_impl::exp(), oomph::Hankel_functions_for_helmholtz_problem::Hankel_first(), i, I, imag(), ProblemParameters::K_squared, N_fourier, OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, Eigen::bfloat16_impl::pow(), UniformPSDSelfTest::r, sqrt(), BiharmonicTestFunctions2::theta, and plotDoE::x.
void GlobalParameters::get_exact_u | ( | const Vector< double > & | x, |
Vector< double > & | u, | ||
const double & | alpha = 0.25*MathematicalConstants::Pi |
||
) |
Value of the solution on the boundary of the obstacle (here we assume the solution is a plane wave incident at angle alpha)
References alpha, cos(), sin(), Wavenumber, and plotDoE::x.
References ProblemParameters::Centre, oomph::Hankel_functions_for_helmholtz_problem::Hankel_first(), imag(), UniformPSDSelfTest::r, sqrt(), Wavenumber, and plotDoE::x.
Pressure depending on the position (x,y)
References Pressure.
Referenced by UnstructuredFvKProblem< ELEMENT >::complete_problem_setup(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::fill_in_contribution_to_residuals_axisym_poroelasticity_face(), oomph::DarcyFaceElement< ELEMENT >::fill_in_contribution_to_residuals_darcy_face(), oomph::PoroelasticityFaceElement< ELEMENT >::fill_in_contribution_to_residuals_darcy_face(), oomph::AxisymmetricPoroelasticityTractionElement< ELEMENT >::pressure(), oomph::DarcyFaceElement< ELEMENT >::pressure(), and oomph::PoroelasticityFaceElement< ELEMENT >::pressure().
Get the exact solution, u, at the spatial position, x.
References Centre, cos(), UniformPSDSelfTest::r, sin(), sqrt(), Wavenumber, and plotDoE::x.
Referenced by PMLStructuredCubicHelmholtz< ELEMENT >::apply_boundary_conditions(), and PMLStructuredCubicHelmholtz< ELEMENT >::doc_solution().
void GlobalParameters::get_source | ( | const double & | time, |
const Vector< double > & | x, | ||
double & | source | ||
) |
Source function.
Source function to make it an exact solution.
References UniformPSDSelfTest::r, Radius_inner, Radius_innermost, S0, S1, TestProblem::source(), sqrt(), and plotDoE::x.
Referenced by main(), and StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
Source function required to make the solution above an exact solution.
References TanhSolnForAdvectionDiffusion::Alpha, Eigen::bfloat16_impl::pow(), TestProblem::source(), Eigen::bfloat16_impl::tanh(), TanhSolnForAdvectionDiffusion::TanPhi, and plotDoE::x.
std::complex< double > GlobalParameters::I | ( | 0. | 0, |
1. | 0 | ||
) |
Imaginary unit.
Incoming sb radiation on inside.
References Beta0, cos(), Eigen::bfloat16_impl::pow(), R_hat, Radius_innermost, Sigma, sin(), plotPSD::t, Theta_0, ExactSolution::U0, V0, and V0_hat.
Referenced by StefanBoltzmannProblem< ELEMENT >::doc_solution().
Incoming sb radiation on outside.
References Beta0, cos(), Eigen::bfloat16_impl::pow(), R_hat, Radius_inner, Radius_innermost, Sigma, sin(), plotPSD::t, Theta_0, ExactSolution::U0, V0, and V0_hat.
Referenced by StefanBoltzmannProblem< ELEMENT >::doc_solution().
Initial condition for velocity.
References synthetic_velocity_field(), and plotDoE::x.
Function to determine whether or not a point lies in the centre of the mesh (in the pinned region)
References abs(), Centre, Element_width, Eps, and plotDoE::x.
Referenced by PMLStructuredCubicHelmholtz< ELEMENT >::apply_boundary_conditions(), and PMLStructuredCubicHelmholtz< ELEMENT >::doc_solution().
Melt flux for exact solution (to test melting without feedback with S.B.)
References cos(), R_hat, and plotPSD::t.
Referenced by StefanBoltzmannProblem< ELEMENT >::doc_solution(), oomph::UnsteadyHeatFluxPseudoMeltElement< ELEMENT >::fill_in_generic_residual_contribution_ust_heat_flux(), oomph::SurfaceMeltElement< ELEMENT >::interpolated_melt_rate(), oomph::UnsteadyHeatFluxPseudoMeltElement< ELEMENT >::output(), and ExactSolution::prescribed_flux_for_unsteady_heat_validation().
std::string GlobalParameters::parameter_to_string | ( | const double *const | parameter_pt | ) |
Helper function that takes a pointer to one of the problem parameters and returns a string to denote it. Used in the (generic) parameter continuation functions to tell the user which parameter we're changing and what value it has at each iteration
References Amplitude, OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, Period_ratio, GlobalPhysicalVariables::Re, and oomph::Global_string_for_annotation::string().
Referenced by NavierStokesProblem< ELEMENT >::run_natural_continuation().
void GlobalParameters::prescribed_flux_on_fixed_y_boundary | ( | const double & | time, |
const Vector< double > & | x, | ||
double & | flux | ||
) |
Flux required by the exact solution on a boundary on which y is fixed.
References Alpha, Beta, cos(), ProblemParameters::flux(), Gamma, BiharmonicTestFunctions2::Pi, Eigen::bfloat16_impl::pow(), Eigen::bfloat16_impl::tanh(), TanPhi, plotDoE::x, X, and Y.
Referenced by RefineableUnsteadyHeatProblem< ELEMENT >::build_mesh(), and RefineableUnsteadyHeatProblem< ELEMENT >::generic_actions_after().
void GlobalParameters::prescribed_incoming_flux | ( | const Vector< double > & | x, |
complex< double > & | flux | ||
) |
Flux (normal derivative) on the unit disk for a planar incoming wave
References atan2(), CRBond_Bessel::bessjyna(), Eigen::bfloat16_impl::exp(), ProblemParameters::flux(), i, I, ProblemParameters::K_squared, N_fourier, OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, Eigen::bfloat16_impl::pow(), UniformPSDSelfTest::r, sqrt(), BiharmonicTestFunctions2::theta, and plotDoE::x.
Referenced by PMLProblem< ELEMENT >::create_flux_elements(), and ScatteringProblem< ELEMENT >::set_prescribed_incoming_flux_pt().
Exact radius of inner circle.
References R_hat, Radius_innermost, sin(), and plotPSD::t.
Referenced by StefanBoltzmannProblem< ELEMENT >::doc_solution().
---------------------------------------—DOCUMENTATION HELPERS---—
--------------------—Documentation Helpers----------------------—
Function to round a double to the nearest integral value.
-----------------------------------------------—MISCELLANEOUS---— Function to round a double to the nearest integral value
------------------------—Miscellaneous--------------------------— Function to round a double to the nearest integral value
References Eigen::bfloat16_impl::floor().
Referenced by NavierStokesProblem< ELEMENT >::assign_time_slice_id(), and FlowAroundCylinderProblem< ELEMENT >::unsteady_simulation().
Helper function which sets up the mapping between DOF types and which block they should be assigned to. This relies on the concept of "time slices" in the space-time formulation. All dofs in a given time slice will be aggregrated together
Helper function which sets up the mapping between DOF types and which block they should be assigned to. This relies on the concept of "time slabs" in the space-time formulation. All dofs in a given time slab will be aggregrated together
References i, N_dof_type, OOMPH_CURRENT_FUNCTION, and OOMPH_EXCEPTION_LOCATION.
Referenced by NavierStokesProblem< ELEMENT >::set_up_spacetime_solver(), and UnsteadyHeatProblem< ELEMENT >::set_up_spacetime_solver().
void GlobalParameters::setup_dependent_parameters_and_sanity_check | ( | ) |
Setup dependent parameters and perform sanity check.
References All_pinned, Alpha_max, Alpha_min, assert, Barrel_shape, Case, Control_element, cos(), Cos_gamma, Gamma, Kappa_initial, L_x, L_y, N_x, N_y, BiharmonicTestFunctions2::Pi, Rotate_spines_in_both_directions, Spherical_cap_in_cylinder_pinned, and T_junction_with_nonzero_contact_angle.
Returns the velocity field associated with the Taylor-Green vortex solution (for validation of vorticity projection)
References cos(), Eigen::bfloat16_impl::exp(), Height, Kinematic_viscosity, Length, BiharmonicTestFunctions2::Pi, sin(), plotPSD::t, and plotDoE::x.
Referenced by synthetic_velocity_field().
void GlobalParameters::sin_cos_vorticity | ( | const Vector< double > & | x, |
Vector< Vector< double > > & | vort_and_derivs | ||
) |
Returns the vorticity field associated with the Taylor-Green vortex solution (for validation of vorticity projection)
References cos(), Eigen::bfloat16_impl::exp(), Height, Kinematic_viscosity, Length, BiharmonicTestFunctions2::Pi, sin(), plotPSD::t, and plotDoE::x.
Referenced by synthetic_vorticity().
void GlobalParameters::spine_base_function | ( | const Vector< double > & | x, |
Vector< double > & | spine_B, | ||
Vector< Vector< double > > & | dspine_B | ||
) |
Spine basis: The position vector to the basis of the spine as a function of the two coordinates x_1 and x_2, and its derivatives w.r.t. to these coordinates. dspine_B[i][j] = d spine_B[j] / dx_i Spines start in the (x_1,x_2) plane at (x_1,x_2).
References plotDoE::x.
Referenced by RefineableYoungLaplaceProblem< ELEMENT >::RefineableYoungLaplaceProblem(), and YoungLaplaceProblem< ELEMENT >::YoungLaplaceProblem().
void GlobalParameters::spine_base_function | ( | const Vector< double > & | x, |
Vector< double > & | spine_B, | ||
Vector< Vector< double > > & | dspine_B | ||
) |
Spine basis: The position vector to the basis of the spine as a function of the two coordinates x_1 and x_2, and its derivatives w.r.t. to these coordinates. dspine_B[i][j] = d spine_B[j] / dx_i Spines start in the (x_1,x_2) plane at (x_1,x_2).
References plotDoE::x.
void GlobalParameters::spine_function | ( | const Vector< double > & | x, |
Vector< double > & | spine, | ||
Vector< Vector< double > > & | dspine | ||
) |
Spine: The spine vector field as a function of the two coordinates x_1 and x_2, and its derivatives w.r.t. to these coordinates: dspine[i][j] = d spine[j] / dx_i
Spines (and derivatives) are independent of x[0] and rotate in the x[1]-direction
Spines (and derivatives) are independent of x[0] and rotate in the x[1]-direction
Spines (and derivatives) are independent of x[0] and rotate in the x[1]-direction
References Alpha_max, Alpha_min, cos(), sin(), and plotDoE::x.
Referenced by RefineableYoungLaplaceProblem< ELEMENT >::RefineableYoungLaplaceProblem(), and YoungLaplaceProblem< ELEMENT >::YoungLaplaceProblem().
void GlobalParameters::spine_function | ( | const Vector< double > & | xx, |
Vector< double > & | spine, | ||
Vector< Vector< double > > & | dspine | ||
) |
Spine: The spine vector field as a function of the two coordinates x_1 and x_2, and its derivatives w.r.t. to these coordinates: dspine[i][j] = d spine[j] / dx_i
Spines (and derivatives) are independent of x[0] and rotate in the x[1]-direction
Spines are dependent of x[0] AND x[1] and rotate in both directions
References Alpha_max, Alpha_min, cos(), L_x, L_y, Rotate_spines_in_both_directions, sin(), and plotDoE::x.
Position of step (x-axis intercept)
References Beta, cos(), Gamma, BiharmonicTestFunctions2::Pi, and Eigen::bfloat16_impl::tanh().
Referenced by RefineableUnsteadyHeatProblem< ELEMENT >::doc_solution().
void GlobalParameters::synthetic_velocity_field | ( | const Vector< double > & | x, |
Vector< double > & | veloc | ||
) |
Synthetic velocity field for validation.
References sin_cos_velocity_field(), and plotDoE::x.
Referenced by VorticityRecoveryProblem< ELEMENT >::apply_boundary_conditions(), VorticityRecoveryProblem< ELEMENT >::assign_synthetic_veloc_field(), and initial_condition().
void GlobalParameters::synthetic_vorticity | ( | const Vector< double > & | x, |
Vector< Vector< double > > & | vort_and_derivs | ||
) |
Synthetic vorticity field and derivs for validation.
References sin_cos_vorticity(), and plotDoE::x.
Referenced by VorticityRecoveryProblem< ELEMENT >::complete_problem_setup().
void GlobalParameters::update_mesh_parameters | ( | ) |
Update mesh parameters. This is (and only needs to be) once per simulation, during the setup of the mesh. This decides how thick the "fine resolution" layer of elements around the cylinder is. This layer is used to accurately resolve the boundary layer close to the cylinder.
References Annular_region_radius, Length_of_central_box, min, N_t, OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, and Global_Physical_Variables::Radius.
Referenced by NavierStokesProblem< ELEMENT >::NavierStokesProblem().
void GlobalParameters::update_parameters | ( | ) |
Update parameters.
Update the parameters passed in at the command line.
Wavenumber (also known as k), k=omega/c
Wavenumber (also known as k), k=omega/c
Wavenumber (also known as k), k=omega/c
Wavenumber (also known as k), k=omega/c
References Annular_region_radius, Length_of_box, min, and Radius.
Referenced by main().
void GlobalParameters::update_physical_parameters | ( | ) |
Update physical parameters. This updates: (1) The Reynolds number, and; (2) The Strouhal number, and should ALWAYS be called after either the Reynolds number or Period_ratio value changes.
References calculate_strouhal_number(), Period_ratio, GlobalPhysicalVariables::Re, GlobalPhysicalVariables::ReSt, and Global_Physical_Variables::St.
Referenced by NavierStokesProblem< ELEMENT >::actions_after_parameter_increase(), and NavierStokesProblem< ELEMENT >::NavierStokesProblem().
void GlobalParameters::update_simulation_parameters | ( | ) |
Update physical parameters. This updates: (1) The Reynolds number, and; (2) The Strouhal number, and should ALWAYS be called after either the Reynolds number or Period_ratio value changes.
References calculate_strouhal_number(), Period_ratio, GlobalPhysicalVariables::Re, ReSt, and St.
Referenced by main().
Function to compute norm of solution itself (we treat this as the "exact" solution)
Referenced by UnstructuredFvKProblem< ELEMENT >::doc_solution().
unsigned GlobalParameters::ABC_order =3 |
Flag to choose wich order to use.
Referenced by main(), HelmholtzPointSourceProblem< ELEMENT >::setup_outer_boundary(), and ScatteringProblem< ELEMENT >::setup_outer_boundary().
unsigned GlobalParameters::Add_refinement_level =0 |
The additional levels of uniform refinement.
Referenced by main().
double GlobalParameters::Alpha =1.0 |
Parameter for steepness of step.
Parameter for steepness of "step".
------------------—Unsteady Heat Parameters---------------------— Alpha value (thermal inertia)
Referenced by get_exact_u(), SinSolution::get_source(), main(), prescribed_flux_on_fixed_y_boundary(), and RefineableUnsteadyHeatProblem< ELEMENT >::RefineableUnsteadyHeatProblem().
double GlobalParameters::Alpha0 =1.0 |
Thermal inertia in inner region.
Referenced by StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
double GlobalParameters::Alpha1 =1.0 |
Thermal inertia in outer annular region.
Referenced by StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
double GlobalParameters::Alpha_max = MathematicalConstants::Pi/2.0*0.5 |
Max. spine angle against horizontal plane.
Max. first spine angle against horizontal plane.
Referenced by setup_dependent_parameters_and_sanity_check(), and spine_function().
double GlobalParameters::Alpha_min = MathematicalConstants::Pi/2.0*1.5 |
Min. spine angle against horizontal plane.
Min. first spine angle against horizontal plane.
Referenced by setup_dependent_parameters_and_sanity_check(), and spine_function().
double GlobalParameters::Alpha_shift =0.0 |
Choose the value of the shift to create the complex-shifted Laplacian preconditioner (CSLP)
Referenced by main(), PMLStructuredCubicHelmholtz< ELEMENT >::set_gmres_multigrid_solver(), PMLHelmholtzMGProblem< ELEMENT >::set_gmres_multigrid_solver(), and oomph::HelmholtzMGPreconditioner< DIM >::setup_mg_structures().
double GlobalParameters::Amplitude =0.50 |
Amplitude of the cylinder motion.
---------------------------------------------—CYLINDER MOTION---— Amplitude of the cylinder motion used by Williamson & Roshko (1988). Probably best to fix the wavelength and vary this to get different wake modes. Also the easiest way to get different wake patterns to shown in Leontini et al. (2006). SIDE NOTE: as D=1 in our mesh this is also the dimensionless amplitude.
-----------------------—Cylinder Motion-------------------------— Amplitude of the cylinder motion used by Williamson & Roshko (1988). As a side note, since the (simulation) cylinder has unit diameter (i.e. D=1) this is actually the dimensionless amplitude.
Referenced by NavierStokesProblem< ELEMENT >::actions_after_parameter_increase(), CollapsibleChannelProblem< ELEMENT >::CollapsibleChannelProblem(), ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::create_extruded_mesh(), NavierStokesProblem< ELEMENT >::create_spacetime_mesh(), doc_maximum_central_box_deformation(), FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), main(), and parameter_to_string().
double GlobalParameters::Amplitude_target =0.50 |
The target amplitude; used if we're going to do a parameter sweep through the amplitude-wavelength plane. This is generally the second parameter for which parameter continuation is used (if, of course, the value of Amplitude is different to Amplitude_target).
Referenced by main().
double GlobalParameters::Annular_region_radius =1.0 |
The radius of the annular region surrounding the cylinder.
The radius of the annular region surrounding the cylinder NOTE: The annular rings are used to resolve the boundary layers so they should not be made too large (hence the use of std::min).
Referenced by ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::create_extruded_mesh(), NavierStokesProblem< ELEMENT >::create_spacetime_mesh(), doc_maximum_central_box_deformation(), FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), update_mesh_parameters(), and update_parameters().
bool GlobalParameters::Apply_time_periodic_boundary_conditions =true |
Should we apply time-periodic boundary conditions?
Referenced by UnsteadyHeatProblem< ELEMENT >::apply_boundary_conditions(), UnsteadyHeatProblem< ELEMENT >::doc_solution(), and main().
double GlobalParameters::Beta =1.0 |
Parameter for amplitude of step translation.
Beta value (thermal conductivity)
Referenced by get_exact_u(), SinSolution::get_source(), prescribed_flux_on_fixed_y_boundary(), RefineableUnsteadyHeatProblem< ELEMENT >::RefineableUnsteadyHeatProblem(), and step_position().
double GlobalParameters::Beta0 =0.05 |
Thermal conductivity in inner region.
Referenced by get_exact_u(), incoming_sb_inside(), incoming_sb_outside(), and StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
double GlobalParameters::Beta1 =1.5 |
Thermal conductivity in outer annular region.
Referenced by get_exact_u(), oomph::Newmark< NSTEPS >::Newmark(), oomph::NewmarkBDF< NSTEPS >::set_newmark_veloc_weights(), oomph::Newmark< NSTEPS >::set_weights(), and StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
double GlobalParameters::Beta_max = MathematicalConstants::Pi/2.0 |
Max. second pine angle against horizontal plane.
double GlobalParameters::Beta_min = MathematicalConstants::Pi/2.0 |
Min. second spine angle against horizontal plane.
int GlobalParameters::Case = All_pinned |
What case are we considering: Choose one from the enumeration Cases.
Referenced by RefineableYoungLaplaceProblem< ELEMENT >::actions_after_adapt(), main(), and setup_dependent_parameters_and_sanity_check().
The x and y coordinate of the centre of the cube.
The x and y coordinate of the centre of the square.
Referenced by get_simple_exact_u(), is_in_pinned_region(), and PMLHelmholtzMGProblem< ELEMENT >::PMLHelmholtzMGProblem().
ConstitutiveLaw* GlobalParameters::Constitutive_law_pt =0 |
Pointer to constitutive law.
Referenced by main().
unsigned GlobalParameters::Control_element = 0 |
Number of element in bulk mesh at which height control is applied. Initialise to 0 – will be overwritte in setup_dependent_parameters_and_sanity_check()
Referenced by setup_dependent_parameters_and_sanity_check().
double GlobalParameters::Controlled_height = 0.0 |
Height control value.
Height control value for displacement control.
Referenced by get_exact_kappa(), RefineableYoungLaplaceProblem< ELEMENT >::increment_parameters(), main(), RefineableYoungLaplaceProblem< ELEMENT >::RefineableYoungLaplaceProblem(), and YoungLaplaceProblem< ELEMENT >::YoungLaplaceProblem().
double GlobalParameters::Controlled_height_increment = 0.1 |
Increment for height control.
Referenced by RefineableYoungLaplaceProblem< ELEMENT >::increment_parameters(), and main().
OscillatingCylinder * GlobalParameters::Cylinder_pt =0 |
---------------------------------—TIME-INTEGRATION PARAMETERS---—
Pointer to the cylinder.
----------------------—Cylinder Properties----------------------— Pointer to the cylinder
-------------------------------------------—DOMAIN PROPERTIES---— Pointer to the cylinder
Referenced by NavierStokesProblem< ELEMENT >::apply_boundary_conditions(), TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::build_mesh(), ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::create_extruded_mesh(), NavierStokesProblem< ELEMENT >::create_spacetime_mesh(), RectangleWithHoleDomain::cylinder_pt(), CylinderAndInterfaceDomain::CylinderAndInterfaceDomain(), FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), RectangleWithHoleDomain::macro_element_boundary(), oomph::HalfRectangleWithHoleDomain::macro_element_boundary(), CylinderAndInterfaceDomain::macro_element_boundary(), FlowAroundCylinderProblem< ELEMENT >::make_copy(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_IX(), and oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_VIII().
string GlobalParameters::Directory ="RESLT" |
Output directory.
Referenced by main(), and StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
unsigned GlobalParameters::Disable_pml_flag =0 |
The choice of whether or not to disable PMLs (the default is to enable them) 0 = Enable PMLs 1 = Disable PMLs
Referenced by PMLHelmholtzMGProblem< ELEMENT >::actions_after_adapt(), GlobalParameters::TestPMLMapping::gamma(), main(), and PMLHelmholtzMGProblem< ELEMENT >::PMLHelmholtzMGProblem().
unsigned GlobalParameters::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(), PMLStructuredCubicHelmholtz< ELEMENT >::set_gmres_multigrid_solver(), and PMLHelmholtzMGProblem< ELEMENT >::set_gmres_multigrid_solver().
DocInfo GlobalParameters::Doc_info |
Helper for documenting.
-----------------------—Mesh Properties-------------------------—
-------------------------—Solver Info---------------------------—
Doc info object.
DocInfo object used for documentation of the solution.
----------------------—Domain Properties----------------------—
--------------------—Documentation Helpers--------------------— Doc info object
--------------------—Documentation Helpers----------------------—
Referenced by NavierStokesProblem< ELEMENT >::actions_after_newton_solve(), EntryFlowProblem< ELEMENT >::actions_after_newton_solve(), FreeSurfaceRotationProblem< ELEMENT >::actions_after_newton_solve(), RefineableAdvectionDiffusionProblem< ELEMENT >::actions_before_adapt(), RefineableAdvectionDiffusionPipeProblem< ELEMENT >::actions_before_adapt(), PreconditionedFSICollapsibleChannelProblem< ELEMENT >::actions_before_newton_convergence_check(), oomph::MyProblem::actions_before_newton_step(), AnnularDiskProblem< ELASTICITY_ELEMENT >::AnnularDiskProblem(), CantileverProblem< ELEMENT >::CantileverProblem(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedDiskProblem(), ContactProblem< ELEMENT >::ContactProblem(), ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::ConvectionProblem(), DDConvectionProblem< NST_ELEMENT, AD_ELEMENT >::DDConvectionProblem(), DiskShockWaveProblem< ELEMENT, TIMESTEPPER >::doc_displ_and_veloc(), RefineableFishPoissonProblem< ELEMENT >::doc_info(), GeomObjectAsGeneralisedElementProblem::doc_info(), RefineableUnsteadyHeatProblem< ELEMENT >::doc_info(), RefineableAdvectionDiffusionProblem< ELEMENT >::doc_solution(), SUPGAdvectionDiffusionProblem< ELEMENT >::doc_solution(), AxisymFvKProblem< ELEMENT >::doc_solution(), UnstructuredFvKProblem< ELEMENT >::doc_solution(), RefineableAdvectionDiffusionPipeProblem< ELEMENT >::doc_solution(), MovingBlockProblem< ELEMENT >::doc_solution(), ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::doc_solution(), MeltContactProblem< ELEMENT >::doc_solution(), SolarRadiationProblem< ELEMENT >::doc_solution(), ContactProblem< ELEMENT >::doc_solution(), UnsteadyHeatMeltProblem< ELEMENT >::doc_solution(), StefanBoltzmannProblem< ELEMENT >::doc_solution(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), RefineableFishPoissonProblem< ELEMENT >::doc_solution(), GeomObjectAsGeneralisedElementProblem::doc_solution(), NavierStokesProblem< ELEMENT >::doc_solution(), UnstructuredSolidProblem< ELEMENT, MESH >::doc_solution(), CantileverProblem< ELEMENT >::doc_solution(), PrescribedBoundaryDisplacementProblem< ELEMENT >::doc_solution(), EntryFlowProblem< ELEMENT >::doc_solution(), ConvectionProblem< NST_ELEMENT, AD_ELEMENT >::doc_solution(), RefineableConvectionProblem< NST_ELEMENT, AD_ELEMENT >::doc_solution(), DDConvectionProblem< NST_ELEMENT, AD_ELEMENT >::doc_solution(), RefineableDDConvectionProblem< NST_ELEMENT, AD_ELEMENT >::doc_solution(), ThermalProblem< ELEMENT >::doc_solution(), PMLStructuredCubicHelmholtz< ELEMENT >::doc_solution(), PMLHelmholtzMGProblem< ELEMENT >::doc_solution(), SteadyCurvedTubeProblem< ELEMENT >::doc_solution(), SteadyHelicalProblem< ELEMENT >::doc_solution(), SteadyTubeProblem< ELEMENT >::doc_solution(), SolidFreeSurfaceRotationProblem< ELEMENT >::doc_solution(), DiskShockWaveProblem< ELEMENT, TIMESTEPPER >::doc_solution(), AnnularDiskProblem< ELASTICITY_ELEMENT >::doc_solution(), RingWithTRibProblem< ELASTICITY_ELEMENT >::doc_solution(), UnsteadyHeatProblem< ELEMENT >::doc_solution(), FlowAroundCylinderProblem< ELEMENT >::doc_solution(), CompressedSquareProblem< ELEMENT >::doc_solution(), UnstructuredImmersedEllipseProblem< ELEMENT >::doc_solution(), UnstructuredPoissonProblem< ELEMENT >::doc_solution(), RefineableUnsteadyHeatProblem< ELEMENT >::doc_solution(), RefineableDrivenCavityProblem< ELEMENT >::doc_solution(), oomph::MyProblem::doc_solution(), ElasticAnnulusProblem< ELASTICITY_ELEMENT >::doc_solution(), SurfactantProblem< ELEMENT, INTERFACE_ELEMENT >::doc_solution(), FSICollapsibleChannelProblem< ELEMENT >::doc_solution_steady(), FSICollapsibleChannelProblem< ELEMENT >::doc_solution_unsteady(), oomph::MyProblem::dump(), RefineableUnsteadyHeatProblem< ELEMENT >::dump_it(), ElasticAnnulusProblem< ELASTICITY_ELEMENT >::ElasticAnnulusProblem(), oomph::MyProblem::final_doc(), GeomObjectAsGeneralisedElementProblem::GeomObjectAsGeneralisedElementProblem(), oomph::MyProblem::initial_doc(), main(), MeltContactProblem< ELEMENT >::MeltContactProblem(), oomph::MyProblem::MyProblem(), PrescribedBoundaryDisplacementProblem< ELEMENT >::PrescribedBoundaryDisplacementProblem(), oomph::MyProblem::read(), RefineableAdvectionDiffusionPipeProblem< ELEMENT >::RefineableAdvectionDiffusionPipeProblem(), RefineableConvectionProblem< NST_ELEMENT, AD_ELEMENT >::RefineableConvectionProblem(), RefineableDDConvectionProblem< NST_ELEMENT, AD_ELEMENT >::RefineableDDConvectionProblem(), RefineableUnsteadyHeatProblem< ELEMENT >::restart(), RingWithTRibProblem< ELASTICITY_ELEMENT >::RingWithTRibProblem(), DiskShockWaveProblem< ELEMENT, TIMESTEPPER >::run(), CompressedSquareProblem< ELEMENT >::run_it(), CantileverProblem< ELEMENT >::run_it(), CantileverProblem< ELEMENT >::run_tests(), StefanBoltzmannProblem< ELEMENT >::setup_sb_radiation(), SolarRadiationProblem< ELEMENT >::SolarRadiationProblem(), FSICollapsibleChannelProblem< ELEMENT >::steady_run(), ThermalProblem< ELEMENT >::ThermalProblem(), FSICollapsibleChannelProblem< ELEMENT >::unsteady_run(), FlowAroundCylinderProblem< ELEMENT >::unsteady_simulation(), UnsteadyHeatMeltProblem< ELEMENT >::UnsteadyHeatMeltProblem(), UnstructuredImmersedEllipseProblem< ELEMENT >::UnstructuredImmersedEllipseProblem(), oomph::MyProblem::write_trace(), and RefineableUnsteadyHeatProblem< ELEMENT >::write_trace_file_header().
bool GlobalParameters::Document_solution =true |
Helper variable to indicate whether or not to document the solution.
bool GlobalParameters::DtN_BC =false |
Flag to choose the Dirichlet to Neumann BC or ABC BC
Referenced by HelmholtzPointSourceProblem< ELEMENT >::actions_before_newton_convergence_check(), ScatteringProblem< ELEMENT >::actions_before_newton_convergence_check(), HelmholtzPointSourceProblem< ELEMENT >::create_outer_bc_elements(), ScatteringProblem< ELEMENT >::create_outer_bc_elements(), main(), HelmholtzPointSourceProblem< ELEMENT >::setup_outer_boundary(), and ScatteringProblem< ELEMENT >::setup_outer_boundary().
unsigned GlobalParameters::Element_order =1 |
The order of the FE interpolation.
The element width.
Referenced by is_in_pinned_region().
unsigned GlobalParameters::Enable_test_pml_mapping_flag =0 |
The choice of whether or not to enable the new test mapping 1 = Enable test mapping 0 = Disable test mapping
Referenced by PMLHelmholtzMGProblem< ELEMENT >::actions_after_adapt(), PMLStructuredCubicHelmholtz< ELEMENT >::enable_pmls(), main(), PMLHelmholtzMGProblem< ELEMENT >::PMLHelmholtzMGProblem(), and PMLStructuredCubicHelmholtz< ELEMENT >::PMLStructuredCubicHelmholtz().
double GlobalParameters::Eps =1.0e-12 |
The tolerance for a point relative to the bounding inner square.
Referenced by is_in_pinned_region().
double GlobalParameters::Eta = 2.39e6 |
FvK parameter.
Referenced by UnstructuredFvKProblem< ELEMENT >::complete_problem_setup().
double GlobalParameters::Gamma = MathematicalConstants::Pi/4.0 |
Parameter for timescale of step translation.
Contact angle and its cos (dependent parameter – is reassigned)
Referenced by get_exact_u(), main(), prescribed_flux_on_fixed_y_boundary(), RefineableUnsteadyHeatProblem< ELEMENT >::RefineableUnsteadyHeatProblem(), setup_dependent_parameters_and_sanity_check(), and step_position().
double GlobalParameters::Height =20.0 |
Height of domain.
Height of computational domain.
Referenced by MeltSpinningProblem< ELEMENT >::actions_before_newton_solve(), AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::actions_before_newton_solve(), CombCanSpineMesh< ELEMENT, INTERFACE_ELEMENT >::build_single_layer_mesh(), CombTipSpineMesh< ELEMENT, INTERFACE_ELEMENT >::build_single_layer_mesh(), STSpineMesh< ELEMENT, INTERFACE_ELEMENT >::build_single_layer_mesh(), AngleOfRepose::create_inflow_particle(), NavierStokesProblem< ELEMENT >::create_spacetime_mesh(), CylinderAndInterfaceDomain::CylinderAndInterfaceDomain(), MeltSpinningProblem< ELEMENT >::deform_free_surface(), AxisymFreeSurfaceNozzleAdvDiffRobinProblem< ELEMENT >::deform_free_surface(), InterfaceProblem< ELEMENT, TIMESTEPPER >::deform_free_surface(), FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), RectangleWithHoleMesh< ELEMENT >::height(), main(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_I(), oomph::AlgebraicCylinderWithFlagMesh< ELEMENT >::node_update_II(), 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(), RectangleWithHoleMesh< ELEMENT >::RectangleWithHoleMesh(), sin_cos_velocity_field(), sin_cos_vorticity(), and VorticityRecoveryProblem< ELEMENT >::VorticityRecoveryProblem().
double GlobalParameters::K_squared =10.0 |
Square of the wavenumber.
Square of the wavenumber (also known as k^2)
Square of the wavenumber (also known as k^2)
Referenced by HelmholtzPointSourceProblem< ELEMENT >::actions_after_adapt(), PMLStructuredCubicHelmholtz< ELEMENT >::actions_after_adapt(), PMLHelmholtzMGProblem< ELEMENT >::actions_after_adapt(), HelmholtzPointSourceProblem< ELEMENT >::HelmholtzPointSourceProblem(), main(), PMLHelmholtzMGProblem< ELEMENT >::PMLHelmholtzMGProblem(), PMLProblem< ELEMENT >::PMLProblem(), PMLStructuredCubicHelmholtz< ELEMENT >::PMLStructuredCubicHelmholtz(), and ScatteringProblem< ELEMENT >::ScatteringProblem().
double GlobalParameters::Kappa_increment = -0.05 |
Increment for prescribed curvature.
Referenced by RefineableYoungLaplaceProblem< ELEMENT >::increment_parameters().
double GlobalParameters::Kappa_initial = 0.0 |
Initial value for kappa.
Referenced by setup_dependent_parameters_and_sanity_check().
Data* GlobalParameters::Kappa_pt = 0 |
Pointer to Data object that stores the prescribed curvature.
Referenced by YoungLaplaceProblem< ELEMENT >::actions_before_newton_solve(), YoungLaplaceProblem< ELEMENT >::doc_solution(), RefineableYoungLaplaceProblem< ELEMENT >::doc_solution(), RefineableYoungLaplaceProblem< ELEMENT >::increment_parameters(), RefineableYoungLaplaceProblem< ELEMENT >::RefineableYoungLaplaceProblem(), and YoungLaplaceProblem< ELEMENT >::YoungLaplaceProblem().
double GlobalParameters::Kinematic_viscosity =1.0 |
The value of the kinematic viscosity (assumed to be the same everywhere)
Referenced by VorticityRecoveryProblem< ELEMENT >::complete_problem_setup(), sin_cos_velocity_field(), and sin_cos_vorticity().
double GlobalParameters::L_t =1.0 |
The length of the mesh in the time direction.
Length of the mesh in the t-direction.
Referenced by UnsteadyHeatProblem< ELEMENT >::assign_time_slab_id(), NavierStokesProblem< ELEMENT >::assign_time_slice_id(), NavierStokesProblem< ELEMENT >::create_spacetime_mesh(), and UnsteadyHeatProblem< ELEMENT >::create_spacetime_mesh().
double GlobalParameters::L_x =1.0 |
------------------—Unsteady Heat Parameters---------------------—
Length of domain.
Length and width of the domain.
-----------------------—Mesh Properties-------------------------— Length of the mesh in the x-direction
Referenced by UnsteadyHeatProblem< ELEMENT >::create_spacetime_mesh(), main(), RefineableYoungLaplaceProblem< ELEMENT >::RefineableYoungLaplaceProblem(), setup_dependent_parameters_and_sanity_check(), and spine_function().
double GlobalParameters::L_y =1.0 |
Length of the mesh in the y-direction.
Width of domain.
Referenced by UnsteadyHeatProblem< ELEMENT >::create_spacetime_mesh(), main(), RefineableYoungLaplaceProblem< ELEMENT >::RefineableYoungLaplaceProblem(), setup_dependent_parameters_and_sanity_check(), and spine_function().
double GlobalParameters::L_z =3.0 |
Length of the mesh in the z-direction.
Referenced by MovingBlockProblem< ELEMENT >::create_extruded_mesh().
double GlobalParameters::Lambda_sq =0.0 |
Non-dim density for pseudo-solid.
double GlobalParameters::Length =2.0*MathematicalConstants::Pi |
Length of computational domain.
Referenced by sin_cos_velocity_field(), sin_cos_vorticity(), and VorticityRecoveryProblem< ELEMENT >::VorticityRecoveryProblem().
double GlobalParameters::Length_of_box =10.0 |
----------------------—Cylinder Properties----------------------—
----------------------—Domain Properties------------------------— Length of square central box domain
Referenced by ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::create_extruded_mesh(), and update_parameters().
double GlobalParameters::Length_of_central_box =10.0 |
Side-length of the square box in the mesh surrounding the cylinder.
Length of square central box domain.
Referenced by NavierStokesProblem< ELEMENT >::create_spacetime_mesh(), doc_maximum_central_box_deformation(), find_node_on_centerline(), FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), and update_mesh_parameters().
double GlobalParameters::Length_z =1.0 |
The length of the extruded mesh in the z-direction.
Referenced by ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::create_extruded_mesh().
unsigned GlobalParameters::Linear_solver_flag =1 |
The choice of linear solver 0 = SuperLU 1 = Multigrid
Referenced by main(), PMLHelmholtzMGProblem< ELEMENT >::PMLHelmholtzMGProblem(), PMLStructuredCubicHelmholtz< ELEMENT >::PMLStructuredCubicHelmholtz(), PMLHelmholtzMGProblem< ELEMENT >::~PMLHelmholtzMGProblem(), and PMLStructuredCubicHelmholtz< ELEMENT >::~PMLStructuredCubicHelmholtz().
double GlobalParameters::Lx =1.0 |
Length of the cube in each direction
Length of the square in each direction
Referenced by PMLStructuredCubicHelmholtz< ELEMENT >::doc_solution(), PMLStructuredCubicHelmholtz< ELEMENT >::enable_pmls(), PMLHelmholtzMGProblem< ELEMENT >::PMLHelmholtzMGProblem(), and PMLStructuredCubicHelmholtz< ELEMENT >::PMLStructuredCubicHelmholtz().
double GlobalParameters::Ly =1.0 |
double GlobalParameters::Lz =1.0 |
double GlobalParameters::Melt_temperature =0.8288627710 |
Melt-temperature.
Referenced by StefanBoltzmannProblem< ELEMENT >::create_melt_elements().
unsigned GlobalParameters::Min_refinement_level =1 |
The minimum level of uniform refinement.
Referenced by main().
unsigned GlobalParameters::N_adaptations =1 |
The number of adaptations allowed by the Newton solver.
Referenced by main().
unsigned GlobalParameters::N_amplitude_step =5 |
The number of steps used to reach the target amplitude.
Referenced by main().
unsigned GlobalParameters::N_boundary_segment =6 |
The number of segments used to define the circular boundary.
Referenced by main(), and PMLHelmholtzMGProblem< ELEMENT >::PMLHelmholtzMGProblem().
unsigned GlobalParameters::N_dof_type =0 |
Storage for the number of dof types in the mesh. Will be assigned in the function assign_time_slice_id()
Referenced by UnsteadyHeatProblem< ELEMENT >::assign_time_slab_id(), NavierStokesProblem< ELEMENT >::assign_time_slice_id(), and set_up_dof_to_block_mapping().
unsigned GlobalParameters::N_element_z =10 |
Number of elements in the z-direction (in the extruded mesh)
Referenced by ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::create_extruded_mesh().
unsigned GlobalParameters::N_fourier =10 |
Number of terms used in the computation of the exact solution
Referenced by get_exact_u(), prescribed_incoming_flux(), and ScatteringProblem< ELEMENT >::ScatteringProblem().
unsigned GlobalParameters::N_period_ratio_step =1 |
The number of steps used to reach the target Period_ratio value.
unsigned GlobalParameters::N_period_unsteady =1 |
------------------------------------—NAVIER-STOKES PARAMETERS---—
---------------------------------—TIME-INTEGRATION PARAMETERS---— Number of periods for unsteady run
Referenced by FlowAroundCylinderProblem< ELEMENT >::unsteady_simulation().
unsigned GlobalParameters::N_plot_point =2 |
-------------------------------------------—DOMAIN PROPERTIES---—
Number of plot points (in each direction)
---------------------------------------—DOCUMENTATION HELPERS---— The number of plot points in each direction
Referenced by FlowAroundCylinderProblem< ELEMENT >::doc_solution().
unsigned GlobalParameters::N_pml_element =1 |
The number of elements in the PML layer.
Referenced by PMLHelmholtzMGProblem< ELEMENT >::actions_after_adapt(), PMLHelmholtzMGProblem< ELEMENT >::actions_before_adapt(), PMLHelmholtzMGProblem< ELEMENT >::apply_boundary_conditions(), PMLHelmholtzMGProblem< ELEMENT >::create_pml_meshes(), PMLHelmholtzMGProblem< ELEMENT >::doc_solution(), main(), and PMLHelmholtzMGProblem< ELEMENT >::PMLHelmholtzMGProblem().
unsigned GlobalParameters::N_re_step =2 |
The number of steps used to reach the target Reynolds number. In general the target Reynolds number will be reached using natural parameter continuation as pseudo-arc-length continuation doesn't seem to be a reliable method for it (or at least that's what was observed in coarse-grid simulations).
Referenced by main().
unsigned GlobalParameters::N_step_per_period_unsteady =100 |
Number of timesteps per period for unsteady run.
Referenced by FlowAroundCylinderProblem< ELEMENT >::unsteady_simulation().
unsigned GlobalParameters::N_t =25 |
The number of elements in the time direction.
Number of elements in the t-direction.
Referenced by NavierStokesProblem< ELEMENT >::assign_time_slice_id(), NavierStokesProblem< ELEMENT >::create_spacetime_mesh(), UnsteadyHeatProblem< ELEMENT >::create_spacetime_mesh(), and update_mesh_parameters().
unsigned GlobalParameters::N_uniform_refinement_before_solve =2 |
Number of uniform refinements before any solve.
Number of uniform refinements before the mesh extrusion.
Referenced by ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::create_extruded_mesh(), NavierStokesProblem< ELEMENT >::create_spacetime_mesh(), and main().
unsigned GlobalParameters::N_x =10 |
Number of elements in the x-direction.
Number of elements in the mesh.
Referenced by UnsteadyHeatProblem< ELEMENT >::create_spacetime_mesh(), and setup_dependent_parameters_and_sanity_check().
unsigned GlobalParameters::N_y =10 |
Number of elements in the y-direction.
Referenced by UnsteadyHeatProblem< ELEMENT >::create_spacetime_mesh(), and setup_dependent_parameters_and_sanity_check().
unsigned GlobalParameters::N_z =5 |
Number of elements in the z-direction.
Referenced by MovingBlockProblem< ELEMENT >::create_extruded_mesh().
unsigned GlobalParameters::Nintpt =10 |
Number of integration points for new integration scheme (if used)
Referenced by oomph::AxisymmetricNavierStokesEquations::compute_error(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::compute_error(), StefanBoltzmannProblem< ELEMENT >::create_melt_elements(), StefanBoltzmannProblem< ELEMENT >::create_sb_elements(), oomph::AxisymmetricNavierStokesEquations::dissipation(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::dissipation(), oomph::AxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_contribution_to_hessian_vector_products(), oomph::AxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::fill_in_generic_dresidual_contribution_axi_nst(), 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::Z2ErrorEstimator::get_recovered_flux_in_patch(), oomph::AxisymmetricNavierStokesEquations::kin_energy(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::kin_energy(), main(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::max_and_min_invariant_and_viscosity(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::max_and_min_invariant_and_viscosity(), oomph::AxisymmetricNavierStokesEquations::pressure_integral(), oomph::GeneralisedNewtonianAxisymmetricNavierStokesEquations::pressure_integral(), and StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
unsigned GlobalParameters::Nnode_1d =2 |
The number of nodes in one direction (default=2)
The number of nodes in one direction (default=2)
Referenced by oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::get_node_at_local_coordinate(), oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >::get_node_at_local_coordinate(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::local_coordinate_of_node(), oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >::local_coordinate_of_node(), and main().
unsigned GlobalParameters::Nx =7 |
Number of elements in each direction (used by SimpleCubicMesh)
Referenced by NautaMixer::addParticlesAtWall(), CylinderMesh< ELEMENT >::assign_centreline_nodes(), ShellMesh< ELEMENT >::assign_undeformed_positions(), FlatPlateMesh< ELEMENT >::assign_undeformed_positions(), BratuProblem< ELEMENT >::BratuProblem(), oomph::ChannelSpineMesh< ELEMENT >::build_channel_spine_mesh(), oomph::HorizontalSingleLayerSpineMesh< ELEMENT >::build_horizontal_single_layer_mesh(), oomph::CircularCylindricalShellMesh< ELEMENT >::build_mesh(), oomph::RectangularQuadMesh< 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(), oomph::SingleLayerSpineMesh< ELEMENT >::build_single_layer_mesh(), oomph::TwoLayerPerturbedSpineMesh< ELEMENT >::build_two_layer_mesh(), oomph::TwoLayerSpineMesh< BASE_ELEMENT >::build_two_layer_mesh(), CapProblem< ELEMENT >::CapProblem(), ChannelSpineFlowProblem< ELEMENT >::ChannelSpineFlowProblem(), oomph::TwoLayerPerturbedSpineMesh< ELEMENT >::element_reorder(), oomph::ChannelSpineMesh< ELEMENT >::element_reorder(), oomph::RectangularQuadMesh< ELEMENT >::element_reorder(), ExactSolution::flux_into_bulk(), FSIDrivenCavityProblem< ELEMENT >::FSIDrivenCavityProblem(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::initial_element_reorder(), LinearWaveProblem< ELEMENT, TIMESTEPPER >::LinearWaveProblem(), Mesh1D< ELEMENT >::Mesh1D(), PMLStructuredCubicHelmholtz< ELEMENT >::PMLStructuredCubicHelmholtz(), PolarNSProblem< ELEMENT >::PolarNSProblem(), PseudoSolidCapProblem< ELEMENT >::PseudoSolidCapProblem(), CoilSelfTest::setupInitialConditions(), oomph::SimpleRectangularQuadMesh< ELEMENT >::SimpleRectangularQuadMesh(), SimpleRefineableRectangularQuadMesh< ELEMENT >::SimpleRefineableRectangularQuadMesh(), TwoDDGMesh< ELEMENT >::TwoDDGMesh(), TwoDDGProblem< ELEMENT >::TwoDDGProblem(), oomph::TwoLayerPerturbedSpineMesh< ELEMENT >::x_spacing_function(), and oomph::TwoLayerSpineMesh< ELEMENT >::x_spacing_function().
unsigned GlobalParameters::Ny =7 |
Referenced by Vreman::add_particles(), NautaMixer::addParticlesAtWall(), ShellMesh< ELEMENT >::assign_undeformed_positions(), FlatPlateMesh< ELEMENT >::assign_undeformed_positions(), oomph::CircularCylindricalShellMesh< ELEMENT >::assign_undeformed_positions(), oomph::ChannelSpineMesh< ELEMENT >::build_channel_spine_mesh(), oomph::HorizontalSingleLayerSpineMesh< ELEMENT >::build_horizontal_single_layer_mesh(), oomph::CircularCylindricalShellMesh< ELEMENT >::build_mesh(), oomph::RectangularQuadMesh< 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(), oomph::SingleLayerSpineMesh< ELEMENT >::build_single_layer_mesh(), ChannelSpineFlowProblem< ELEMENT >::ChannelSpineFlowProblem(), CollapsibleChannelProblem< ELEMENT >::CollapsibleChannelProblem(), doc_sparse_node_update(), oomph::ChannelSpineMesh< ELEMENT >::element_reorder(), oomph::RectangularQuadMesh< ELEMENT >::element_reorder(), ExactSolution::flux_into_bulk(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), FSIDrivenCavityProblem< ELEMENT >::FSIDrivenCavityProblem(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::initial_element_reorder(), LinearWaveProblem< ELEMENT, TIMESTEPPER >::LinearWaveProblem(), PMLStructuredCubicHelmholtz< ELEMENT >::PMLStructuredCubicHelmholtz(), PolarNSProblem< ELEMENT >::PolarNSProblem(), CoilSelfTest::setupInitialConditions(), oomph::SimpleRectangularQuadMesh< ELEMENT >::SimpleRectangularQuadMesh(), SpikedChannelSpineFlowProblem< ELEMENT >::SpikedChannelSpineFlowProblem(), TwoDDGMesh< ELEMENT >::TwoDDGMesh(), and TwoDDGProblem< ELEMENT >::TwoDDGProblem().
unsigned GlobalParameters::Nz =7 |
double GlobalParameters::Outer_radius =1.5 |
Radius of outer boundary (must be a circle!)
Referenced by HelmholtzPointSourceProblem< ELEMENT >::HelmholtzPointSourceProblem(), ScatteringProblem< ELEMENT >::ScatteringProblem(), oomph::FourierDecomposedHelmholtzDtNMesh< ELEMENT >::setup_gamma(), oomph::HelmholtzDtNMesh< ELEMENT >::setup_gamma(), HelmholtzPointSourceProblem< ELEMENT >::setup_outer_boundary(), and ScatteringProblem< ELEMENT >::setup_outer_boundary().
unsigned GlobalParameters::Output_management_flag =0 |
The MG solver allows for five different levels of output: 0 = Outputs everything 1 = Outputs everything except the smoother timings 2 = Outputs setup information but no V-cycle timings 3 = Suppresses all output
Referenced by PMLStructuredCubicHelmholtz< ELEMENT >::apply_boundary_conditions(), main(), PMLStructuredCubicHelmholtz< ELEMENT >::set_gmres_multigrid_solver(), and PMLHelmholtzMGProblem< ELEMENT >::set_gmres_multigrid_solver().
std::string GlobalParameters::Partitioning_file ="" |
Name of file specifying the partitioning of the problem.
Referenced by main().
double GlobalParameters::Period_ratio =1.0 |
The ratio T_e/T_s.
The ratio between the cylinder excitation period, T_e, and the stationary cylinder vortex-shedding period, T_s. Explicitly, we have, Period_ratio=T_e/T_s. If the value of this parameter ever changes then the function update_physical_parameter(), (defined in this namespace) MUST be called immediately after.
NOTE: We use the ratio T_e/T_s (instead of T_s/T_e; used by Leontini et al. 2006) to match the x-axis in the experimental phase diagram of Williamson & Roshko (1988) (with the y-axis given by the non-dimensionalised amplitude parameter).
Referenced by NavierStokesProblem< ELEMENT >::actions_after_parameter_increase(), main(), parameter_to_string(), update_physical_parameters(), and update_simulation_parameters().
double GlobalParameters::Period_ratio_target =1.0 |
The target Period_ratio value; used if we're going to do a parameter sweep through the amplitude-wavelength plane. This will normally be the last parameter for which parameter continuation is used (again, if the value of Period_ratio is different to Period_ratio_target).
double GlobalParameters::Pi =MathematicalConstants::Pi |
Store the value of Pi.
double GlobalParameters::Pml_thickness =Element_width |
Length of cube in each direction.
The thickness of the PML layer defaults to 0.2, so 10% of the size of the physical domain
Referenced by PMLHelmholtzMGProblem< ELEMENT >::create_pml_meshes(), PMLStructuredCubicHelmholtz< ELEMENT >::doc_solution(), PMLStructuredCubicHelmholtz< ELEMENT >::enable_pmls(), and main().
unsigned GlobalParameters::Post_smoother_flag =0 |
The choice of post-smoother: 0 = Automatic (GMRES as a smoother on levels where kh>0.5) 1 = Damped Jacobi on all levels with a constant omega value
Referenced by main(), PMLStructuredCubicHelmholtz< ELEMENT >::set_gmres_multigrid_solver(), and PMLHelmholtzMGProblem< ELEMENT >::set_gmres_multigrid_solver().
unsigned GlobalParameters::Pre_smoother_flag =0 |
The choice of pre-smoother: 0 = Automatic (GMRES as a smoother on levels where kh>0.5) 1 = Damped Jacobi on all levels with a constant omega value
Referenced by main(), PMLStructuredCubicHelmholtz< ELEMENT >::set_gmres_multigrid_solver(), and PMLHelmholtzMGProblem< ELEMENT >::set_gmres_multigrid_solver().
unsigned GlobalParameters::Preconditioner =0 |
----------------------—Domain Properties------------------------—
-----------------------—Mesh Properties-------------------------—
-------------------------—Solver Info---------------------------— Variable to choose which preconditioner to use. The actual preconditioner we choose to use is defined by the enumeration class implemented in the problem
Referenced by NavierStokesProblem< ELEMENT >::NavierStokesProblem(), NavierStokesProblem< ELEMENT >::set_up_spacetime_solver(), and UnsteadyHeatProblem< ELEMENT >::set_up_spacetime_solver().
double GlobalParameters::Pressure =0.0 |
The pressure.
Referenced by UnstructuredFvKProblem< ELEMENT >::doc_solution(), get_pressure(), and main().
double GlobalParameters::R_b = 0.1 |
The "bubble" radius.
Referenced by UnstructuredFvKProblem< ELEMENT >::UnstructuredFvKProblem().
double GlobalParameters::R_hat =0.1 |
Temporal variation in inner radius (for exact solution)
Referenced by incoming_sb_inside(), incoming_sb_outside(), melt_flux(), and radius().
double GlobalParameters::Radius =0.5 |
Radius of the cylinder.
------------------—Navier-Stokes Parameters---------------------—
----------------------—Domain Properties------------------------— Radius of the cylinder
Referenced by ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::create_extruded_mesh(), NavierStokesProblem< ELEMENT >::create_spacetime_mesh(), FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), and update_parameters().
double GlobalParameters::Radius_inner =1.0 |
Inner radius of annular region.
Referenced by get_exact_u(), get_source(), incoming_sb_outside(), and StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
double GlobalParameters::Radius_innermost =0.5 |
Radius of inner circle.
Initial radius of inner circle.
Referenced by get_exact_u(), get_source(), incoming_sb_inside(), incoming_sb_outside(), radius(), and StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
double GlobalParameters::Radius_outer =1.5 |
Outer radius of annular region.
Referenced by get_exact_u(), and StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
double GlobalParameters::Re =100.0 |
Reynolds number.
-----------------------—Cylinder Motion-------------------------—
---------------------------------------------—CYLINDER MOTION---—
------------------------------------—NAVIER-STOKES PARAMETERS---— The current Reynolds number
------------------—Navier-Stokes Parameters---------------------— Set the (current) Reynolds number. A pointer to this variable is provided to elements to make them fully functional. As this is used to calculate the Womersley number (=Re*St), the function update_physical_parameter(), (defined in this namespace) MUST be called immediately after editing the value of this variable.
Referenced by NavierStokesProblem< ELEMENT >::actions_after_parameter_increase(), MovingBlockProblem< ELEMENT >::complete_element_build(), NavierStokesProblem< ELEMENT >::complete_problem_setup(), VorticityRecoveryProblem< ELEMENT >::complete_problem_setup(), doc_navier_stokes_parameters(), FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), main(), and FlowAroundCylinderProblem< ELEMENT >::unsteady_simulation().
double GlobalParameters::Re_target =20.0 |
Reynolds number for unsteady run.
The target Reynolds number used in simulations. If this is different to the current Reynolds number then the first part of this simulation will (or at least, should) work to reach the target Reynolds number. Also, the value this number takes dictates the choice of Strouhal number (=St).
Referenced by main(), and FlowAroundCylinderProblem< ELEMENT >::unsteady_simulation().
The Womersley number.
The Womersley number (=Re*St), otherwise denoted as ReSt, is dependent on the value of the Reynolds number and the Strouhal number. If either value is changed then the function update_physical_parameter(), will be called which, in turn, updates the Womersley number value.
Referenced by NavierStokesProblem< ELEMENT >::complete_problem_setup(), doc_navier_stokes_parameters(), FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), main(), and update_simulation_parameters().
std::string GlobalParameters::Restart_file ="" |
Name of restart file.
Referenced by main(), and RefineableUnsteadyHeatProblem< ELEMENT >::restart().
bool GlobalParameters::Rotate_spines_in_both_directions = true |
Should the spines rotate in the x and y directions (true)?
Referenced by setup_dependent_parameters_and_sanity_check(), and spine_function().
double GlobalParameters::S0 =0.1 |
Strength of source function in inner region.
Referenced by get_exact_u(), get_source(), oomph::BrethertonSpineMesh< ELEMENT, SpineLineFluidInterfaceElement< ELEMENT > >::initial_element_reorder(), Eigen::internal::ptranspose(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::reposition_spines(), SegregationPeriodic::setSpeciesProperties(), SegregationPeriodic::setupInitialConditions(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::spine_node_update_vertical_transition_lower(), and oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::spine_node_update_vertical_transition_upper().
double GlobalParameters::S1 =1.0 |
Strength of source function in outer region.
Referenced by get_exact_u(), get_source(), Eigen::internal::ptranspose(), SegregationPeriodic::setSpeciesProperties(), and SegregationPeriodic::setupInitialConditions().
double GlobalParameters::Sigma = 1.0e-2 |
Non-dim Stefan Boltzmann constant.
Referenced by StefanBoltzmannProblem< ELEMENT >::create_melt_elements(), StefanBoltzmannProblem< ELEMENT >::create_sb_elements(), oomph::PerturbedSpineLinearisedAxisymmetricFluidInterfaceElement< ELEMENT >::fill_in_generic_residual_contribution_interface(), oomph::FluidInterfaceElement::fill_in_generic_residual_contribution_interface(), get_exact_u(), incoming_sb_inside(), incoming_sb_outside(), and StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
FiniteElement::SteadyExactSolutionFctPt GlobalParameters::simple_exact_u_pt =&get_simple_exact_u |
double GlobalParameters::St =1.0 |
The default Strouhal number (overloaded with input value if given)
The Strouhal number, St, is normally defined as St=L/UT, where L, U and T are the defining length-scale, flow speed and defining time scale. Physically, this parameter represents the ratio of convection time-scale to that of our artificial time- scale. The natural length-scale to use here is the cylinder diameter and U is defined to be the speed of the flow at the inlet. To capture time-periodic solutions (which have the same period as a single cylinder oscillation) we non-dimensionalise time on the cylinder oscillation time-scale, i.e. T_{e}. This allows us to use a mesh with fixed (unit) length in the time- direction; avoiding any re-meshing. Thus, we define St=St_{oomph}=D/UT_{e}. However, this is not the only time-scale of the flow. There is also the time-scale of the vortex-shedding past a stationary cylinder. The Strouhal number associated with this (which is dependent on the choice of Reynolds number) is St(Re)=St_{vort}(Re)=D/UT_{s}, where T_{s} is the period of vortex-shedding. This is also the Strouhal number computed by: calculate_strouhal_number(Re), which is defined further below. It then follows: St_{oomph}=(D/UT_{e}) =(D/UT_{s})*(T_{s}/T_{e}) =St_{vort}/Period_ratio. In general, we always choose St_{vort} to be that associated with the value of Re_target (which will remain the same throughout a simulation). As such, the only time the value of St=St_{oomph}=St_{vort}/Period_ratio, may change is when the value of Period_ratio changes.
NOTE: This value is also used to scale the cylinder velocity since, in dimensional units, nodes on the cylinder boundary satisfy: u_{node}^{*}=dr^{*}_{cyl}/dt^{*}, where the asterisk indicates the quantity is in dimensional units. After non-dimensionalising and rearranging we find u_{node}=(D/UT_{e})*dr_{cyl}/dt =St_{oomph}*dr_{cyl}/dt =(St_{vort}/Period_ratio)*dr_{cyl}/dt.
Referenced by NavierStokesProblem< ELEMENT >::apply_boundary_conditions(), FlowAroundCylinderProblem< ELEMENT >::unsteady_simulation(), and update_simulation_parameters().
int GlobalParameters::Step_sign = 1 |
Increase or decrease the value of the control parameters?
std::ostream * GlobalParameters::Stream_pt |
Referenced by PMLStructuredCubicHelmholtz< ELEMENT >::apply_boundary_conditions(), main(), oomph::OomphInfo::operator<<(), oomph::OomphLibError::set_stream_pt(), oomph::OomphLibWarning::set_stream_pt(), oomph::BlockDiagonalPreconditioner< MATRIX >::setup(), oomph::BlockTriangularPreconditioner< MATRIX >::setup(), oomph::ExactDGPBlockPreconditioner< MATRIX >::setup(), oomph::BandedBlockTriangularPreconditioner< MATRIX >::setup(), and oomph::OomphInfo::stream_pt().
double GlobalParameters::TanPhi =0.0 |
Parameter for angle of step.
Parameter for angle Phi of "step".
Referenced by get_exact_u(), main(), prescribed_flux_on_fixed_y_boundary(), and RefineableUnsteadyHeatProblem< ELEMENT >::RefineableUnsteadyHeatProblem().
double GlobalParameters::Target_area =0.05 |
Target element size.
Referenced by main(), and StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
TestPMLMapping * GlobalParameters::Test_pml_mapping_pt =new TestPMLMapping |
double GlobalParameters::Theta_0 =1.0 |
Zero degrees Celsius offset in Stefan Boltzmann law.
Referenced by StefanBoltzmannProblem< ELEMENT >::create_melt_elements(), StefanBoltzmannProblem< ELEMENT >::create_sb_elements(), get_exact_u(), incoming_sb_inside(), incoming_sb_outside(), and StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem().
std::ofstream GlobalParameters::Trace_file |
Trace file to doc. asymmetry norm data in.
double GlobalParameters::U0 = 0.8288627710 |
Temperature on boundary of inner circle.
Referenced by get_exact_u().
unsigned GlobalParameters::Use_adaptation_flag =0 |
The choice of whether or not to use adaptation 0 = Uniform refinement 1 = Adaptive refinement
Referenced by main().
bool GlobalParameters::Use_height_control = true |
Use height control (true) or not (false)?
Referenced by RefineableYoungLaplaceProblem< ELEMENT >::increment_parameters().
double GlobalParameters::V0 =1.0 |
Coeff for (time-)constant variation of temperature in inner circle.
Referenced by incoming_sb_inside(), and incoming_sb_outside().
double GlobalParameters::V0_hat =0.5 |
Coeff for time variation inner circle.
Referenced by incoming_sb_inside(), and incoming_sb_outside().
Wavenumber (also known as k),k=omega/c.
Wavenumber (also known as k), k=omega/c.
Referenced by get_exact_u(), get_exact_u_bessel(), get_simple_exact_u(), oomph::HelmholtzMGPreconditioner< DIM >::setup_mg_structures(), and oomph::HelmholtzMGPreconditioner< DIM >::setup_smoothers().
double GlobalParameters::X_left =-10.0 |
X-coordinate of upstream end of domain.
Referenced by NavierStokesProblem< ELEMENT >::create_spacetime_mesh(), FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), and OscillatingWall::position().
double GlobalParameters::X_right =40.0 |
X-coordinate of downstream end of domain.
Referenced by NavierStokesProblem< ELEMENT >::create_spacetime_mesh(), and FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem().