oomph::Problem_Parameter Namespace Reference

Namespace for Problem Parameter. More...

Functions

void oscillation (const double &time, const Vector< double > &x, Vector< double > &force)
 Function describing the oscillation. More...
 
double free_surface_profile (const double r)
 

Variables

unsigned BDF_type =2
 Which bdf timestepper do we use? More...
 
unsigned Nprev_for_extrapolation_of_strain_rate =2
 
double Uniform_element_area =0.004
 Uniform initial element area. More...
 
std::string Directory = "RESLT"
 Output directory. More...
 
std::string Restart_file =""
 Name of restart file. More...
 
DocInfo Doc_info_trace
 Doc info trace file. More...
 
DocInfo Doc_info_soln
 Doc info solutions. More...
 
double External_pressure =0.0
 Set external pressure. More...
 
double Re =1.967e-1
 Reynolds number. More...
 
double ReInvFr =1.0
 
double Ca = 42.19
 Capillary number. More...
 
double St = 1.440e0
 Strouhal number. More...
 
double Re_St = Re*St
 Reynolds multiplied Strouhal. More...
 
double F_max = 40.24
 Maximum force of the applied oscillation (non-dimensionalised) More...
 
double Oscillating_body_force_multiplier =1.0
 Body force multiplier. More...
 
double Initial_settling_time = 0.25
 Time after which oscillation starts. More...
 
double Dt_min =1.0e-6
 Minimum allowable timestep. More...
 
double Nu =0.3
 Pseudo-solid Poisson ratio. More...
 
double C1 =1.0
 Pseudo-solid Mooney-Rivlin parameter. More...
 
double E =2.2
 Pseudo-solid Young's modulus. More...
 
double Shell_radius =1.0
 Radius of the shell. More...
 
ConstitutiveLawConstitutive_law_pt =0
 Constitutive law used to determine the mesh deformation. More...
 
double Yield_stress = 2.861e-1
 have a generic yield stress, required for the output function More...
 
double C_yield_stress =2.526e-1
 Yield stress. More...
 
double C_Re =7.827e-1
 Reynolds number. More...
 
double C_St = 2.966e-1
 Strouhal number. More...
 
double C_Re_St = C_Re*C_St
 Reynolds multiplied Strouhal. More...
 
double HB_yield_stress =2.861e-1
 Yield stress. More...
 
double HB_flow_index = 0.828
 Power law exponent. More...
 
double HB_Re =2.430e-1
 Reynolds number. More...
 
double HB_St =1.295e0
 Strouhal number. More...
 
double HB_Re_St = HB_Re*HB_St
 Reynolds multiplied Strouhal. More...
 
double S_alpha =3.181e-1
 Pre-factor in Sisko model K / ( mu_inf T^(n-1) ) More...
 
double S_flow_index =4.89e-6
 Flow index in Sisko model. More...
 
double S_Re =1.967e-1
 Reynolds number. More...
 
double S_St = 1.440e0
 Strouhal number. More...
 
double S_Re_St = S_Re*S_St
 Reynolds multiplied Strouhal. More...
 
double Critical_strain_rate =1.4e-14
 Critical strain rate. More...
 
GeneralisedNewtonianConstitutiveEquation< 3 > * Const_eqn_pt =0
 Fluid constitutive equation. More...
 
ofstream Trace_file
 Trace file. More...
 
ofstream Norm_file
 File to document the norm of the solution (for validation purposes) More...
 
double Block_x_velocity =0.5
 Block velocity. More...
 
double Block_y_velocity =0.3
 Block velocity. More...
 
double Block_rotation_velocity =1.0
 Block velocity. More...
 
Vector< Data * > Centre_displacement_data_pt
 
DocInfo Doc_info
 Doc info. More...
 
double Lambda_sq =0.0
 

Detailed Description

Namespace for Problem Parameter.

Function Documentation

◆ free_surface_profile()

