CFD Online Logo CFD Online URL
www.cfd-online.com
[Sponsors]
Home > Forums > Software User Forums > SU2

Problem Implementing Internal Surfaces in SU2

Register Blogs Community New Posts Updated Threads Search

Reply
 
LinkBack Thread Tools Search this Thread Display Modes
Old   August 6, 2024, 17:21
Default Problem Implementing Internal Surfaces in SU2
  #1
New Member
 
PA
Join Date: Dec 2018
Posts: 4
Rep Power: 7
gkhokhar is on a distinguished road
Hello Everyone,

I’m having an issue implementing internal surfaces in SU2. (See attached figures.)

I have a simple channel geometry that runs with no issues as expected. However, when I define two internal boundaries, “internal1” and “internal2”, without changing anything else in the simulation, the simulation mysteriously crashes after about 20 or so iterations.

This is the marker that I’m using:

MARKER_INTERNAL= ( internal1, internal2 )

I’m not sure what I’m doing incorrectly. Can someone please assist me with this?

Both meshes, and the .cfg file I’m using along with a few images for reference can be found using the following Dropbox link:

https://www.dropbox.com/scl/fo/3zu5m...wabrdftyc&dl=0

Any assistance would be greatly appreciated.


The .cfg file I'm using is pasted here for convenience:


%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%

% ------------- DIRECT, ADJOINT, AND LINEARIZED PROBLEM DEFINITION ------------%
%
% Physical governing equations (EULER, NAVIER_STOKES,
% WAVE_EQUATION, HEAT_EQUATION, FEM_ELASTICITY,
% POISSON_EQUATION)
SOLVER= RANS
%
% If Navier-Stokes, kind of turbulent model (NONE, SA, SA_NEG, SST)
KIND_TURB_MODEL= SST
%
% Mathematical problem (DIRECT, CONTINUOUS_ADJOINT)
MATH_PROBLEM= DIRECT
%
% Restart solution (NO, YES)
RESTART_SOL= NO

AXISYMMETRIC= YES

CUSTOM_OUTPUTS= 'velocity : Macro{sqrt(pow(VELOCITY_X, 2))};\
avg_vel_in : MassFlowAvg{$velocity}[farfield];\
avg_vel_out : MassFlowAvg{$velocity}[exit]'

SCREEN_OUTPUT= INNER_ITER, RMS_DENSITY, LINSOL_RESIDUAL,\
avg_vel_in, avg_vel_out

HISTORY_OUTPUT = ITER, AERO_COEFF, FLOW_COEFF, FLOW_COEFF_SURF,CUSTOM,


FLUID_MODEL= STANDARD_AIR


% -------------------- COMPRESSIBLE FREE-STREAM DEFINITION --------------------%
%
% Mach number (non-dimensional, based on the free-stream values)
MACH_NUMBER= 0.2
%
% Angle of attack (degrees, only for compressible flows)
AOA= 0.0
%
% Side-slip angle (degrees, only for compressible flows)
SIDESLIP_ANGLE= 0.0
%
% Free-stream pressure (101325.0 N/m^2 by default)
FREESTREAM_PRESSURE= 101300.0
%
% Free-stream temperature (288.15 K by default)
FREESTREAM_TEMPERATURE= 288

MARKER_FAR = ( farfield )


INIT_OPTION= TD_CONDITIONS

% ---------------------- 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= 1.0
%
% Reference area for force coefficients (0 implies automatic calculation)
REF_AREA= 1.0

% -------------------- BOUNDARY CONDITION DEFINITION --------------------------%
%
MARKER_HEATFLUX= ( wall, 0.0 )
%
% Inlet boundary type (TOTAL_CONDITIONS, MASS_FLOW)
INLET_TYPE= TOTAL_CONDITIONS

%MARKER_INLET= ( farfield, 288.6, 102010.0, 1.0, 0.0, 0.0 )

MARKER_INTERNAL= ( internal1, internal2 )

MARKER_OUTLET= ( exit, 90000 )

% ------------------------ SURFACES IDENTIFICATION ----------------------------%
%
% Marker(s) of the surface to be plotted or designed
MARKER_PLOTTING= ( wall )
%
% Marker(s) of the surface where the functional (Cd, Cl, etc.) will be evaluated
MARKER_MONITORING= ( wall )

% ------------- COMMON PARAMETERS DEFINING THE NUMERICAL METHOD ---------------%
%
% Numerical method for spatial gradients (GREEN_GAUSS, WEIGHTED_LEAST_SQUARES)
NUM_METHOD_GRAD= GREEN_GAUSS
%NUM_METHOD_GRAD= WEIGHTED_LEAST_SQUARES
%
% Courant-Friedrichs-Lewy condition of the finest grid
CFL_NUMBER= 5
%
% 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= ( 0.1, 2.0, 50.0, 1e10 )
%
% Runge-Kutta alpha coefficients
RK_ALPHA_COEFF= ( 0.66667, 0.66667, 1.000000 )
%
% Number of total iterations
ITER= 999999

%MUSCL_FLOW= YES

% ------------------------ LINEAR SOLVER DEFINITION ---------------------------%
%
% Linear solver for implicit formulations (BCGSTAB, FGMRES)
LINEAR_SOLVER= FGMRES
%
% Preconditioner of the Krylov linear solver (ILU, JACOBI, LINELET, LU_SGS)
LINEAR_SOLVER_PREC= ILU
%
% Minimum error of the linear solver for implicit formulations
LINEAR_SOLVER_ERROR= 1E-10
%
% Max number of iterations of the linear solver for the implicit formulation
LINEAR_SOLVER_ITER= 20

