-
Notifications
You must be signed in to change notification settings - Fork 846
Commit
This commit does not belong to any branch on this repository, and may belong to a fork outside of the repository.
- Loading branch information
Francisco Palacios
committed
Jun 17, 2014
1 parent
da575d9
commit a2ff3df
Showing
4 changed files
with
16,085 additions
and
1 deletion.
There are no files selected for viewing
This file contains bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
Original file line number | Diff line number | Diff line change |
---|---|---|
@@ -0,0 +1,377 @@ | ||
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% | ||
% % | ||
% SU2 configuration file % | ||
% Case description: Transonic inviscid flow around a NACA0012 airfoil % | ||
% Author: Thomas D. Economon % | ||
% Institution: Stanford University % | ||
% Date: 2014.06.11 % | ||
% File Version 3.2.0 "eagle" % | ||
% % | ||
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% | ||
|
||
% ------------- DIRECT, ADJOINT, AND LINEARIZED PROBLEM DEFINITION ------------% | ||
% | ||
% Physical governing equations (EULER, NAVIER_STOKES, | ||
% TNE2_EULER, TNE2_NAVIER_STOKES, | ||
% WAVE_EQUATION, HEAT_EQUATION, LINEAR_ELASTICITY, | ||
% POISSON_EQUATION) | ||
PHYSICAL_PROBLEM= EULER | ||
% | ||
% Mathematical problem (DIRECT, ADJOINT) | ||
MATH_PROBLEM= DIRECT | ||
% | ||
% Restart solution (NO, YES) | ||
RESTART_SOL= NO | ||
|
||
% ----------- COMPRESSIBLE AND INCOMPRESSIBLE FREE-STREAM DEFINITION ----------% | ||
% | ||
% Mach number (non-dimensional, based on the free-stream values) | ||
MACH_NUMBER= 0.8 | ||
% | ||
% Angle of attack (degrees) | ||
AoA= 1.25 | ||
% | ||
% Free-stream pressure (101325.0 N/m^2 by default, only Euler flows) | ||
FREESTREAM_PRESSURE= 101325.0 | ||
% | ||
% Free-stream temperature (273.15 K by default) | ||
FREESTREAM_TEMPERATURE= 273.15 | ||
|
||
% -------------- COMPRESSIBLE AND INCOMPRESSIBLE FLUID CONSTANTS --------------% | ||
% | ||
% Ratio of specific heats (1.4 (air), only for compressible flows) | ||
GAMMA_VALUE= 1.4 | ||
% | ||
% Specific gas constant (287.87 J/kg*K (air), only for compressible flows) | ||
GAS_CONSTANT= 287.87 | ||
|
||
% ---------------------- REFERENCE VALUE DEFINITION ---------------------------% | ||
% | ||
% Reference origin for moment computation | ||
REF_ORIGIN_MOMENT_X = 0.25 | ||
REF_ORIGIN_MOMENT_Y = 0.00 | ||
REF_ORIGIN_MOMENT_Z = 0.00 | ||
% | ||
% Reference length for pitching, rolling, and yawing non-dimensional moment | ||
REF_LENGTH_MOMENT= 1.0 | ||
% | ||
% Reference area for force coefficients (0 implies automatic calculation) | ||
REF_AREA= 1.0 | ||
% | ||
% Reference pressure (101325.0 N/m^2 by default) | ||
REF_PRESSURE= 1.0 | ||
% | ||
% Reference temperature (273.15 K by default) | ||
REF_TEMPERATURE= 1.0 | ||
% | ||
% Reference density (1.2886 Kg/m^3 (air), 998.2 Kg/m^3 (water)) | ||
REF_DENSITY= 1.0 | ||
|
||
% ----------------------- BOUNDARY CONDITION DEFINITION -----------------------% | ||
% | ||
% Marker of the Euler boundary (NONE = no marker) | ||
MARKER_EULER= ( airfoil ) | ||
% | ||
% Marker of the far field (NONE = no marker) | ||
MARKER_FAR= ( farfield ) | ||
|
||
% ------------------------ SURFACES IDENTIFICATION ----------------------------% | ||
% | ||
% Marker(s) of the surface in the surface flow solution file | ||
MARKER_PLOTTING = ( airfoil ) | ||
% | ||
% Marker(s) of the surface where the non-dimensional coefficients are evaluated. | ||
MARKER_MONITORING = ( airfoil ) | ||
% | ||
% Marker(s) of the surface where obj. func. (design problem) will be evaluated | ||
MARKER_DESIGNING = ( airfoil ) | ||
|
||
% ------------- COMMON PARAMETERS TO DEFINE THE NUMERICAL METHOD --------------% | ||
% | ||
% Numerical method for spatial gradients (GREEN_GAUSS, WEIGHTED_LEAST_SQUARES) | ||
NUM_METHOD_GRAD= WEIGHTED_LEAST_SQUARES | ||
% | ||
% Objective function in optimization problem (DRAG, LIFT, SIDEFORCE, MOMENT_X, | ||
% MOMENT_Y, MOMENT_Z, EFFICIENCY, | ||
% EQUIVALENT_AREA, NEARFIELD_PRESSURE, | ||
% FORCE_X, FORCE_Y, FORCE_Z, THRUST, | ||
% TORQUE, FREE_SURFACE, TOTAL_HEATFLUX, | ||
% MAXIMUM_HEATFLUX, INVERSE_DESIGN_PRESSURE, | ||
% INVERSE_DESIGN_HEATFLUX) | ||
OBJECTIVE_FUNCTION= DRAG | ||
% | ||
% Courant-Friedrichs-Lewy condition of the finest grid | ||
CFL_NUMBER= 4.0 | ||
% | ||
% CFL ramp (factor, number of iterations, CFL limit) | ||
CFL_RAMP= ( 1.0, 100, 1.0 ) | ||
% | ||
% Number of total iterations | ||
EXT_ITER= 250 | ||
|
||
% ------------------------ LINEAR SOLVER DEFINITION ---------------------------% | ||
% | ||
% Linear solver for implicit formulations (BCGSTAB, FGMRES) | ||
LINEAR_SOLVER= FGMRES | ||
% | ||
% Preconditioner of the Krylov linear solver (JACOBI, LINELET, LU_SGS) | ||
LINEAR_SOLVER_PREC= LU_SGS | ||
% | ||
% Minimum error of the linear solver for implicit formulations | ||
LINEAR_SOLVER_ERROR= 1E-6 | ||
% | ||
% Max number of iterations of the linear solver for the implicit formulation | ||
LINEAR_SOLVER_ITER= 5 | ||
% | ||
% Relaxation coefficient | ||
LINEAR_SOLVER_RELAX= 1.0 | ||
|
||
% -------------------------- MULTIGRID PARAMETERS -----------------------------% | ||
% | ||
% Multi-Grid Levels (0 = no multi-grid) | ||
MGLEVEL= 3 | ||
% | ||
% Multi-Grid Cycle (0 = V cycle, 1 = W Cycle) | ||
MGCYCLE= 1 | ||
% | ||
% Reduction factor of the CFL coefficient on the coarse levels | ||
MG_CFL_REDUCTION= 0.9 | ||
% | ||
% Maximum number of children in the agglomeration stage | ||
MAX_CHILDREN= 250 | ||
% | ||
% Maximum length of an agglomerated element (compared with the domain) | ||
MAX_DIMENSION= 0.1 | ||
% | ||
% Multi-Grid PreSmoothing Level | ||
MG_PRE_SMOOTH= ( 1, 2, 3, 3 ) | ||
% | ||
% Multi-Grid PostSmoothing 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= 1.0 | ||
% | ||
% Damping factor for the correction prolongation | ||
MG_DAMP_PROLONGATION= 1.0 | ||
|
||
% -------------------- FLOW NUMERICAL METHOD DEFINITION -----------------------% | ||
% | ||
% Convective numerical method (JST, LAX-FRIEDRICH, CUSP, ROE, AUSM, HLLC, | ||
% TURKEL_PREC, MSW) | ||
CONV_NUM_METHOD_FLOW= JST | ||
% | ||
% Spatial numerical order integration (1ST_ORDER, 2ND_ORDER, 2ND_ORDER_LIMITER) | ||
% | ||
SPATIAL_ORDER_FLOW= 2ND_ORDER_LIMITER | ||
% | ||
% Slope limiter (VENKATAKRISHNAN, MINMOD) | ||
SLOPE_LIMITER_FLOW= VENKATAKRISHNAN | ||
% | ||
% 1st, 2nd and 4th order artificial dissipation coefficients | ||
AD_COEFF_FLOW= ( 0.15, 0.5, 0.02 ) | ||
% | ||
% Time discretization (RUNGE-KUTTA_EXPLICIT, EULER_IMPLICIT, EULER_EXPLICIT) | ||
TIME_DISCRE_FLOW= EULER_IMPLICIT | ||
|
||
% ---------------- ADJOINT-FLOW NUMERICAL METHOD DEFINITION -------------------% | ||
% | ||
% Convective numerical method (JST, LAX-FRIEDRICH, ROE) | ||
CONV_NUM_METHOD_ADJFLOW= JST | ||
% | ||
% Spatial numerical order integration (1ST_ORDER, 2ND_ORDER, 2ND_ORDER_LIMITER) | ||
% | ||
SPATIAL_ORDER_ADJFLOW= 2ND_ORDER | ||
% | ||
% Slope limiter (VENKATAKRISHNAN, SHARP_EDGES) | ||
SLOPE_LIMITER_ADJFLOW= VENKATAKRISHNAN | ||
% | ||
% 1st, 2nd, and 4th order artificial dissipation coefficients | ||
AD_COEFF_ADJFLOW= ( 0.15, 0.5, 0.02 ) | ||
% | ||
% Reduction factor of the CFL coefficient in the adjoint problem | ||
CFL_REDUCTION_ADJFLOW= 0.5 | ||
% | ||
% Time discretization (RUNGE-KUTTA_EXPLICIT, EULER_IMPLICIT) | ||
TIME_DISCRE_ADJFLOW= EULER_IMPLICIT | ||
|
||
% --------------------------- PARTITIONING STRATEGY ---------------------------% | ||
% Write a paraview file for each partition (NO, YES) | ||
VISUALIZE_PART= NO | ||
|
||
% ----------------------- DESIGN VARIABLE PARAMETERS --------------------------% | ||
% | ||
% Kind of deformation (FFD_SETTING, FFD_CONTROL_POINT_2D, FFD_CAMBER_2D, FFD_THICKNESS_2D, | ||
% HICKS_HENNE, COSINE_BUMP, PARABOLIC, | ||
% NACA_4DIGITS, DISPLACEMENT, ROTATION, FFD_CONTROL_POINT, | ||
% FFD_DIHEDRAL_ANGLE, FFD_TWIST_ANGLE, FFD_ROTATION, | ||
% FFD_CAMBER, FFD_THICKNESS, SURFACE_FILE, AIRFOIL) | ||
DV_KIND= HICKS_HENNE | ||
% | ||
% Marker of the surface in which we are going apply the shape deformation | ||
DV_MARKER= ( airfoil ) | ||
% | ||
% Parameters of the shape deformation | ||
% - FFD_CONTROL_POINT_2D ( FFD_Box_ID, i_Ind, j_Ind, x_Disp, y_Disp ) | ||
% - FFD_CAMBER_2D ( FFD_Box_ID, i_Ind ) | ||
% - FFD_THICKNESS_2D ( FFD_Box_ID, i_Ind ) | ||
% - HICKS_HENNE ( Lower Surface (0)/Upper Surface (1)/Only one Surface (2), x_Loc ) | ||
% - COSINE_BUMP ( Lower Surface (0)/Upper Surface (1)/Only one Surface (2), x_Loc, x_Size ) | ||
% - FOURIER ( Lower Surface (0)/Upper Surface (1)/Only one Surface (2), index, cos(0)/sin(1) ) | ||
% - SPHERICAL ( ControlPoint_Index, Theta_Disp, R_Disp ) | ||
% - NACA_4DIGITS ( 1st digit, 2nd digit, 3rd and 4th digit ) | ||
% - PARABOLIC ( Center, Thickness ) | ||
% - DISPLACEMENT ( x_Disp, y_Disp, z_Disp ) | ||
% - ROTATION ( x_Orig, y_Orig, z_Orig, x_End, y_End, z_End ) | ||
% - OBSTACLE ( Center, Bump size ) | ||
DV_PARAM= ( 1, 0.5 ) | ||
% | ||
% Value of the shape deformation | ||
DV_VALUE= 0.01 | ||
% | ||
% Surface deformation input filename (SURFACE_FILE DV only) | ||
MOTION_FILENAME= mesh_motion.dat | ||
|
||
% ------------------------ GRID DEFORMATION PARAMETERS ------------------------% | ||
% | ||
% Number of smoothing iterations for FEA mesh deformation | ||
DEFORM_LINEAR_ITER= 500 | ||
% | ||
% Number of nonlinear deformation iterations (surface deformation increments) | ||
DEFORM_NONLINEAR_ITER= 1 | ||
% | ||
% Print the residuals during mesh deformation to the console (YES, NO) | ||
DEFORM_CONSOLE_OUTPUT= YES | ||
% | ||
% Factor to multiply smallest cell volume for deform tolerance (0.001 default) | ||
DEFORM_TOL_FACTOR = 0.001 | ||
% | ||
% Type of element stiffness imposed for FEA mesh deformation (INVERSE_VOLUME, | ||
% WALL_DISTANCE, CONSTANT_STIFFNESS) | ||
DEFORM_STIFFNESS_TYPE= INVERSE_VOLUME | ||
% | ||
% Visualize the deformation (NO, YES) | ||
VISUALIZE_DEFORMATION= NO | ||
% | ||
% Divide elements into triangles and tetrahedra (NO, YES) | ||
DIVIDE_ELEMENTS= NO | ||
|
||
% --------------------------- CONVERGENCE PARAMETERS --------------------------% | ||
% Convergence criteria (CAUCHY, RESIDUAL) | ||
% | ||
CONV_CRITERIA= CAUCHY | ||
% | ||
% Residual reduction (order of magnitude with respect to the initial value) | ||
RESIDUAL_REDUCTION= 6 | ||
% | ||
% Min value of the residual (log10 of the residual) | ||
RESIDUAL_MINVAL= -8 | ||
% | ||
% Start Cauchy 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-6 | ||
% | ||
% Function to apply the criteria (LIFT, DRAG, SENS_GEOMETRY, SENS_MACH, | ||
% DELTA_LIFT, DELTA_DRAG) | ||
CAUCHY_FUNC_FLOW= DRAG | ||
|
||
% ------------------------- INPUT/OUTPUT INFORMATION --------------------------% | ||
% Mesh input file | ||
MESH_FILENAME= mesh_NACA0012_inv.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 | ||
% | ||
% Restart adjoint input file | ||
SOLUTION_ADJ_FILENAME= solution_adj.dat | ||
% | ||
% Output file format (TECPLOT, PARAVIEW, TECPLOT_BINARY) | ||
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) | ||
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= 250 | ||
% | ||
% Writing convergence history frequency | ||
WRT_CON_FREQ= 1 | ||
|
||
% --------------------- OPTIMAL SHAPE DESIGN DEFINITION -----------------------% | ||
% Available flow based objective functions or constraint functions | ||
% DRAG, LIFT, SIDEFORCE, EFFICIENCY, | ||
% FORCE_X, FORCE_Y, FORCE_Z, | ||
% MOMENT_X, MOMENT_Y, MOMENT_Z, | ||
% THRUST, TORQUE, FIGURE_OF_MERIT, | ||
% EQUIVALENT_AREA, NEARFIELD_PRESSURE, | ||
% TOTAL_HEATFLUX, MAXIMUM_HEATFLUX, | ||
% INVERSE_DESIGN_PRESSURE, INVERSE_DESIGN_HEATFLUX, | ||
% FREE_SURFACE | ||
% | ||
% Available geometrical based objective functions or constraint functions | ||
% MAX_THICKNESS, 1/4_THICKNESS, 1/2_THICKNESS, 3/4_THICKNESS, AREA, AOA, CHORD, | ||
% MAX_THICKNESS_SEC1, MAX_THICKNESS_SEC2, MAX_THICKNESS_SEC3, MAX_THICKNESS_SEC4, MAX_THICKNESS_SEC5, | ||
% 1/4_THICKNESS_SEC1, 1/4_THICKNESS_SEC2, 1/4_THICKNESS_SEC3, 1/4_THICKNESS_SEC4, 1/4_THICKNESS_SEC5, | ||
% 1/2_THICKNESS_SEC1, 1/2_THICKNESS_SEC2, 1/2_THICKNESS_SEC3, 1/2_THICKNESS_SEC4, 1/2_THICKNESS_SEC5, | ||
% 3/4_THICKNESS_SEC1, 3/4_THICKNESS_SEC2, 3/4_THICKNESS_SEC3, 3/4_THICKNESS_SEC4, 3/4_THICKNESS_SEC5, | ||
% AREA_SEC1, AREA_SEC2, AREA_SEC3, AREA_SEC4, AREA_SEC5, | ||
% AOA_SEC1, AOA_SEC2, AOA_SEC3, AOA_SEC4, AOA_SEC5, | ||
% CHORD_SEC1, CHORD_SEC2, CHORD_SEC3, CHORD_SEC4, CHORD_SEC5 | ||
% | ||
% Available design variables | ||
% HICKS_HENNE ( 1, Scale | Mark. List | Lower(0)/Upper(1) side, x_Loc ) | ||
% COSINE_BUMP ( 2, Scale | Mark. List | Lower(0)/Upper(1) side, x_Loc, x_Size ) | ||
% SPHERICAL ( 3, Scale | Mark. List | ControlPoint_Index, Theta_Disp, R_Disp ) | ||
% NACA_4DIGITS ( 4, Scale | Mark. List | 1st digit, 2nd digit, 3rd and 4th digit ) | ||
% DISPLACEMENT ( 5, Scale | Mark. List | x_Disp, y_Disp, z_Disp ) | ||
% ROTATION ( 6, Scale | Mark. List | x_Axis, y_Axis, z_Axis, x_Turn, y_Turn, z_Turn ) | ||
% FOURIER ( 14, Scale | Mark. List | Lower(0)/Upper(1) side, index, cos(0)/sin(1) ) | ||
% FFD_CONTROL_POINT_2D ( 15, Scale | Mark. List | FFD_Box_ID, i_Ind, j_Ind, x_Mov, y_Mov ) | ||
% FFD_CAMBER_2D ( 16, Scale | Mark. List | FFD_Box_ID, i_Ind ) | ||
% FFD_THICKNESS_2D ( 17, Scale | Mark. List | FFD_Box_ID, i_Ind ) | ||
% | ||
% Optimization objective function with scaling factor | ||
% ex= Objective * Scale | ||
OPT_OBJECTIVE= DRAG * 0.001 | ||
% | ||
% Optimization constraint functions with scaling factors, separated by semicolons | ||
% ex= (Objective = Value ) * Scale, use '>','<','=' | ||
OPT_CONSTRAINT= ( LIFT > 0.328188 ) * 0.001; ( MOMENT_Z > 0.034068 ) * 0.001; ( MAX_THICKNESS > 0.11 ) * 0.001 | ||
% | ||
% Optimization design variables, separated by semicolons | ||
DEFINITION_DV= ( 1, 1.0 | airfoil | 0, 0.05 ); ( 1, 1.0 | airfoil | 0, 0.10 ); ( 1, 1.0 | airfoil | 0, 0.15 ); ( 1, 1.0 | airfoil | 0, 0.20 ); ( 1, 1.0 | airfoil | 0, 0.25 ); ( 1, 1.0 | airfoil | 0, 0.30 ); ( 1, 1.0 | airfoil | 0, 0.35 ); ( 1, 1.0 | airfoil | 0, 0.40 ); ( 1, 1.0 | airfoil | 0, 0.45 ); ( 1, 1.0 | airfoil | 0, 0.50 ); ( 1, 1.0 | airfoil | 0, 0.55 ); ( 1, 1.0 | airfoil | 0, 0.60 ); ( 1, 1.0 | airfoil | 0, 0.65 ); ( 1, 1.0 | airfoil | 0, 0.70 ); ( 1, 1.0 | airfoil | 0, 0.75 ); ( 1, 1.0 | airfoil | 0, 0.80 ); ( 1, 1.0 | airfoil | 0, 0.85 ); ( 1, 1.0 | airfoil | 0, 0.90 ); ( 1, 1.0 | airfoil | 0, 0.95 ); ( 1, 1.0 | airfoil | 1, 0.05 ); ( 1, 1.0 | airfoil | 1, 0.10 ); ( 1, 1.0 | airfoil | 1, 0.15 ); ( 1, 1.0 | airfoil | 1, 0.20 ); ( 1, 1.0 | airfoil | 1, 0.25 ); ( 1, 1.0 | airfoil | 1, 0.30 ); ( 1, 1.0 | airfoil | 1, 0.35 ); ( 1, 1.0 | airfoil | 1, 0.40 ); ( 1, 1.0 | airfoil | 1, 0.45 ); ( 1, 1.0 | airfoil | 1, 0.50 ); ( 1, 1.0 | airfoil | 1, 0.55 ); ( 1, 1.0 | airfoil | 1, 0.60 ); ( 1, 1.0 | airfoil | 1, 0.65 ); ( 1, 1.0 | airfoil | 1, 0.70 ); ( 1, 1.0 | airfoil | 1, 0.75 ); ( 1, 1.0 | airfoil | 1, 0.80 ); ( 1, 1.0 | airfoil | 1, 0.85 ); ( 1, 1.0 | airfoil | 1, 0.90 ); ( 1, 1.0 | airfoil | 1, 0.95 ) |
Oops, something went wrong.