Skip to content
Merged
Show file tree
Hide file tree
Changes from all commits
Commits
Show all changes
60 commits
Select commit Hold shift + click to select a range
a3b2a8c
quick fix for normal point in sharp corner
bigfooted Dec 6, 2024
9863c1d
quick fix for normal point in sharp corner
bigfooted Dec 6, 2024
8c71e6d
clang-format
bigfooted Dec 6, 2024
e0dd4c7
check why clang-format error
bigfooted Dec 7, 2024
a4946c3
check why clang-format error
bigfooted Dec 7, 2024
40119af
clang-format error
bigfooted Dec 7, 2024
18054d6
clang-format fix
bigfooted Dec 7, 2024
5823be7
Merge branch 'develop' into fix_cornernode_normal
bigfooted Dec 10, 2024
3578502
use wall distance
bigfooted Dec 13, 2024
5a89f90
clang
bigfooted Dec 13, 2024
087a12c
introduce nearest_neighbor
bigfooted Dec 15, 2024
ce27533
restore original normalneighbor
bigfooted Dec 15, 2024
5f8b6ba
clang
bigfooted Dec 15, 2024
d5e625c
Merge branch 'develop' into fix_cornernode_normal
bigfooted Dec 22, 2024
933500a
Merge branch 'develop' into fix_cornernode_normal
bigfooted Dec 27, 2024
739f87f
Merge branch 'develop' into fix_cornernode_normal
bigfooted Dec 29, 2024
4e27793
Merge branch 'develop' into fix_cornernode_normal
bigfooted Jan 2, 2025
f5f2de9
cleanup old implementation, start new
bigfooted Jan 7, 2025
47f3839
small update
bigfooted Jan 7, 2025
55d2163
update
bigfooted Jan 9, 2025
535c841
update
bigfooted Jan 10, 2025
4b30110
update
bigfooted Jan 10, 2025
bd45235
cleanup
bigfooted Jan 10, 2025
31bd154
projection
bigfooted Jan 10, 2025
1f1a4fe
cleanup
bigfooted Jan 10, 2025
7d55b44
simplify
pcarruscag Jan 12, 2025
cb29d29
Merge branch 'develop' into fix_cornernode_normal
bigfooted Jan 13, 2025
1b43468
Merge branch 'develop' into fix_cornernode_normal
bigfooted Jan 13, 2025
4c1dce4
regression
bigfooted Jan 15, 2025
761c4b0
regression update
bigfooted Jan 15, 2025
d7b8ee7
regression update
bigfooted Jan 16, 2025
444008a
regression update
bigfooted Jan 16, 2025
82658f7
remove unused functions
bigfooted Jan 20, 2025
401d0c8
Merge branch 'develop' into fix_cornernode_normal
bigfooted Jan 23, 2025
10bbc5a
Merge branch 'develop' into fix_cornernode_normal
bigfooted Jan 25, 2025
bf48e1b
Merge branch 'develop' into fix_cornernode_normal
bigfooted Feb 19, 2025
fde5b39
move to CVertex
pcarruscag Feb 23, 2025
9020ece
fix DG segfault
Feb 24, 2025
1b9dbe1
nearest-neighbor distance for wallfunction
Feb 24, 2025
2cb1465
DG uses different mesh structure
Feb 24, 2025
b66271c
fix SA walldist
bigfooted Feb 24, 2025
1199125
Update CTurbSSTSolver.cpp to fix bug on calculating MuT
ShiheJia Feb 25, 2025
ca0b4b6
Apply suggestions from code review
pcarruscag Feb 25, 2025
cb37bac
Apply suggestions from code review
pcarruscag Feb 25, 2025
011589f
Update SU2_CFD/src/solvers/CTurbSSTSolver.cpp
pcarruscag Feb 25, 2025
3b5493d
revert nearestneighbor
bigfooted Feb 25, 2025
59f3561
Merge pull request #2453 from ShiheJia/Fix_SST_MuT
pcarruscag Feb 27, 2025
0bc734e
remove virtual function
pcarruscag Feb 27, 2025
662f0d8
format
pcarruscag Feb 27, 2025
131f47f
fix reverts
pcarruscag Mar 1, 2025
a27e246
some updates
pcarruscag Mar 1, 2025
42f80f3
use new cases branch
pcarruscag Mar 1, 2025
e7d17f6
update
pcarruscag Mar 1, 2025
5c78bc8
updates
pcarruscag Mar 1, 2025
aa7209a
updates
pcarruscag Mar 2, 2025
4c87e81
update rotating_cylinder
bigfooted Mar 3, 2025
bffddda
update species multizone
bigfooted Mar 3, 2025
e7626dd
update sp
bigfooted Mar 4, 2025
60ac5a6
Apply suggestions from code review
pcarruscag Mar 4, 2025
c5527d3
Update TestCases/parallel_regression.py [skip ci]
pcarruscag Mar 4, 2025
File filter

