|
[Sponsors] |
Always fail to get the result on the backward facing step |
|
LinkBack | Thread Tools | Search this Thread | Display Modes |
July 25, 2019, 18:31 |
Always fail to get the result on the backward facing step
|
#1 |
Member
Jianming Liu
Join Date: Mar 2009
Location: China
Posts: 71
Rep Power: 17 |
Hello,
recently I try to use SU2-6.2.0 to run a case (3d backward facing step). I used both of DDES and rans. But both of them will divergent after some time steps. The grid is obtained from https://turbmodels.larc.nasa.gov/backstep_grids.html. I choose a small cgns grid (2x65x65, 2x25x65, 2x97x113, 2x33x113 ) to generate a 3d grid in the format of SU2. In the spanwise direction, the length is 3 times of step height with 40 grids. I paste the cfg file here and the used grid . Could u please tell me what's wrong? Thank u very much. %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% %%%%%%%%%%%%%%%%%%%%%%%%%%%%%% % % % SU2 configuration file % % Case description: Turbulent flow around a square cylinder % % Author: Thomas D. Economon % % Institution: Stanford University % % Date: 2013.02.25 % % File Version 6.2.0 "Falcon" % % % %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% %%%%%%%%%%%%%%%%%%%%%%%%%%%%%% % ------------- DIRECT, ADJOINT, AND LINEARIZED PROBLEM DEFINITION ------------% % % Physical governing equations (EULER, NAVIER_STOKES, % WAVE_EQUATION, HEAT_EQUATION, FEM_ELASTICITY, % POISSON_EQUATION) PHYSICAL_PROBLEM= NAVIER_STOKES % % If Navier-Stokes, kind of turbulent model (NONE, SA) KIND_TURB_MODEL= SA HYBRID_RANSLES= SA_DDES % % Mathematical problem (DIRECT, CONTINUOUS_ADJOINT) MATH_PROBLEM= DIRECT % % Restart solution (NO, YES) RESTART_SOL= NO % % Write binary restart files (YES, NO) WRT_BINARY_RESTART= NO % % Read binary restart files (YES, NO) READ_BINARY_RESTART= NO % % Unsteady restart iteration (need previous restart files) UNST_RESTART_ITER=2 % ------------------------- UNSTEADY SIMULATION -------------------------------% % % Unsteady simulation (NO, TIME_STEPPING, DUAL_TIME_STEPPING-1ST_ORDER, % DUAL_TIME_STEPPING-2ND_ORDER, HARMONIC_BALANCE) UNSTEADY_SIMULATION= DUAL_TIME_STEPPING-2ND_ORDER % % Time Step for dual time stepping simulations (s) UNST_TIMESTEP= 0.00005 % % Total Physical Time for dual time stepping simulations (s) UNST_TIME= 7.5 %UNST_TIME= 0.001 % 2500 iterations - 3.75 % 3500 iterations - 5.25 % 5000 iterations - 7.50 % % Number of internal iterations (dual time method) UNST_INT_ITER=15 % ----------- COMPRESSIBLE AND INCOMPRESSIBLE FREE-STREAM DEFINITION ----------% % % Mach number (non-dimensional, based on the free-stream values) MACH_NUMBER= 0.2 % % Angle of attack (degrees) AOA= 0.0 % % Side-slip angle (degrees) SIDESLIP_ANGLE= 0.0 % % Free-stream temperature (288.15 K by default) FREESTREAM_TEMPERATURE= 300.0 % % Reynolds number (non-dimensional, based on the free-stream values) REYNOLDS_NUMBER= 36000.0 % % Reynolds length (in meters) REYNOLDS_LENGTH= 1.0 % ---------------------- REFERENCE VALUE DEFINITION ---------------------------% % % Reference origin for moment computation REF_ORIGIN_MOMENT_X = 0.00 REF_ORIGIN_MOMENT_Y = 0.00 REF_ORIGIN_MOMENT_Z = 0.00 % % Reference length for pitching, rolling, and yawing non-dimensional moment REF_LENGTH= 1.0 % % Reference area for force coefficients (0 implies automatic calculation) REF_AREA= 1.0 % -------------------- BOUNDARY CONDITION DEFINITION --------------------------% % % Navier-Stokes wall boundary marker(s) (NONE = no marker) MARKER_HEATFLUX= ( topwall, 0.0,lowerwall,0.0 ) % MARKER_PERIODIC= ( cebianB, cebianA, 0,0,0, 0,0,0, 0,1.0,0.0) % Farfield boundary marker(s) (NONE = no marker) %MARKER_FAR= ( top ) % % Marker(s) of the surface to be plotted or designed MARKER_PLOTTING= ( lowerwall ) % % Marker(s) of the surface where the functional (Cd, Cl, etc.) will be evaluated MARKER_MONITORING= ( lowerwall ) % Inlet boundary marker(s) (NONE = no marker) % Format: ( inlet marker, total temperature, total pressure, flow_direction_x, % flow_direction_y, flow_direction_z, ... ) MARKER_INLET= ( inflow, 302.4, 118309.784, 1.0, 0.0, 0.0 ) % % Outlet boundary marker(s) (NONE = no marker) % Format: ( outlet marker, back pressure, ... ) MARKER_OUTLET= ( outflow, 115056.0 ) % % Symmetry boundary marker(s) (NONE = no marker) %MARKER_SYM= (topsym,lowersym,cebianB, cebianA, ) MARKER_SYM= (topsym,lowersym ) % % ------------- COMMON PARAMETERS DEFINING THE NUMERICAL METHOD ---------------% % % Numerical method for spatial gradients (GREEN_GAUSS, LEAST_SQUARES, % WEIGHTED_LEAST_SQUARES) NUM_METHOD_GRAD= WEIGHTED_LEAST_SQUARES % % Courant-Friedrichs-Lewy condition of the finest grid CFL_NUMBER= 2.0 % % Adaptive CFL number (NO, YES) CFL_ADAPT= NO % % Parameters of the adaptive CFL number (factor down, factor up, CFL min value, % CFL max value ) CFL_ADAPT_PARAM= ( 1.5, 0.5, 1.0, 100.0 ) % % Runge-Kutta alpha coefficients RK_ALPHA_COEFF= ( 0.66667, 0.66667, 1.000000 ) % % Number of total iterations EXT_ITER= 30010 % % ------------------------ LINEAR SOLVER DEFINITION ---------------------------% % % Linear solver for the implicit (or discrete adjoint) formulation (BCGSTAB, FGMRES) LINEAR_SOLVER= FGMRES % % Preconditioner of the Krylov linear solver (JACOBI, LINELET, LU_SGS) LINEAR_SOLVER_PREC= LU_SGS % % Min error of the linear solver for the implicit formulation LINEAR_SOLVER_ERROR= 1E-6 % % Max number of iterations of the linear solver for the implicit formulation LINEAR_SOLVER_ITER= 10 % -------------------------- MULTIGRID PARAMETERS -----------------------------% % % Multi-Grid Levels (0 = no multi-grid) MGLEVEL= 0 % % Multi-grid cycle (V_CYCLE, W_CYCLE, FULLMG_CYCLE) MGCYCLE= V_CYCLE % % Multi-grid pre-smoothing level MG_PRE_SMOOTH= ( 1, 2, 3, 3 ) % % Multi-grid post-smoothing level MG_POST_SMOOTH= ( 0, 0, 0, 0 ) % % Jacobi implicit smoothing of the correction MG_CORRECTION_SMOOTH= ( 0, 0, 0, 0 ) % % Damping factor for the residual restriction MG_DAMP_RESTRICTION= 0.7 % % Damping factor for the correction prolongation MG_DAMP_PROLONGATION= 0.7 % -------------------- FLOW NUMERICAL METHOD DEFINITION -----------------------% % % Convective numerical method (JST, LAX-FRIEDRICH, CUSP, ROE, AUSM, HLLC, % TURKEL_PREC, MSW) CONV_NUM_METHOD_FLOW= ROE % % Spatial numerical order integration (1ST_ORDER, 2ND_ORDER, 2ND_ORDER_LIMITER) MUSCL_FLOW= YES % % Coefficient for the limiter VENKAT_LIMITER_COEFF= 5.0 % % 2nd and 4th order artificial dissipation coefficients JST_SENSOR_COEFF= ( 0.5, 0.02 ) % % Time discretization (RUNGE-KUTTA_EXPLICIT, EULER_IMPLICIT, EULER_EXPLICIT) TIME_DISCRE_FLOW= EULER_IMPLICIT %TIME_DISCRE_FLOW= EULER_EXPLICIT % -------------------- TURBULENT NUMERICAL METHOD DEFINITION ------------------% % % Convective numerical method (SCALAR_UPWIND) CONV_NUM_METHOD_TURB= SCALAR_UPWIND % % Monotonic Upwind Scheme for Conservation Laws (TVD) in the turbulence equations. % Required for 2nd order upwind schemes (NO, YES) MUSCL_TURB= NO % % Slope limiter (NONE, VENKATAKRISHNAN, BARTH) SLOPE_LIMITER_TURB= VENKATAKRISHNAN % % Time discretization (EULER_IMPLICIT) TIME_DISCRE_TURB= EULER_IMPLICIT % --------------------------- CONVERGENCE PARAMETERS --------------------------% % % Convergence criteria (CAUCHY, RESIDUAL) % CONV_CRITERIA= RESIDUAL % % Residual reduction (order of magnitude with respect to the initial value) RESIDUAL_REDUCTION= 3 % % Min value of the residual (log10 of the residual) RESIDUAL_MINVAL= -10 % % Start convergence criteria at iteration number STARTCONV_ITER= 10 % % Number of elements to apply the criteria CAUCHY_ELEMS= 100 % % Epsilon to control the series convergence CAUCHY_EPS= 1E-5 % % Function to apply the criteria (LIFT, DRAG, NEARFIELD_PRESS, SENS_GEOMETRY, % SENS_MACH, DELTA_LIFT, DELTA_DRAG) CAUCHY_FUNC_FLOW= DRAG % ------------------------- INPUT/OUTPUT INFORMATION --------------------------% % % Mesh input file %MESH_FILENAME= mesh_square_turb_hybrid.su2 %MESH_FILENAME= bkstpsm.su2 MESH_FILENAME=bkstpJul23.su2 % % Mesh input file format (SU2, CGNS NETCDF_ASCII) MESH_FORMAT= SU2 % % Mesh output file MESH_OUT_FILENAME= mesh_out.su2 % % Restart flow input file %SOLUTION_FLOW_FILENAME= solution_flow.dat SOLUTION_FLOW_FILENAME= restart_flow.dat % % Restart adjoint input file SOLUTION_ADJ_FILENAME= solution_adj.dat % % Output file format (PARAVIEW, TECPLOT) OUTPUT_FORMAT= TECPLOT % % Output file convergence history (w/o extension) CONV_FILENAME= history % % Output file restart flow RESTART_FLOW_FILENAME= restart_flow.dat % % Output file restart adjoint RESTART_ADJ_FILENAME= restart_adj.dat % % Output file flow (w/o extension) variables VOLUME_FLOW_FILENAME= flow % % Output file adjoint (w/o extension) variables VOLUME_ADJ_FILENAME= adjoint % % Output Objective function gradient (using continuous adjoint) WRT_CSV_SOL=NO %WRT_SURF_FREQ_DUALTIME=100 GRAD_OBJFUNC_FILENAME= of_grad.dat % % Output file surface flow coefficient (w/o extension) SURFACE_FLOW_FILENAME= surface_flow % % Output file surface adjoint coefficient (w/o extension) SURFACE_ADJ_FILENAME= surface_adjoint % % Writing solution file frequency WRT_SOL_FREQ= 400 % % Writing solution file frequency for physical time steps (dual time) WRT_SOL_FREQ_DUALTIME= 200 WRT_SURF_FREQ_DUALTIME= 200 % % Writing convergence history frequency WRT_CON_FREQ= 1 % % Writing convergence history frequency (dual time, only written to screen) WRT_CON_FREQ_DUALTIME= 1 Last edited by liujmljm; July 26, 2019 at 01:17. |
|
July 25, 2019, 18:42 |
|
#2 |
Member
Jianming Liu
Join Date: Mar 2009
Location: China
Posts: 71
Rep Power: 17 |
the grid can be downloaded from
https://www.dropbox.com/s/xyk8ownh9c...Jul23.su2?dl=0 |
|
|
|
Similar Threads | ||||
Thread | Thread Starter | Forum | Replies | Last Post |
Long simulation time (Backward Facing Step) | nskelly | OpenFOAM Running, Solving & CFD | 3 | March 6, 2018 11:59 |
Micro Scale Pore, icoFoam | gooya_kabir | OpenFOAM Running, Solving & CFD | 2 | November 2, 2013 14:58 |
backward facing step simple with no particle | saeed115 | Mesh Generation & Pre-Processing | 0 | March 5, 2013 18:41 |
IcoFoam parallel woes | msrinath80 | OpenFOAM Running, Solving & CFD | 9 | July 22, 2007 03:58 |
backward facing step problem | Yung-Ming Chen | Main CFD Forum | 3 | May 11, 1999 23:04 |