% -------------------------- MULTIGRID PARAMETERS -----------------------------%
%
% Multi-Grid Levels (0 = no multi-grid)
MGLEVEL= 0
%
% Multi-grid cycle (V_CYCLE, W_CYCLE, FULLMG_CYCLE)
MGCYCLE= W_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= 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
%
% 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

% -------------------- 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 (VENKATAKRISHNAN, MINMOD)
SLOPE_LIMITER_TURB= VENKATAKRISHNAN
%
% Time discretization (EULER_IMPLICIT)
TIME_DISCRE_TURB= EULER_IMPLICIT

% --------------------------- CONVERGENCE PARAMETERS --------------------------%
%
% Convergence criteria (CAUCHY, RESIDUAL)
CONV_FIELD= RMS_DENSITY
%
% Min value of the residual (log10 of the residual)
CONV_RESIDUAL_MINVAL= -7
%
% Start convergence criteria at iteration number
CONV_STARTITER= 10
%
% Number of elements to apply the criteria
CONV_CAUCHY_ELEMS= 100
%
% Epsilon to control the series convergence
CONV_CAUCHY_EPS= 1E-10

% ------------------------- INPUT/OUTPUT INFORMATION --------------------------%
%
% Mesh input file

MESH_FILENAME= Channel_With_Internal1_Internal2.su2
%MESH_FILENAME= Channel_Without_Internal1_Internal2.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_FILENAME= restart_flow10078588.dat
%
%
% Output file format (PARAVIEW, TECPLOT, STL)
TABULAR_FORMAT= TECPLOT
%
% Output file convergence history (w/o extension)
CONV_FILENAME= history
%
% Output file restart flow
RESTART_FILENAME= restart_flow.dat
%
% Output file restart adjoint
RESTART_ADJ_FILENAME= restart_adj.dat
%
% Output file flow (w/o extension) variables
VOLUME_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_FILENAME= surface_flow
%
% Output file surface adjoint coefficient (w/o extension)
SURFACE_ADJ_FILENAME= surface_adjoint
%
Attached Images
File Type: jpg ReferenceImage1.jpg (124.7 KB, 10 views)
File Type: png ReferenceImage2.png (44.7 KB, 4 views)
gkhokhar is offline   Reply With Quote

Old   August 7, 2024, 04:16
Default
  #2
Senior Member
 
bigfoot
Join Date: Dec 2011
Location: Netherlands
Posts: 601
Rep Power: 18
bigfootedrockmidget is on a distinguished road
This sounds like a bug, maybe we forgot to disable something in the special case of internal markers.
Could you create a github issue for it?
https://github.com/su2code/SU2/issues
bigfootedrockmidget is offline   Reply With Quote

Old   September 13, 2024, 23:34
Default
  #3
New Member
 
zs
Join Date: Mar 2024
Posts: 5
Rep Power: 2
ShengZhang is on a distinguished road
Quote:
Originally Posted by bigfootedrockmidget View Post
This sounds like a bug, maybe we forgot to disable something in the special case of internal markers.
Could you create a github issue for it?
https://github.com/su2code/SU2/issues
Hi, Mr. bigfootedrockmidget, may I ask if this issue has been resolved?
I also encountered the same problem, where I took a internal monitoring surface, but it diverged at 200 steps.
ShengZhang is offline   Reply With Quote

Old   September 17, 2024, 03:26
Default
  #4
Senior Member
 
bigfoot
Join Date: Dec 2011
Location: Netherlands
Posts: 601
Rep Power: 18
bigfootedrockmidget is on a distinguished road
Are you using the RANS solver like the OP or another solver? and which version of SU2 are you using?
I did not look into this yet. If you are stuck, and you only need an interface for monitoring purposes, you can in the mean time work with paraview and postprocess the paraview results. Or if you need only point data or data on other existing markers, you can use the macro functionality.
bigfootedrockmidget is offline   Reply With Quote

Old   Yesterday, 08:39
Default
  #5
New Member
 
zs
Join Date: Mar 2024
Posts: 5
Rep Power: 2
ShengZhang is on a distinguished road
Quote:
Originally Posted by bigfootedrockmidget View Post
Are you using the RANS solver like the OP or another solver? and which version of SU2 are you using?
I did not look into this yet. If you are stuck, and you only need an interface for monitoring purposes, you can in the mean time work with paraview and postprocess the paraview results. Or if you need only point data or data on other existing markers, you can use the macro functionality.
Thank you for your help and answer. I believe there is no problem with setting up the RANS solver. When there is no internal1, the calculation converges. Once the MARKER_INTERNAL=(internal1) is set, the calculation diverges.
I want to set an internal cross-section for the optimization objective calculation during the optimization process, such as internal1, which is set in config of MARKER_ANALYZE=(internal1). Before that, we need to solve the flow field. Unfortunately, the calculations have been diverging.
ShengZhang is offline   Reply With Quote

Reply


Posting Rules
You may not post new threads
You may not post replies
You may not post attachments
You may not edit your posts

BB code is On
Smilies are On
[IMG] code is On
HTML code is Off
Trackbacks are Off
Pingbacks are On
Refbacks are On


Similar Threads
Thread Thread Starter Forum Replies Last Post
Tag an internal marker in SU2 akshaydeshpande SU2 1 September 2, 2019 13:28
Pitching and Plunging problem in SU2 albinjohny SU2 Shape Design 1 July 5, 2015 01:54
[snappyHexMesh] Boundary Patch definition on Thin Surfaces / Internal Walls in SnappyHex Hannes_Kiel OpenFOAM Meshing & Mesh Conversion 4 August 27, 2013 01:06
Can SU2 solve the blast wave problem? newmancfd SU2 2 May 13, 2013 03:33
Problem in implementing cht tilek CFX 3 May 8, 2011 08:39


All times are GMT -4. The time now is 20:46.