double oomph::Problem_Parameter::free_surface_profile ( const double  r)
129  {
130  return -0.05*(cos(MathematicalConstants::Pi*r)+1.0);
131  }
AnnoyingScalar cos(const AnnoyingScalar &x)
Definition: AnnoyingScalar.h:136
double Pi
Definition: two_d_biharmonic.cc:235
r
Definition: UniformPSDSelfTest.py:20

References cos(), BiharmonicTestFunctions2::Pi, and UniformPSDSelfTest::r.

Referenced by AxisymmetricVibratingShellProblem< ELEMENT >::AxisymmetricVibratingShellProblem(), and VibratingShellProblem< ELEMENT >::VibratingShellProblem().

◆ oscillation()

void oomph::Problem_Parameter::oscillation ( const double time,
const Vector< double > &  x,
Vector< double > &  force 
)

Function describing the oscillation.

108  {
109  force[0]=0.0;
110 
111  // Start the oscillation after initial settling time
112  if(time >= Initial_settling_time)
113  {
114  force[1]=-1.0 + Oscillating_body_force_multiplier*
116  }
117  else
118  {
119  force[1]=-1.0;
120  }
121 
122  // Horizontal body force is always zero
123  force[2]=0.0;
124 
125  }
AnnoyingScalar sin(const AnnoyingScalar &x)
Definition: AnnoyingScalar.h:137
double F_max
Maximum force of the applied oscillation (non-dimensionalised)
Definition: axisym_vibrating_shell_non_newtonian.cc:94
double Initial_settling_time
Time after which oscillation starts.
Definition: axisym_vibrating_shell_non_newtonian.cc:100
double Oscillating_body_force_multiplier
Body force multiplier.
Definition: axisym_vibrating_shell_non_newtonian.cc:97

References F_max, Initial_settling_time, Oscillating_body_force_multiplier, BiharmonicTestFunctions2::Pi, and sin().

Referenced by AxisymmetricVibratingShellProblem< ELEMENT >::complete_problem_setup(), VibratingShellProblem< ELEMENT >::complete_problem_setup(), AxisymmetricVibratingShellProblem< ELEMENT >::doc_solution(), and VibratingShellProblem< ELEMENT >::doc_solution().

Variable Documentation

◆ BDF_type

◆ Block_rotation_velocity

double oomph::Problem_Parameter::Block_rotation_velocity =1.0

Block velocity.

◆ Block_x_velocity

double oomph::Problem_Parameter::Block_x_velocity =0.5

Block velocity.

◆ Block_y_velocity

double oomph::Problem_Parameter::Block_y_velocity =0.3

Block velocity.

◆ C1

double oomph::Problem_Parameter::C1 =1.0

Pseudo-solid Mooney-Rivlin parameter.

◆ C_Re

double oomph::Problem_Parameter::C_Re =7.827e-1

Reynolds number.

Referenced by main().

◆ C_Re_St

double oomph::Problem_Parameter::C_Re_St = C_Re*C_St

Reynolds multiplied Strouhal.

Referenced by main().

◆ C_St

double oomph::Problem_Parameter::C_St = 2.966e-1

Strouhal number.

Referenced by main().

◆ C_yield_stress

double oomph::Problem_Parameter::C_yield_stress =2.526e-1

Yield stress.

Referenced by main().

◆ Ca

double oomph::Problem_Parameter::Ca = 42.19

Capillary number.

◆ Centre_displacement_data_pt

Vector<Data*> oomph::Problem_Parameter::Centre_displacement_data_pt

Vector of Data object containing the three values (x-displacement, y-displacement and rotation angle) for the polygons' centreline motion.

Referenced by UnstructuredFluidProblem< ELEMENT >::actions_before_implicit_timestep(), UnstructuredFluidProblem< ELEMENT >::doc_solution(), UnstructuredFluidProblem< ELEMENT >::UnstructuredFluidProblem(), and UnstructuredFluidProblem< ELEMENT >::~UnstructuredFluidProblem().

◆ Const_eqn_pt