Filter by extension

Filter by extension

Conversations
Failed to load comments.
Loading
Jump to
Jump to file
Failed to load files.
Loading
Diff view
Diff view
2 changes: 1 addition & 1 deletion Common/include/geometry/CMultiGridGeometry.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -123,7 +123,7 @@ class CMultiGridGeometry final : public CGeometry {
void SetRestricted_GridVelocity(const CGeometry* fine_grid) override;

/*!
* \brief Find and store the closest neighbor to a vertex.
* \brief Find and store the closest, most normal, neighbor to a vertex.
* \param[in] config - Definition of the particular problem.
*/
void FindNormal_Neighbor(const CConfig* config) override;
Expand Down
2 changes: 1 addition & 1 deletion Common/include/geometry/CPhysicalGeometry.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -607,7 +607,7 @@ class CPhysicalGeometry final : public CGeometry {
void ComputeMeshQualityStatistics(const CConfig* config) override;

/*!
* \brief Find and store the closest neighbor to a vertex.
* \brief Find and store the closest, most normal, neighbor to a vertex.
* \param[in] config - Definition of the particular problem.
*/
void FindNormal_Neighbor(const CConfig* config) override;
Expand Down
43 changes: 27 additions & 16 deletions Common/include/geometry/dual_grid/CVertex.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -45,7 +45,8 @@ class CVertex : public CDualGrid {
long PeriodicPoint[5] = {-1}; /*!< \brief Store the periodic point of a boundary (iProcessor, iPoint) */
bool ActDisk_Perimeter = false; /*!< \brief Identify nodes at the perimeter of the actuator disk */
short Rotation_Type; /*!< \brief Type of rotation associated with the vertex (MPI and periodic) */
unsigned long Normal_Neighbor; /*!< \brief Index of the closest neighbor. */
unsigned long Normal_Neighbor; /*!< \brief Index of the closest, most normal, neighbor. */
su2double NearestNeighborDist = 0.0; /*!< \brief Distance to nearest internal neighbor that is not a wall. */
su2double Basis_Function[3] = {0.0}; /*!< \brief Basis function values for interpolation across zones. */

public:
Expand Down Expand Up @@ -98,7 +99,7 @@ class CVertex : public CDualGrid {
* \brief Get the normal to a face of the control volume asociated with a vertex.
* \return Dimensional normal vector, the modulus is the area of the face.
*/
inline su2double* GetNormal(void) override { return Normal; }
inline su2double* GetNormal() override { return Normal; }

/*!
* \brief Get the ith component of the normal.
Expand All @@ -108,7 +109,7 @@ class CVertex : public CDualGrid {
/*!
* \brief Initialize normal vector.
*/
inline void SetZeroValues(void) override {
inline void SetZeroValues() override {
for (unsigned short iDim = 0; iDim < nDim; iDim++) Normal[iDim] = 0.0;
}

Expand All @@ -122,7 +123,7 @@ class CVertex : public CDualGrid {
* \brief Get the value of an auxiliary variable for gradient computation.
* \return Value of the auxiliar variable.
*/
inline su2double GetAuxVar(void) const { return Aux_Var; }
inline su2double GetAuxVar() const { return Aux_Var; }

/*!
* \brief Add the value of an auxiliary variable for gradient computation.
Expand Down Expand Up @@ -167,7 +168,7 @@ class CVertex : public CDualGrid {
* \brief Get the value of the coordinate variation due to a surface modification.
* \return Variation of the coordinate.
*/
inline su2double* GetVarCoord(void) { return VarCoord; }
inline su2double* GetVarCoord() { return VarCoord; }

/*!
* \brief Set the value of the cartesian coordinate for the vertex.
Expand All @@ -181,7 +182,7 @@ class CVertex : public CDualGrid {
* \brief Get the value of the cartesian coordinate for the vertex.
* \return Value of the cartesian coordinate of the vertex.
*/
inline su2double* GetCoord(void) override { return CartCoord; }
inline su2double* GetCoord() override { return CartCoord; }

/*!
* \brief Get the value of the cartesian coordinate for the vertex.
Expand All @@ -200,7 +201,7 @@ class CVertex : public CDualGrid {
* \brief Get the type of rotation associated to the vertex.
* \return Value of the rotation that must be applied to the solution of the vertex
*/
inline short GetRotation_Type(void) const { return Rotation_Type; }
inline short GetRotation_Type() const { return Rotation_Type; }

/*!
* \overload
Expand Down Expand Up @@ -250,49 +251,49 @@ class CVertex : public CDualGrid {
* \brief Get the value of the periodic point of a vertex.
* \return Value of the periodic point of a vertex.
*/
inline long GetDonorPoint(void) const { return PeriodicPoint[0]; }
inline long GetDonorPoint() const { return PeriodicPoint[0]; }

/*!
* \brief Get the value of the periodic point of a vertex.
* \return Value of the periodic point of a vertex.
*/
inline long GetDonorMarker(void) const { return PeriodicPoint[4]; }
inline long GetDonorMarker() const { return PeriodicPoint[4]; }

/*!
* \brief Get the value of the periodic point of a vertex.
* \return Value of the periodic point of a vertex.
*/
inline long GetDonorVertex(void) const { return PeriodicPoint[3]; }
inline long GetDonorVertex() const { return PeriodicPoint[3]; }

/*!
* \brief Get the value of the periodic point of a vertex.
* \return Value of the periodic point of a vertex.
*/
inline long GetDonorGlobalIndex(void) const { return PeriodicPoint[2]; }
inline long GetDonorGlobalIndex() const { return PeriodicPoint[2]; }

/*!
* \brief Get the value of the periodic point of a vertex.
* \return Value of the periodic point of a vertex.
*/
inline long GetGlobalDonorPoint(void) const { return PeriodicPoint[2]; }
inline long GetGlobalDonorPoint() const { return PeriodicPoint[2]; }

/*!
* \brief Get the value of the periodic point of a vertex.
* \return Value of the periodic point of a vertex.
*/
inline long GetDonorProcessor(void) const { return PeriodicPoint[1]; }
inline long GetDonorProcessor() const { return PeriodicPoint[1]; }

/*!
* \brief Get the value of the periodic point of a vertex, and its somain
* \return Value of the periodic point of a vertex, and the domain.
*/
inline long* GetPeriodicPointDomain(void) { return PeriodicPoint; }
inline long* GetPeriodicPointDomain() { return PeriodicPoint; }

/*!
* \brief Get the value of the periodic point of a vertex, and its somain
* \return Value of the periodic point of a vertex, and the domain.
*/
inline bool GetActDisk_Perimeter(void) const { return ActDisk_Perimeter; }
inline bool GetActDisk_Perimeter() const { return ActDisk_Perimeter; }

/*!
* \brief Set the finite element basis functions needed for interpolation.
Expand All @@ -318,5 +319,15 @@ class CVertex : public CDualGrid {
* \brief Get the value of the closest neighbor.
* \return Index of the closest neighbor.
*/
inline unsigned long GetNormal_Neighbor(void) const { return Normal_Neighbor; }
inline unsigned long GetNormal_Neighbor() const { return Normal_Neighbor; }

/*!
* \brief Set the distance of the nearest internal neighbor that is not a wall.
*/
inline void SetNearestNeighborDistance(const su2double& val) { NearestNeighborDist = val; }

/*!
* \brief Get the distance to the nearest internal neighbor that is not a wall.
*/
inline const su2double& GetNearestNeighborDistance() const { return NearestNeighborDist; }
};
92 changes: 74 additions & 18 deletions Common/src/geometry/CGeometry.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -3902,6 +3902,36 @@ const CGeometry::CLineletInfo& CGeometry::GetLineletInfo(const CConfig* config)
return li;
}

namespace {
su2double NearestNeighborDistance(CGeometry* geometry, const CConfig* config, const unsigned long iPoint) {
const su2double max = std::numeric_limits<su2double>::max();
su2double distance = max;
for (const auto jPoint : geometry->nodes->GetPoints(iPoint)) {
const su2double dist = geometry->nodes->GetWall_Distance(jPoint);
if (dist > EPS) distance = fmin(distance, dist);
}
if (distance > 0 && distance < max) return distance;

/*--- The point only has wall neighbors, which all have 0 wall distance.
* Compute an alternative distance based on volume and wall area. ---*/

const auto nDim = geometry->GetnDim();
su2double Normal[3] = {};
for (auto iMarker = 0u; iMarker < config->GetnMarker_All(); iMarker++) {
if (!config->GetViscous_Wall(iMarker)) continue;

const auto iVertex = geometry->nodes->GetVertex(iPoint, iMarker);
if (iVertex < 0) continue;

for (auto iDim = 0u; iDim < nDim; iDim++) {
Normal[iDim] += geometry->vertex[iMarker][iVertex]->GetNormal(iDim);
}
}
const su2double Vol = geometry->nodes->GetVolume(iPoint) + geometry->nodes->GetPeriodicVolume(iPoint);
return 2 * Vol / GeometryToolbox::Norm(nDim, Normal);
}
} // namespace

void CGeometry::ComputeWallDistance(const CConfig* const* config_container, CGeometry**** geometry_container) {
int nZone = config_container[ZONE_0]->GetnZone();
bool allEmpty = true;
Expand Down Expand Up @@ -3946,27 +3976,53 @@ void CGeometry::ComputeWallDistance(const CConfig* const* config_container, CGeo
CGeometry* geometry = geometry_container[iZone][iInst][MESH_0];
geometry->SetWallDistance(0.0);
}
continue;
}
/*--- Otherwise, set wall roughnesses. ---*/
if (!allEmpty) {
/*--- Store all wall roughnesses in a common data structure. ---*/
// [iZone][iMarker] -> roughness, for this rank
auto roughness_f = make_pair(nZone, [config_container, geometry_container, iInst](unsigned long iZone) {
const CConfig* config = config_container[iZone];
const auto nMarker = geometry_container[iZone][iInst][MESH_0]->GetnMarker();

return make_pair(nMarker, [config](unsigned long iMarker) {
return config->GetWallRoughnessProperties(config->GetMarker_All_TagBound(iMarker)).second;
});

/*--- Otherwise, set wall roughnesses, storing them in a common data structure. ---*/
// [iZone][iMarker] -> roughness, for this rank
auto roughness_f = make_pair(nZone, [config_container, geometry_container, iInst](unsigned long iZone) {
const CConfig* config = config_container[iZone];
const auto nMarker = geometry_container[iZone][iInst][MESH_0]->GetnMarker();

return make_pair(nMarker, [config](unsigned long iMarker) {
return config->GetWallRoughnessProperties(config->GetMarker_All_TagBound(iMarker)).second;
});
NdFlattener<2> roughness_local(roughness_f);
// [rank][iZone][iMarker] -> roughness
NdFlattener<3> roughness_global(Nd_MPI_Environment(), roughness_local);
// use it to update roughnesses
for (int jZone = 0; jZone < nZone; jZone++) {
if (wallDistanceNeeded[jZone] && config_container[jZone]->GetnRoughWall() > 0) {
geometry_container[jZone][iInst][MESH_0]->nodes->SetWallRoughness(roughness_global);
});
NdFlattener<2> roughness_local(roughness_f);
// [rank][iZone][iMarker] -> roughness
NdFlattener<3> roughness_global(Nd_MPI_Environment(), roughness_local);
// use it to update roughnesses
for (int jZone = 0; jZone < nZone; jZone++) {
if (wallDistanceNeeded[jZone] && config_container[jZone]->GetnRoughWall() > 0) {
geometry_container[jZone][iInst][MESH_0]->nodes->SetWallRoughness(roughness_global);
}
}

for (int iZone = 0; iZone < nZone; iZone++) {
/*--- For the FEM solver, we use a different mesh structure ---*/
MAIN_SOLVER kindSolver = config_container[iZone]->GetKind_Solver();
if (!wallDistanceNeeded[iZone] || kindSolver == MAIN_SOLVER::FEM_LES || kindSolver == MAIN_SOLVER::FEM_RANS) {
continue;
}
const auto* config = config_container[iZone];
auto* geometry = geometry_container[iZone][iInst][MESH_0];

for (unsigned short iMarker = 0; iMarker < config->GetnMarker_All(); ++iMarker) {
const auto viscous = config->GetViscous_Wall(iMarker);

SU2_OMP_FOR_STAT(OMP_MIN_SIZE)
for (auto iVertex = 0u; iVertex < geometry->nVertex[iMarker]; iVertex++) {
const auto iPoint = geometry->vertex[iMarker][iVertex]->GetNode();
su2double dist = 0;
if (viscous && geometry->nodes->GetDomain(iPoint)) {
dist = NearestNeighborDistance(geometry, config, iPoint);
} else {
dist = geometry->nodes->GetWall_Distance(iPoint);
}
geometry->vertex[iMarker][iVertex]->SetNearestNeighborDistance(dist);
}
END_SU2_OMP_FOR
}
}
}
Expand Down
10 changes: 4 additions & 6 deletions SU2_CFD/include/solvers/CFVMFlowSolverBase.inl
Original file line number Diff line number Diff line change
Expand Up @@ -2350,7 +2350,7 @@ void CFVMFlowSolverBase<V, FlowRegime>::Friction_Forces(const CGeometry* geometr

unsigned long iVertex, iPoint, iPointNormal;
unsigned short iMarker, iMarker_Monitoring, iDim, jDim;
su2double Viscosity = 0.0, Area, Density = 0.0, WallDistMod, FrictionVel,
su2double Viscosity = 0.0, Area, Density = 0.0, FrictionVel,
UnitNormal[3] = {0.0}, TauElem[3] = {0.0}, Tau[3][3] = {{0.0}}, Cp,
thermal_conductivity, MaxNorm = 8.0, Grad_Vel[3][3] = {{0.0}}, Grad_Temp[3] = {0.0},
Grad_Temp_ve[3] = {0.0}, AxiFactor;
Expand Down Expand Up @@ -2497,11 +2497,9 @@ void CFVMFlowSolverBase<V, FlowRegime>::Friction_Forces(const CGeometry* geometr

FrictionVel = sqrt(fabs(WallShearStress[iMarker][iVertex]) / Density);

if (!wallfunctions && (MGLevel == MESH_0 || geometry->nodes->GetDomain(iPoint))) {
// for CMultiGridGeometry, the normal neighbor of halo nodes in not set
iPointNormal = geometry->vertex[iMarker][iVertex]->GetNormal_Neighbor();
Coord_Normal = geometry->nodes->GetCoord(iPointNormal);
WallDistMod = GeometryToolbox::Distance(nDim, Coord, Coord_Normal);
if (!wallfunctions && MGLevel == MESH_0 && geometry->nodes->GetDomain(iPoint)) {
// for CMultiGridGeometry and halos, the nearest neighbor distance is not set
const su2double WallDistMod = geometry->vertex[iMarker][iVertex]->GetNearestNeighborDistance();
YPlus[iMarker][iVertex] = WallDistMod * FrictionVel / (Viscosity / Density);
}

Expand Down
2 changes: 0 additions & 2 deletions SU2_CFD/include/solvers/CTurbSSTSolver.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -53,7 +53,6 @@ class CTurbSSTSolver final : public CTurbSolver {
CSolver **solver_container,
const CConfig *config,
unsigned short val_marker);

public:
/*!
* \brief Constructor.
Expand Down Expand Up @@ -302,5 +301,4 @@ class CTurbSSTSolver final : public CTurbSolver {
*/
inline su2double GetOmega_Inf(void) const override { return Solution_Inf[1]; }


};
2 changes: 1 addition & 1 deletion SU2_CFD/include/variables/CFlowVariable.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -260,7 +260,7 @@ class CFlowVariable : public CVariable {
* \param[in] iPoint - Point index.
* \return Value of magnitude.
*/
inline su2double GetStrainMag(unsigned long iPoint) const final { return StrainMag(iPoint); }
inline su2double GetStrainMag(unsigned long iPoint) const { return StrainMag(iPoint); }

/*!
* \brief Get the entire vector of the rate of strain magnitude.
Expand Down
7 changes: 0 additions & 7 deletions SU2_CFD/include/variables/CVariable.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -1147,13 +1147,6 @@ class CVariable {
inline virtual su2double *GetVorticity(unsigned long iPoint) { return nullptr; }
inline virtual const su2double *GetVorticity(unsigned long iPoint) const { return nullptr; }

/*!
* \brief A virtual member.
* \param[in] iPoint - Point index.
* \return Value of the rate of strain magnitude.
*/
inline virtual su2double GetStrainMag(unsigned long iPoint) const { return 0.0; }

/*!
* \brief A virtual member.
* \param[in] iPoint - Point index.
Expand Down
4 changes: 2 additions & 2 deletions SU2_CFD/src/drivers/CDriver.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -833,7 +833,7 @@ void CDriver::InitializeGeometryFVM(CConfig *config, CGeometry **&geometry) {
geometry[iMGlevel]->SetBoundControlVolume(geometry[iMGlevel-1], config, ALLOCATE);
geometry[iMGlevel]->SetCoord(geometry[iMGlevel-1]);

/*--- Find closest neighbor to a surface point ---*/
/*--- Find closest, most normal, neighbor to a surface point ---*/

geometry[iMGlevel]->FindNormal_Neighbor(config);

Expand Down Expand Up @@ -2517,7 +2517,7 @@ void CDriver::InitializeInterface(CConfig **config, CSolver***** solver, CGeomet
else
interface_type = NO_TRANSFER;
}

if (interface_type != NO_TRANSFER) {
auto nVar = 4;
interface[donor][target] = new CConjugateHeatInterface(nVar, 0);
Expand Down
6 changes: 1 addition & 5 deletions SU2_CFD/src/solvers/CIncNSSolver.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -685,11 +685,7 @@ void CIncNSSolver::SetTau_Wall_WF(CGeometry *geometry, CSolver **solver_containe
const su2double VelTangMod = GeometryToolbox::Norm(int(MAXNDIM), VelTang);

/*--- Compute normal distance of the interior point from the wall ---*/

su2double WallDist[MAXNDIM] = {0.0};
GeometryToolbox::Distance(nDim, Coord, Coord_Normal, WallDist);

su2double WallDistMod = GeometryToolbox::Norm(int(MAXNDIM), WallDist);
const su2double WallDistMod = GeometryToolbox::Distance(nDim, Coord, Coord_Normal);

su2double Density_Wall = nodes->GetDensity(iPoint);

Expand Down
6 changes: 1 addition & 5 deletions SU2_CFD/src/solvers/CNSSolver.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -864,11 +864,7 @@ void CNSSolver::SetTau_Wall_WF(CGeometry *geometry, CSolver **solver_container,
const su2double VelTangMod = GeometryToolbox::Norm(int(MAXNDIM), VelTang);

/*--- Compute normal distance of the interior point from the wall ---*/

su2double WallDist[MAXNDIM] = {0.0};
GeometryToolbox::Distance(nDim, Coord, Coord_Normal, WallDist);

const su2double WallDistMod = GeometryToolbox::Norm(int(MAXNDIM), WallDist);
const su2double WallDistMod = GeometryToolbox::Distance(nDim, Coord, Coord_Normal);

su2double T_Wall = nodes->GetTemperature(iPoint);
const su2double Conductivity_Wall = nodes->GetThermalConductivity(iPoint);
Expand Down
4 changes: 2 additions & 2 deletions SU2_CFD/src/solvers/CTurbSASolver.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -309,7 +309,7 @@ void CTurbSASolver::Source_Residual(CGeometry *geometry, CSolver **solver_contai
CNumerics **numerics_container, CConfig *config, unsigned short iMesh) {

bool axisymmetric = config->GetAxisymmetric();

const bool implicit = (config->GetKind_TimeIntScheme() == EULER_IMPLICIT);
const bool harmonic_balance = (config->GetTime_Marching() == TIME_MARCHING::HARMONIC_BALANCE);
const bool transition_BC = config->GetSAParsedOptions().bc;
Expand Down Expand Up @@ -389,7 +389,7 @@ void CTurbSASolver::Source_Residual(CGeometry *geometry, CSolver **solver_contai
/*--- Set y coordinate ---*/
numerics->SetCoord(geometry->nodes->GetCoord(iPoint), geometry->nodes->GetCoord(iPoint));
}

/*--- Compute the source term ---*/

auto residual = numerics->ComputeResidual(config);
Expand Down
Loading