Skip to content

Commit

Permalink
Merge pull request #1404 from su2code/minor_chores
Browse files Browse the repository at this point in the history
Minor chores: TURB_MODEL now enum class.
  • Loading branch information
TobiKattmann authored Oct 19, 2021
2 parents 680fb8b + b423073 commit d8cfe78
Show file tree
Hide file tree
Showing 42 changed files with 388 additions and 384 deletions.
4 changes: 2 additions & 2 deletions Common/include/CConfig.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -554,7 +554,7 @@ class CConfig {
STRUCT_DEFORMATION Kind_Struct_Solver; /*!< \brief Determines the geometric condition (small or large deformations) for structural analysis. */
unsigned short Kind_DV_FEA; /*!< \brief Kind of Design Variable for FEA problems.*/

unsigned short Kind_Turb_Model; /*!< \brief Turbulent model definition. */
TURB_MODEL Kind_Turb_Model; /*!< \brief Turbulent model definition. */
unsigned short Kind_SGS_Model; /*!< \brief LES SGS model definition. */
unsigned short Kind_Trans_Model, /*!< \brief Transition model definition. */
Kind_ActDisk, Kind_Engine_Inflow,
Expand Down Expand Up @@ -4162,7 +4162,7 @@ class CConfig {
* \brief Get the kind of the turbulence model.
* \return Kind of the turbulence model.
*/
unsigned short GetKind_Turb_Model(void) const { return Kind_Turb_Model; }
TURB_MODEL GetKind_Turb_Model(void) const { return Kind_Turb_Model; }

/*!
* \brief Get the kind of the transition model.
Expand Down
38 changes: 19 additions & 19 deletions Common/include/option_structure.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -888,25 +888,25 @@ static const MapType<std::string, ENUM_LIMITER> Limiter_Map = {
/*!
* \brief Types of turbulent models
*/
enum ENUM_TURB_MODEL {
NO_TURB_MODEL = 0, /*!< \brief No turbulence model. */
SA = 1, /*!< \brief Kind of Turbulent model (Spalart-Allmaras). */
SA_NEG = 2, /*!< \brief Kind of Turbulent model (Spalart-Allmaras). */
SA_E = 3, /*!< \brief Kind of Turbulent model (Spalart-Allmaras Edwards). */
SA_COMP = 4, /*!< \brief Kind of Turbulent model (Spalart-Allmaras Compressibility Correction). */
SA_E_COMP = 5, /*!< \brief Kind of Turbulent model (Spalart-Allmaras Edwards with Compressibility Correction). */
SST = 6, /*!< \brief Kind of Turbulence model (Menter SST). */
SST_SUST = 7 /*!< \brief Kind of Turbulence model (Menter SST with sustaining terms for free-stream preservation). */
};
static const MapType<std::string, ENUM_TURB_MODEL> Turb_Model_Map = {
MakePair("NONE", NO_TURB_MODEL)
MakePair("SA", SA)
MakePair("SA_NEG", SA_NEG)
MakePair("SA_E", SA_E)
MakePair("SA_COMP", SA_COMP)
MakePair("SA_E_COMP", SA_E_COMP)
MakePair("SST", SST)
MakePair("SST_SUST", SST_SUST)
enum class TURB_MODEL {
NONE, /*!< \brief No turbulence model. */
SA, /*!< \brief Kind of Turbulent model (Spalart-Allmaras). */
SA_NEG, /*!< \brief Kind of Turbulent model (Spalart-Allmaras). */
SA_E, /*!< \brief Kind of Turbulent model (Spalart-Allmaras Edwards). */
SA_COMP, /*!< \brief Kind of Turbulent model (Spalart-Allmaras Compressibility Correction). */
SA_E_COMP, /*!< \brief Kind of Turbulent model (Spalart-Allmaras Edwards with Compressibility Correction). */
SST, /*!< \brief Kind of Turbulence model (Menter SST). */
SST_SUST /*!< \brief Kind of Turbulence model (Menter SST with sustaining terms for free-stream preservation). */
};
static const MapType<std::string, TURB_MODEL> Turb_Model_Map = {
MakePair("NONE", TURB_MODEL::NONE)
MakePair("SA", TURB_MODEL::SA)
MakePair("SA_NEG", TURB_MODEL::SA_NEG)
MakePair("SA_E", TURB_MODEL::SA_E)
MakePair("SA_COMP", TURB_MODEL::SA_COMP)
MakePair("SA_E_COMP", TURB_MODEL::SA_E_COMP)
MakePair("SST", TURB_MODEL::SST)
MakePair("SST_SUST", TURB_MODEL::SST_SUST)
};

/*!
Expand Down
4 changes: 1 addition & 3 deletions Common/include/option_structure.inl
Original file line number Diff line number Diff line change
Expand Up @@ -1889,7 +1889,7 @@ public:
this->doubleInfo[i] = new su2double[1];

/* Check for a valid RANS turbulence model. */
map<string, ENUM_TURB_MODEL>::const_iterator iit;
map<string, TURB_MODEL>::const_iterator iit;
iit = Turb_Model_Map.find(option_value[counter++]);
if(iit == Turb_Model_Map.end()) {
string newstring;
Expand All @@ -1904,8 +1904,6 @@ public:
return newstring;
}

this->intInfo[i][0] = iit->second;

/* Extract the exchange distance. */
istringstream ss_1st(option_value[counter++]);
if (!(ss_1st >> this->doubleInfo[i][0])) {
Expand Down
35 changes: 18 additions & 17 deletions Common/src/CConfig.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -1076,7 +1076,7 @@ void CConfig::SetConfig_Options() {
/*!\brief MATH_PROBLEM \n DESCRIPTION: Mathematical problem \n Options: DIRECT, ADJOINT \ingroup Config*/
addMathProblemOption("MATH_PROBLEM", ContinuousAdjoint, false, DiscreteAdjoint, discAdjDefault, Restart_Flow, discAdjDefault);
/*!\brief KIND_TURB_MODEL \n DESCRIPTION: Specify turbulence model \n Options: see \link Turb_Model_Map \endlink \n DEFAULT: NO_TURB_MODEL \ingroup Config*/
addEnumOption("KIND_TURB_MODEL", Kind_Turb_Model, Turb_Model_Map, NO_TURB_MODEL);
addEnumOption("KIND_TURB_MODEL", Kind_Turb_Model, Turb_Model_Map, TURB_MODEL::NONE);
/*!\brief KIND_TRANS_MODEL \n DESCRIPTION: Specify transition model OPTIONS: see \link Trans_Model_Map \endlink \n DEFAULT: NO_TRANS_MODEL \ingroup Config*/
addEnumOption("KIND_TRANS_MODEL", Kind_Trans_Model, Trans_Model_Map, NO_TRANS_MODEL);

Expand Down Expand Up @@ -3273,16 +3273,16 @@ void CConfig::SetPostprocessing(SU2_COMPONENT val_software, unsigned short val_i
}
}

if (Kind_Solver == NAVIER_STOKES && Kind_Turb_Model != NONE){
if (Kind_Solver == NAVIER_STOKES && Kind_Turb_Model != TURB_MODEL::NONE){
SU2_MPI::Error("KIND_TURB_MODEL must be NONE if SOLVER= NAVIER_STOKES", CURRENT_FUNCTION);
}
if (Kind_Solver == INC_NAVIER_STOKES && Kind_Turb_Model != NONE){
if (Kind_Solver == INC_NAVIER_STOKES && Kind_Turb_Model != TURB_MODEL::NONE){
SU2_MPI::Error("KIND_TURB_MODEL must be NONE if SOLVER= INC_NAVIER_STOKES", CURRENT_FUNCTION);
}
if (Kind_Solver == RANS && Kind_Turb_Model == NONE){
if (Kind_Solver == RANS && Kind_Turb_Model == TURB_MODEL::NONE){
SU2_MPI::Error("A turbulence model must be specified with KIND_TURB_MODEL if SOLVER= RANS", CURRENT_FUNCTION);
}
if (Kind_Solver == INC_RANS && Kind_Turb_Model == NONE){
if (Kind_Solver == INC_RANS && Kind_Turb_Model == TURB_MODEL::NONE){
SU2_MPI::Error("A turbulence model must be specified with KIND_TURB_MODEL if SOLVER= INC_RANS", CURRENT_FUNCTION);
}

Expand Down Expand Up @@ -4043,18 +4043,18 @@ void CConfig::SetPostprocessing(SU2_COMPONENT val_software, unsigned short val_i
if (MGCycle == FULLMG_CYCLE) FinestMesh = nMGLevels;

if ((Kind_Solver == NAVIER_STOKES) &&
(Kind_Turb_Model != NONE))
(Kind_Turb_Model != TURB_MODEL::NONE))
Kind_Solver = RANS;

if ((Kind_Solver == INC_NAVIER_STOKES) &&
(Kind_Turb_Model != NONE))
(Kind_Turb_Model != TURB_MODEL::NONE))
Kind_Solver = INC_RANS;

if (Kind_Solver == EULER ||
Kind_Solver == INC_EULER ||
Kind_Solver == NEMO_EULER ||
Kind_Solver == FEM_EULER)
Kind_Turb_Model = NONE;
Kind_Turb_Model = TURB_MODEL::NONE;

Kappa_2nd_Flow = jst_coeff[0];
Kappa_4th_Flow = jst_coeff[1];
Expand Down Expand Up @@ -4435,7 +4435,7 @@ void CConfig::SetPostprocessing(SU2_COMPONENT val_software, unsigned short val_i
for (int i=0; i<7; ++i) eng_cyl[i] /= 12.0;
}

if ((Kind_Turb_Model != SA) && (Kind_Trans_Model == BC)){
if ((Kind_Turb_Model != TURB_MODEL::SA) && (Kind_Trans_Model == BC)){
SU2_MPI::Error("BC transition model currently only available in combination with SA turbulence model!", CURRENT_FUNCTION);
}

Expand Down Expand Up @@ -4533,7 +4533,7 @@ void CConfig::SetPostprocessing(SU2_COMPONENT val_software, unsigned short val_i

/* --- Throw error if UQ used for any turbulence model other that SST --- */

if (Kind_Solver == RANS && Kind_Turb_Model != SST && Kind_Turb_Model != SST_SUST && using_uq){
if (Kind_Solver == RANS && Kind_Turb_Model != TURB_MODEL::SST && Kind_Turb_Model != TURB_MODEL::SST_SUST && using_uq){
SU2_MPI::Error("UQ capabilities only implemented for NAVIER_STOKES solver SST turbulence model", CURRENT_FUNCTION);
}

Expand Down Expand Up @@ -5620,13 +5620,14 @@ void CConfig::SetOutput(SU2_COMPONENT val_software, unsigned short val_izone) {
if (Kind_Regime == ENUM_REGIME::INCOMPRESSIBLE) cout << "Incompressible RANS equations." << endl;
cout << "Turbulence model: ";
switch (Kind_Turb_Model) {
case SA: cout << "Spalart Allmaras" << endl; break;
case SA_NEG: cout << "Negative Spalart Allmaras" << endl; break;
case SA_E: cout << "Edwards Spalart Allmaras" << endl; break;
case SA_COMP: cout << "Compressibility Correction Spalart Allmaras" << endl; break;
case SA_E_COMP: cout << "Compressibility Correction Edwards Spalart Allmaras" << endl; break;
case SST: cout << "Menter's SST" << endl; break;
case SST_SUST: cout << "Menter's SST with sustaining terms" << endl; break;
case TURB_MODEL::NONE: break;
case TURB_MODEL::SA: cout << "Spalart Allmaras" << endl; break;
case TURB_MODEL::SA_NEG: cout << "Negative Spalart Allmaras" << endl; break;
case TURB_MODEL::SA_E: cout << "Edwards Spalart Allmaras" << endl; break;
case TURB_MODEL::SA_COMP: cout << "Compressibility Correction Spalart Allmaras" << endl; break;
case TURB_MODEL::SA_E_COMP: cout << "Compressibility Correction Edwards Spalart Allmaras" << endl; break;
case TURB_MODEL::SST: cout << "Menter's SST" << endl; break;
case TURB_MODEL::SST_SUST: cout << "Menter's SST with sustaining terms" << endl; break;
}
if (QCR) cout << "Using Quadratic Constitutive Relation, 2000 version (QCR2000)" << endl;
if (Kind_Trans_Model == BC) cout << "Using the revised BC transition model (2020)" << endl;
Expand Down
2 changes: 1 addition & 1 deletion SU2_CFD/include/output/CAdjFlowCompOutput.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -39,7 +39,7 @@ class CAdjFlowCompOutput final: public COutput {

bool cont_adj; /*!< \brief Boolean indicating whether we run a cont. adjoint problem */
bool frozen_visc; /*!< \brief Boolean indicating whether frozen viscosity/turbulence is used. */
unsigned short turb_model; /*!< \brief The kind of turbulence model*/
TURB_MODEL turb_model; /*!< \brief The kind of turbulence model*/

public:

Expand Down
2 changes: 1 addition & 1 deletion SU2_CFD/include/output/CAdjFlowIncOutput.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -37,7 +37,7 @@
class CAdjFlowIncOutput final: public COutput {
private:

unsigned short turb_model; /*!< \brief The kind of turbulence model*/
TURB_MODEL turb_model; /*!< \brief The kind of turbulence model*/
RADIATION_MODEL rad_model; /*!< \brief The kind of radiation model */
bool heat; /*!< \brief Boolean indicating whether have a heat problem*/
bool weakly_coupled_heat; /*!< \brief Boolean indicating whether have a weakly coupled heat equation*/
Expand Down
2 changes: 1 addition & 1 deletion SU2_CFD/include/output/CFlowCompFEMOutput.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -39,7 +39,7 @@ class CVariable;
class CFlowCompFEMOutput final: public CFlowOutput {
private:

unsigned short turb_model; //!< Kind of turbulence model
TURB_MODEL turb_model; //!< Kind of turbulence model

public:

Expand Down
2 changes: 1 addition & 1 deletion SU2_CFD/include/output/CFlowCompOutput.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -39,7 +39,7 @@ class CVariable;
class CFlowCompOutput final: public CFlowOutput {
private:

unsigned short turb_model; //!< Kind of turbulence model
TURB_MODEL turb_model; //!< Kind of turbulence model

public:

Expand Down
2 changes: 1 addition & 1 deletion SU2_CFD/include/output/CFlowIncOutput.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -39,7 +39,7 @@ class CVariable;
class CFlowIncOutput final: public CFlowOutput {
private:

unsigned short turb_model; /*!< \brief The kind of turbulence model*/
TURB_MODEL turb_model; /*!< \brief The kind of turbulence model*/
bool heat; /*!< \brief Boolean indicating whether have a heat problem*/
bool weakly_coupled_heat; /*!< \brief Boolean indicating whether have a weakly coupled heat equation*/
unsigned short streamwisePeriodic; /*!< \brief Boolean indicating whether it is a streamwise periodic simulation. */
Expand Down
6 changes: 3 additions & 3 deletions SU2_CFD/include/output/CNEMOCompOutput.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -38,9 +38,9 @@ class CVariable;
class CNEMOCompOutput final: public CFlowOutput {
private:

unsigned short turb_model, /*!< \brief Kind of turbulence model */
iSpecies, /*!< \brief Species index */
nSpecies; /*!< \brief Number of species */
TURB_MODEL turb_model; /*!< \brief Kind of turbulence model */
unsigned short iSpecies, /*!< \brief Species index */
nSpecies; /*!< \brief Number of species */
public:

/*!
Expand Down
16 changes: 8 additions & 8 deletions SU2_CFD/include/solvers/CFVMFlowSolverBase.inl
Original file line number Diff line number Diff line change
Expand Up @@ -406,8 +406,8 @@ void CFVMFlowSolverBase<V, R>::Viscous_Residual_impl(unsigned long iEdge, CGeome
CNumerics *numerics, CConfig *config) {

const bool implicit = (config->GetKind_TimeIntScheme() == EULER_IMPLICIT);
const bool tkeNeeded = (config->GetKind_Turb_Model() == SST) ||
(config->GetKind_Turb_Model() == SST_SUST);
const bool tkeNeeded = (config->GetKind_Turb_Model() == TURB_MODEL::SST) ||
(config->GetKind_Turb_Model() == TURB_MODEL::SST_SUST);

CVariable* turbNodes = nullptr;
if (tkeNeeded) turbNodes = solver_container[TURB_SOL]->GetNodes();
Expand Down Expand Up @@ -726,15 +726,15 @@ void CFVMFlowSolverBase<V, R>::LoadRestart_impl(CGeometry **geometry, CSolver **

unsigned short iDim, iVar, iMesh;
unsigned long iPoint, index, iChildren, Point_Fine;
unsigned short turb_model = config->GetKind_Turb_Model();
TURB_MODEL turb_model = config->GetKind_Turb_Model();
su2double Area_Children, Area_Parent;
const su2double* Solution_Fine = nullptr;
const passivedouble* Coord = nullptr;
bool dual_time = ((config->GetTime_Marching() == TIME_MARCHING::DT_STEPPING_1ST) ||
(config->GetTime_Marching() == TIME_MARCHING::DT_STEPPING_2ND));
bool static_fsi = ((config->GetTime_Marching() == TIME_MARCHING::STEADY) && config->GetFSI_Simulation());
bool steady_restart = config->GetSteadyRestart();
bool turbulent = (config->GetKind_Turb_Model() != NONE);
bool turbulent = (config->GetKind_Turb_Model() != TURB_MODEL::NONE);

string restart_filename = config->GetFilename(config->GetSolution_FileName(), "", iter);

Expand All @@ -751,7 +751,7 @@ void CFVMFlowSolverBase<V, R>::LoadRestart_impl(CGeometry **geometry, CSolver **
(that could appear in the restart file before the grid velocities). ---*/
unsigned short turbVars = 0;
if (turbulent){
if ((turb_model == SST) || (turb_model == SST_SUST)) turbVars = 2;
if ((turb_model == TURB_MODEL::SST) || (turb_model == TURB_MODEL::SST_SUST)) turbVars = 2;
else turbVars = 1;
}

Expand Down Expand Up @@ -946,7 +946,7 @@ void CFVMFlowSolverBase<V, R>::SetInitialCondition(CGeometry **geometry, CSolver
CConfig *config, unsigned long TimeIter) {

const bool restart = (config->GetRestart() || config->GetRestart_Flow());
const bool rans = (config->GetKind_Turb_Model() != NONE);
const bool rans = (config->GetKind_Turb_Model() != TURB_MODEL::NONE);
const bool dual_time = ((config->GetTime_Marching() == TIME_MARCHING::DT_STEPPING_1ST) ||
(config->GetTime_Marching() == TIME_MARCHING::DT_STEPPING_2ND));

Expand Down Expand Up @@ -1266,7 +1266,7 @@ void CFVMFlowSolverBase<V, R>::BC_Sym_Plane(CGeometry* geometry, CSolver** solve
visc_numerics->SetPrimVarGradient(nodes->GetGradient_Primitive(iPoint), CMatrixView<su2double>(Grad_Reflected));

/*--- Turbulent kinetic energy. ---*/
if ((config->GetKind_Turb_Model() == SST) || (config->GetKind_Turb_Model() == SST_SUST))
if ((config->GetKind_Turb_Model() == TURB_MODEL::SST) || (config->GetKind_Turb_Model() == TURB_MODEL::SST_SUST))
visc_numerics->SetTurbKineticEnergy(solver_container[TURB_SOL]->GetNodes()->GetSolution(iPoint, 0),
solver_container[TURB_SOL]->GetNodes()->GetSolution(iPoint, 0));

Expand Down Expand Up @@ -1432,7 +1432,7 @@ void CFVMFlowSolverBase<V, FlowRegime>::BC_Fluid_Interface(CGeometry* geometry,

/*--- Turbulent kinetic energy ---*/

if ((config->GetKind_Turb_Model() == SST) || (config->GetKind_Turb_Model() == SST_SUST))
if ((config->GetKind_Turb_Model() == TURB_MODEL::SST) || (config->GetKind_Turb_Model() == TURB_MODEL::SST_SUST))
visc_numerics->SetTurbKineticEnergy(solver_container[TURB_SOL]->GetNodes()->GetSolution(iPoint, 0),
solver_container[TURB_SOL]->GetNodes()->GetSolution(iPoint, 0));

Expand Down
2 changes: 1 addition & 1 deletion SU2_CFD/include/solvers/CSolverFactory.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -99,7 +99,7 @@ class CSolverFactory {
* \param[in] adjoint - Boolean indicating whether a primal or adjoint solver should be allocated
* \return - A pointer to the allocated turbulent solver
*/
static CSolver* CreateTurbSolver(ENUM_TURB_MODEL kindTurbModel, CSolver **solver, CGeometry *geometry, CConfig *config, int iMGLevel, int adjoint);
static CSolver* CreateTurbSolver(TURB_MODEL kindTurbModel, CSolver **solver, CGeometry *geometry, CConfig *config, int iMGLevel, int adjoint);

/*!
* \brief Create a heat solver
Expand Down
22 changes: 11 additions & 11 deletions SU2_CFD/src/drivers/CDriver.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -1303,7 +1303,7 @@ void CDriver::Numerics_Preprocessing(CConfig *config, CGeometry **geometry, CSol

case ADJ_NAVIER_STOKES:
adj_ns = ns = compressible = true;
turbulent = (config->GetKind_Turb_Model() != NONE); break;
turbulent = (config->GetKind_Turb_Model() != TURB_MODEL::NONE); break;

case ADJ_RANS:
adj_ns = ns = compressible = turbulent = true;
Expand All @@ -1315,16 +1315,16 @@ void CDriver::Numerics_Preprocessing(CConfig *config, CGeometry **geometry, CSol

if (turbulent || fem_turbulent)
switch (config->GetKind_Turb_Model()) {
case SA: spalart_allmaras = true; break;
case SA_NEG: neg_spalart_allmaras = true; break;
case SA_E: e_spalart_allmaras = true; break;
case SA_COMP: comp_spalart_allmaras = true; break;
case SA_E_COMP: e_comp_spalart_allmaras = true; break;
case SST: menter_sst = true; break;
case SST_SUST: menter_sst = true; break;
default:
SU2_MPI::Error("Specified turbulence model unavailable or none selected", CURRENT_FUNCTION);
case TURB_MODEL::NONE:
SU2_MPI::Error("No turbulence model selected.", CURRENT_FUNCTION);
break;
case TURB_MODEL::SA: spalart_allmaras = true; break;
case TURB_MODEL::SA_NEG: neg_spalart_allmaras = true; break;
case TURB_MODEL::SA_E: e_spalart_allmaras = true; break;
case TURB_MODEL::SA_COMP: comp_spalart_allmaras = true; break;
case TURB_MODEL::SA_E_COMP: e_comp_spalart_allmaras = true; break;
case TURB_MODEL::SST: menter_sst = true; break;
case TURB_MODEL::SST_SUST: menter_sst = true; break;
}

/*--- If the Menter SST model is used, store the constants of the model and determine the
Expand Down Expand Up @@ -2697,7 +2697,7 @@ void CDriver::Print_DirectResidual(RECORDING kind_recording) {
RMSTable << log10(solvers[FLOW_SOL]->GetRes_RMS(iVar));
}

if (configs->GetKind_Turb_Model() != NONE && !configs->GetFrozen_Visc_Disc()) {
if (configs->GetKind_Turb_Model() != TURB_MODEL::NONE && !configs->GetFrozen_Visc_Disc()) {
for (unsigned short iVar = 0; iVar < solvers[TURB_SOL]->GetnVar(); iVar++) {
if (!addVals)
RMSTable.AddColumn("rms_Turb" + iVar_iZone2string(iVar, iZone), fieldWidth);
Expand Down
4 changes: 2 additions & 2 deletions SU2_CFD/src/interfaces/cfd/CMixingPlaneInterface.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -58,7 +58,7 @@ void CMixingPlaneInterface::GetDonor_Variable(CSolver *donor_solution, CGeometry
unsigned long iSpan, unsigned long rank) {

unsigned short nDim = nVar - 2;
bool turbulent = (donor_config->GetKind_Turb_Model() != NONE);
bool turbulent = (donor_config->GetKind_Turb_Model() != TURB_MODEL::NONE);



Expand Down Expand Up @@ -93,7 +93,7 @@ void CMixingPlaneInterface::SetTarget_Variable(CSolver *target_solution, CGeomet
unsigned long iSpan, unsigned long rank) {

unsigned short nDim = nVar - 2;
bool turbulent = (target_config->GetKind_Turb_Model() != NONE);
bool turbulent = (target_config->GetKind_Turb_Model() != TURB_MODEL::NONE);


target_solution->SetExtAverageDensity(Marker_Target, iSpan, Target_Variable[0]);
Expand Down
2 changes: 1 addition & 1 deletion SU2_CFD/src/numerics/NEMO/NEMO_sources.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -196,7 +196,7 @@ CNumerics::ResidualType<> CSource_NEMO::ComputeAxisymmetric(const CConfig *confi
const auto& Ms = fluidmodel->GetSpeciesMolarMass();

bool viscous = config->GetViscous();
bool rans = (config->GetKind_Turb_Model() != NONE);
bool rans = (config->GetKind_Turb_Model() != TURB_MODEL::NONE);

/*--- Initialize residual and Jacobian arrays ---*/
for (iVar = 0; iVar < nVar; iVar++) {
Expand Down
Loading

0 comments on commit d8cfe78

Please sign in to comment.