◆ Constitutive_law_pt

ConstitutiveLaw * oomph::Problem_Parameter::Constitutive_law_pt =0

Constitutive law used to determine the mesh deformation.

◆ Critical_strain_rate

double oomph::Problem_Parameter::Critical_strain_rate =1.4e-14

Critical strain rate.

Referenced by get_Z2_flux(), and main().

◆ Directory

std::string oomph::Problem_Parameter::Directory = "RESLT"

◆ Doc_info

DocInfo oomph::Problem_Parameter::Doc_info

Doc info.

◆ Doc_info_soln

◆ Doc_info_trace

◆ Dt_min

◆ E

double oomph::Problem_Parameter::E =2.2

Pseudo-solid Young's modulus.

◆ External_pressure

double oomph::Problem_Parameter::External_pressure =0.0

Set external pressure.

◆ F_max

double oomph::Problem_Parameter::F_max = 40.24

Maximum force of the applied oscillation (non-dimensionalised)

Referenced by oscillation().

◆ HB_flow_index

double oomph::Problem_Parameter::HB_flow_index = 0.828

Power law exponent.

Referenced by main().

◆ HB_Re

double oomph::Problem_Parameter::HB_Re =2.430e-1

Reynolds number.

Referenced by main().

◆ HB_Re_St

double oomph::Problem_Parameter::HB_Re_St = HB_Re*HB_St

Reynolds multiplied Strouhal.

Referenced by main().

◆ HB_St

double oomph::Problem_Parameter::HB_St =1.295e0

Strouhal number.

Referenced by main().

◆ HB_yield_stress

double oomph::Problem_Parameter::HB_yield_stress =2.861e-1

Yield stress.

Referenced by main().

◆ Initial_settling_time

double oomph::Problem_Parameter::Initial_settling_time = 0.25

Time after which oscillation starts.

Referenced by main(), and oscillation().

◆ Lambda_sq

double oomph::Problem_Parameter::Lambda_sq =0.0

Pseudo solid "density" – set to zero because we don't want inertia in the node update!

◆ Norm_file

ofstream oomph::Problem_Parameter::Norm_file

File to document the norm of the solution (for validation purposes)

