-
Notifications
You must be signed in to change notification settings - Fork 133
Input File
The input file controls all operations performed by HiFiLES. Below is a (hopefully) comprehensive list of all inputs available for use in the code.
- equation
- 0 | Solve the full Euler/Navier-Stokes equations [default]
- 1 | Solve the scalar advection/diffusion equation
- viscous
- 0 | Inviscid [Euler equations] (0) [default]
- 1 | Viscous [Navier-Stokes equations] (1)
- riemann_solve_type: Inviscid Riemann solver to use at all element interface flux points
- 0 | Scalar diffusion [Rusanov] [default]
- 1 | Lax-Friedrich [for advection/diffusion only]
- 2 | Roe
- ic_form: Initial condition type
- 0 | Isentropic vortex test case
- 1 | Uniform flow [default]
- 2 | Sine wave
- test_case: Are we running a case with an analytical solution? If so, which one?
- 0 | No test case [default]
- 1 | Isentropic Vortex
- 2 | Advection-Equation [?]
- order: Order of basis polynomials
- dt_type: Which type of time-advancement
- 0 | Constant, user-supplied step size [default]
- 1 | Global minimum CFL-based time step
- 2 | Local CFL-based time stepping
- dt: Time step in non-dimensional units
- n_steps: Number of time steps (iterations) to perform
- adv_type: Time integration method
- 0 | Forward Euler
- 3 | Low-Storage 4th-order 5-stage Runge-Kutta
- tau: "tau" factor used in LDG flux
- 0 by default
- pen_fact: Penalty factor for LDG flux
- 0.5 by default
- restart_flag: Start from a restart file or no?
- 0 | No [default]
- 1 | Yes
- restart_iter: Iteration number to restart from (must match number in restart file name)
- n_restart_files: Number of restart files make up the case we are restarting (corresponds to the number of processors used when the restart file was made)
- mesh_file: Name of the mesh file to use
- dx_cyclic: Length (in x-direction) of periodic domain
- Infinity by default [not a periodic domain]
- dy_cyclic: Length (in y-direction) of periodic domain
- Infinity by default [not a periodic domain]
- dz_cyclic: Length (in z-direction) of periodic domain
- Infinity by default [not a periodic domain]
- p_res: Plotting resolution, number of "plot points" per direction in each cell
- write_type: File type for solution data output
- 0 | Paraview .vtu (VTK Unstructured) type (0) [default]
- 1 | Tecplot
- n_diagnostic_fields: Number of additional calculated fields to output, followed by the names of the fields
- Example: 6 u v w energy pressure mach
- Available fields: u v w energy pressure mach vorticity q_criterion u_average v_average w_average sensor epsion
- inters_cub_order: Order of cubature (quadrature) rule for integrating fields (i.e., pressure & viscous forces) over element interfaces (surfaces)
- volume_cub_order: Order of cubature (quadrature) rule for integrating fields over element volumes
- plot_freq: Frequency (in iterations) at which to output the solution
- restart_dump_freq: Frequency at which to output a restart file
- monitor_integrals_freq: Frequency at which to calculate all requested integral quantities
- monitor_res_freq: Frequency at which the residual is computed & output to the terminal
- monitor_cp_freq: Frequency at which the Cp on wall boundaries is output to a file
- 0 | No output [default]
- res_norm_type: Norm to use on the residual
- 0 | Infinity norm
- 1 | L1 norm
- 2 | L2 norm [default]
- error_norm_type: Norm to use on error (test cases with analytical solution)
- 0 | Infinity norm
- 1 | L1 norm
- 2 | L2 norm [default]
upts_type_tri 0 fpts_type_tri 0 vcjh_scheme_tri 1 c_tri 0.0 sparse_tri 0 upts_type_quad 0 vcjh_scheme_quad 0 eta_quad 0.0 sparse_quad 0 upts_type_hexa 0 vcjh_scheme_hexa 0 eta_hexa 0. sparse_hexa 0 upts_type_tet 1 fpts_type_tet 0 vcjh_scheme_tet 0 eta_tet 0.0 sparse_tet 0 upts_type_pri_tri 0 upts_type_pri_1d 0 vcjh_scheme_pri_1d 0 eta_pri 0.0 sparse_pri 0
- gamma: Ratio of specific heats
- 1.4 by default
- prandtl: Prandtl number
- 0.72 by defult
- R_gas: Ideal gas constant (J/kg-K)
- 286.9 by default
- mu_gas: Dynamic viscosity (kg/m-s)
- 1.827E-05 by default
- S_gas: "S" from Sutherland's Law for viscosity
- 120 by defult
- T_gas: Temperature of the gas for Sutherland's Law (Kelvin)
- 291.15 by default
- fix_vis // 0: Sutherland's law, 1: Constant viscosity
- 0 | Sutherland's Law [default]
- 1 | Constant viscosity
Viscous Boundary Conditions
- Mach_free_stream: Mach number of free-stream flow
- nx_free_stream: x-component of free-stream flow
- ny_free_stream: y-component of free-stream flow
- nz_free_stream: z-component of free-stream flow
- Re_free_stream: Reynolds number of free-stream flow
- L_free_stream : Reference length corresponding to the chosen Re (i.e. chord length of airfoil)
- 1 by default
- T_free_stream: Temperature of free-stream flow (Kelvin)
- 300 by default
- T_wall: Temperature of isothermal wall
- 300 by default
- Mach_wall: For moving wall, to calculate velocity magnitude of wall motion [don't use this]
- 0.0 by default
- nx_wall: For moving wall [don't use this]
- ny_wall: For moving wall [don't use this]
- nz_wall: For moving wall [don't use this]
17.857142857142854098
- rho_bound
- u_bound
1.0 - v_bound 0.0
- w_bound 0.0
- p_bound 17.857142857142854098
These are set equal to the prescribed boundary conditions by default These initial conditions are used only for inviscid flows:
- rho_c_ic Initial condition on density
- u_c_ic Initial condition on x-velocity
- v_c_ic Initial condition on y-velocity
- w_c_ic Initial condition on z-velocity
- p_c_ic: Initial condition on pressure
The following initial conditions are utilized only for viscous flows:
- Mach_c_ic: Initial Mach number of fluid
- nx_c_ic: Initial x-component of fluid motion
- ny_c_ic: Initial y-component of fluid motion
- nz_c_ic: Initial z-component of fluid motion
- Re_c_ic: Reynolds number initial condition
- T_c_ic: Initial condition on temperature
// 0: Static Mesh, 1: Linear-Elastic Deformation, 2: Rigid Movement, 3: Sin/Cos Perturbations (Test Case), 4: Blending Functions motion_flag 1 GCL_flag // 0: No GCL 1: Solve GCL 0 n_deform_iters // number of steps to perform during each deform process 1 mesh_output_freq // Frequency to output mesh to file (-1: use plot_freq) 9999999 mesh_output_format // 0: Gambit, 1: Gmsh (but, Gambit not working yet) 1 blend_dist 3 // moving_boundaries: Control motion for linear-elastic deformation // <n_moving_bnds> // <bnd name 1> <motion type 1> <motion params 1> // <bnd name 2> <motion type 2> <motion params 2> // boundary name: name (in mesh file) of moving boundary // motion type: motion params: // 0: constant velocity [vx,vy,vz] // 1: oscillatory motion [Ax,Ay,Az,Atheta,Wx,Wy,Wz,Wtheta] // (x = Axsin(2piWxt), y = ...) moving_boundaries 1 Slip_Wall 1 -2 2 0 0 2 2 0 0
wave_speed_x 1. wave_speed_y 0. wave_speed_z 0. lambda // 1: upwind 1
work in progress
- Home
- User Docs
- User Tutorials
- Meshing for HiFiLES
- [(2D) Flat Plate]
- [Laminar]
- [Turbulent]
- [Local Time-stepping]
- [(2D) Laminar Circular Cylinder]
- [(2D) NACA 0012, 5° AoA, Re = 60,000, M = 1.6]
- [(2D) SD7003 airfoil, 4° AoA, Re = 22,000]
- [(3D) Method of Manufactured Solutions]
- [(3D) SD7003 wing section, 4° AoA, Re = 10,000]
- (3D) Taylor-Green Vortex, Re = 1,600
- Developer Docs
- [Code Structure]
- Building and Running with Qt Creator
- Adding files to the project
- [License]
- [Contact]
- Release Notes