File to document the norm of the solution (for validation purposes – triangle doesn't give fully reproducible results so mesh generation/adaptation may generate slightly different numbers of elements on different machines!)

Referenced by UnstructuredImmersedEllipseProblem< ELEMENT >::doc_solution(), UnstructuredImmersedEllipseProblem< ELEMENT >::UnstructuredImmersedEllipseProblem(), and UnstructuredImmersedEllipseProblem< ELEMENT >::~UnstructuredImmersedEllipseProblem().

◆ Nprev_for_extrapolation_of_strain_rate

unsigned oomph::Problem_Parameter::Nprev_for_extrapolation_of_strain_rate =2

Number of previous timesteps to be used for extrapolation of strain rate (cannot be bigger than BDF_type)

Referenced by AxisymmetricVibratingShellProblem< ELEMENT >::complete_problem_setup(), VibratingShellProblem< ELEMENT >::complete_problem_setup(), and main().

◆ Nu

double oomph::Problem_Parameter::Nu =0.3

Pseudo-solid Poisson ratio.

◆ Oscillating_body_force_multiplier

double oomph::Problem_Parameter::Oscillating_body_force_multiplier =1.0

Body force multiplier.

Referenced by main(), and oscillation().

◆ Re

double oomph::Problem_Parameter::Re =1.967e-1

Reynolds number.

◆ Re_St

◆ ReInvFr

double oomph::Problem_Parameter::ReInvFr =1.0

◆ Restart_file

std::string oomph::Problem_Parameter::Restart_file =""

◆ S_alpha

double oomph::Problem_Parameter::S_alpha =3.181e-1

Pre-factor in Sisko model K / ( mu_inf T^(n-1) )

Referenced by main().

◆ S_flow_index

double oomph::Problem_Parameter::S_flow_index =4.89e-6

Flow index in Sisko model.

Referenced by main().

◆ S_Re

double oomph::Problem_Parameter::S_Re =1.967e-1

Reynolds number.

Referenced by main().

◆ S_Re_St

double oomph::Problem_Parameter::S_Re_St = S_Re*S_St

Reynolds multiplied Strouhal.

Referenced by main().

◆ S_St

double oomph::Problem_Parameter::S_St = 1.440e0

Strouhal number.

Referenced by main().

◆ Shell_radius

◆ St

double oomph::Problem_Parameter::St = 1.440e0

Strouhal number.

◆ Trace_file

ofstream oomph::Problem_Parameter::Trace_file

Trace file.

Referenced by AxiPoroProblem< ELEMENT, TIMESTEPPER >::AxiPoroProblem(), CantileverProblem< ELEMENT >::CantileverProblem(), BaseStateProblem< BASE_ELEMENT >::close_trace_file(), PerturbedStateProblem< BASE_ELEMENT, PERTURBED_ELEMENT >::close_trace_file(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedDiskProblem(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedSphereProblem(), ContactProblem< ELEMENT >::ContactProblem(), BaseStateProblem< BASE_ELEMENT >::create_trace_file(), PerturbedStateProblem< BASE_ELEMENT, PERTURBED_ELEMENT >::create_trace_file(), DarcyProblem< ELEMENT >::DarcyProblem(), UnstructuredFvKProblem< ELEMENT >::doc_solution(), MeltContactProblem< ELEMENT >::doc_solution(), SolarRadiationProblem< ELEMENT >::doc_solution(), ContactProblem< ELEMENT >::doc_solution(), UnsteadyHeatMeltProblem< ELEMENT >::doc_solution(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), RefineableFishPoissonProblem< ELEMENT >::doc_solution(), GeomObjectAsGeneralisedElementProblem::doc_solution(), UnstructuredSolidProblem< ELEMENT, MESH >::doc_solution(), PMLStructuredCubicHelmholtz< ELEMENT >::doc_solution(), PMLHelmholtzMGProblem< ELEMENT >::doc_solution(), DiskShockWaveProblem< ELEMENT, TIMESTEPPER >::doc_solution(), CompressedSquareProblem< ELEMENT >::doc_solution(), UnstructuredPoissonProblem< ELEMENT >::doc_solution(), RefineableUnsteadyHeatProblem< ELEMENT >::doc_solution(), AxiPoroProblem< ELEMENT, TIMESTEPPER >::doc_solution(), DarcyProblem< ELEMENT >::doc_solution(), CapProblem< ELEMENT >::doc_solution(), PseudoSolidCapProblem< ELEMENT >::doc_solution(), InterfaceProblem< ELEMENT, TIMESTEPPER >::doc_solution(), ElasticRingProblem< ELEMENT >::doc_solution(), UnsteadyHeatProblem< ELEMENT >::doc_solution(), StefanBoltzmannProblem< ELEMENT >::doc_solution(), HelmholtzPointSourceProblem< ELEMENT >::doc_solution(), AirwayReopeningProblem< ELEMENT >::doc_solution(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), DeformableFishPoissonProblem< ELEMENT >::doc_solution(), OscRingNStProblem< ELEMENT >::doc_solution(), LinearWaveProblem< ELEMENT, TIMESTEPPER >::doc_solution(), CantileverProblem< ELEMENT >::doc_solution(), BrethertonProblem< ELEMENT >::doc_solution(), RayleighProblem< ELEMENT, TIMESTEPPER >::doc_solution(), RayleighTractionProblem< ELEMENT, TIMESTEPPER >::doc_solution(), ThreeDimBethertonProblem< ELEMENT >::doc_solution(), ElasticInterfaceProblem< ELEMENT, TIMESTEPPER >::doc_solution(), PMLFourierDecomposedHelmholtzProblem< ELEMENT >::doc_solution(), PMLProblem< ELEMENT >::doc_solution(), StaticDiskCompressionProblem< ELEMENT >::doc_solution(), DiskOscillationProblem< ELEMENT >::doc_solution(), TestPoissonProblem< ELEMENT >::doc_solution(), BaseStateProblem< BASE_ELEMENT >::doc_solution(), PerturbedStateProblem< BASE_ELEMENT, PERTURBED_ELEMENT >::doc_solution(), OscRingNStProblem< ELEMENT >::doc_solution_historic(), GeomObjectAsGeneralisedElementProblem::GeomObjectAsGeneralisedElementProblem(), HelmholtzPointSourceProblem< ELEMENT >::HelmholtzPointSourceProblem(), BaseStateProblem< BASE_ELEMENT >::initialise_trace_file(), PerturbedStateProblem< BASE_ELEMENT, PERTURBED_ELEMENT >::initialise_trace_file(), MeltContactProblem< ELEMENT >::MeltContactProblem(), CapProblem< ELEMENT >::parameter_study(), PseudoSolidCapProblem< ELEMENT >::parameter_study(), StaticDiskCompressionProblem< ELEMENT >::parameter_study(), BrethertonProblem< ELEMENT >::parameter_study(), AirwayReopeningProblem< ELEMENT >::parameter_study(), PMLFourierDecomposedHelmholtzProblem< ELEMENT >::PMLFourierDecomposedHelmholtzProblem(), PMLHelmholtzMGProblem< ELEMENT >::PMLHelmholtzMGProblem(), PMLProblem< ELEMENT >::PMLProblem(), PMLStructuredCubicHelmholtz< ELEMENT >::PMLStructuredCubicHelmholtz(), DeformableFishPoissonProblem< ELEMENT >::run(), DiskShockWaveProblem< ELEMENT, TIMESTEPPER >::run(), DiskOscillationProblem< ELEMENT >::run(), CompressedSquareProblem< ELEMENT >::run_it(), CantileverProblem< ELEMENT >::run_it(), SolarRadiationProblem< ELEMENT >::SolarRadiationProblem(), StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem(), ThreeDimBethertonProblem< ELEMENT >::ThreeDimBethertonProblem(), BaseStateProblem< BASE_ELEMENT >::trace_file(), PerturbedStateProblem< BASE_ELEMENT, PERTURBED_ELEMENT >::trace_file(), ElasticRingProblem< ELEMENT >::unsteady_run(), LinearWaveProblem< ELEMENT, TIMESTEPPER >::unsteady_run(), InterfaceProblem< ELEMENT, TIMESTEPPER >::unsteady_run(), ElasticInterfaceProblem< ELEMENT, TIMESTEPPER >::unsteady_run(), OscRingNStProblem< ELEMENT >::unsteady_run(), RayleighProblem< ELEMENT, TIMESTEPPER >::unsteady_run(), RayleighTractionProblem< ELEMENT, TIMESTEPPER >::unsteady_run(), UnsteadyHeatMeltProblem< ELEMENT >::UnsteadyHeatMeltProblem(), UnsteadyHeatProblem< ELEMENT >::UnsteadyHeatProblem(), UnstructuredPoissonProblem< ELEMENT >::UnstructuredPoissonProblem(), OscRingNStProblem< ELEMENT >::write_trace_file_header(), RefineableUnsteadyHeatProblem< ELEMENT >::write_trace_file_header(), OscRingNStProblem< ELEMENT >::write_trace_file_header_historic(), RefineableFishPoissonProblem< ELEMENT >::~RefineableFishPoissonProblem(), RefineableUnsteadyHeatProblem< ELEMENT >::~RefineableUnsteadyHeatProblem(), and TestPoissonProblem< ELEMENT >::~TestPoissonProblem().

◆ Uniform_element_area

double oomph::Problem_Parameter::Uniform_element_area =0.004

◆ Yield_stress

double oomph::Problem_Parameter::Yield_stress = 2.861e-1

have a generic yield stress, required for the output function

Referenced by main(), and output().