Skip to content

Commit c8e0f34

Browse files
Cristopher-MoralesCristopher-Morales
andauthored
Enable the use of conductivity models different from CONSTANT_PRANDTL for compressible flows. (#2420)
* enable use of conductivity models for compressible flows * removing unused variables * setting eddy viscosity in fluid model * axisymmetric cleaning * updating residuals * fix * fix parallel regression * fix * adding test case using CONSTANT_CONDUCTIVITY model * rename * update regression test * additional cleaning * further cleaning * making thermal conductivity only laminar * small fix * fix heatflux * fix * setting reference values * fix ND heatSolver * freestream values * including Cp setHeatFluxVector * reformulating * moving up SetHeatFluxVector * updating residual test case * fixing missing thermalConductivity * increasing nPrimVar and removing some variables * making LambdaVisc independent of prandtl laminar * addressing review comments * updating residuals regression cases * fixing residuals --------- Co-authored-by: Cristopher-Morales <[email protected]>
1 parent ac85793 commit c8e0f34

29 files changed

+260
-192
lines changed

Common/include/CConfig.hpp

Lines changed: 52 additions & 0 deletions
Original file line numberDiff line numberDiff line change
@@ -899,6 +899,8 @@ class CConfig {
899899
ModVel_FreeStreamND, /*!< \brief Non-dimensional magnitude of the free-stream velocity of the fluid. */
900900
Density_FreeStream, /*!< \brief Free-stream density of the fluid. */
901901
Viscosity_FreeStream, /*!< \brief Free-stream viscosity of the fluid. */
902+
ThermalConductivity_FreeStream, /*!< \brief Free-stream thermal conductivity of the fluid. */
903+
SpecificHeatCp_FreeStream, /*!< \brief Free-stream specific heat capacity at constant pressure of the fluid. */
902904
Tke_FreeStream, /*!< \brief Total turbulent kinetic energy of the fluid. */
903905
Intermittency_FreeStream, /*!< \brief Freestream intermittency (for sagt transition model) of the fluid. */
904906
ReThetaT_FreeStream, /*!< \brief Freestream Transition Momentum Thickness Reynolds Number (for LM transition model) of the fluid. */
@@ -940,6 +942,8 @@ class CConfig {
940942
Velocity_FreeStreamND[3], /*!< \brief Farfield velocity values (external flow). */
941943
Energy_FreeStreamND, /*!< \brief Farfield energy value (external flow). */
942944
Viscosity_FreeStreamND, /*!< \brief Farfield viscosity value (external flow). */
945+
ThermalConductivity_FreeStreamND, /*!< \brief Farfield thermal conductivity value (external flow). */
946+
SpecificHeatCp_FreeStreamND, /*!< \brief Farfield specific heat capacity at constant pressure value (external flow). */
943947
Tke_FreeStreamND, /*!< \brief Farfield kinetic energy (external flow). */
944948
Omega_FreeStreamND, /*!< \brief Specific dissipation (external flow). */
945949
Omega_FreeStream; /*!< \brief Specific dissipation (external flow). */
@@ -1760,6 +1764,18 @@ class CConfig {
17601764
*/
17611765
su2double GetViscosity_FreeStream(void) const { return Viscosity_FreeStream; }
17621766

1767+
/*!
1768+
* \brief Get the value of the freestream thermal conductivity.
1769+
* \return Freestream thermal conductivity.
1770+
*/
1771+
su2double GetThermalConductivity_FreeStream(void) const { return ThermalConductivity_FreeStream; }
1772+
1773+
/*!
1774+
* \brief Get the value of the freestream heat capacity at constant pressure.
1775+
* \return Freestream heat capacity at constant pressure.
1776+
*/
1777+
su2double GetSpecificHeatCp_FreeStream(void) const { return SpecificHeatCp_FreeStream; }
1778+
17631779
/*!
17641780
* \brief Get the value of the freestream density.
17651781
* \return Freestream density.
@@ -1991,6 +2007,18 @@ class CConfig {
19912007
*/
19922008
su2double GetViscosity_FreeStreamND(void) const { return Viscosity_FreeStreamND; }
19932009

2010+
/*!
2011+
* \brief Get the value of the non-dimensionalized freestream thermal conductivity.
2012+
* \return Non-dimensionalized freestream thermal conductivity.
2013+
*/
2014+
su2double GetThermalConductivity_FreeStreamND(void) const { return ThermalConductivity_FreeStreamND; }
2015+
2016+
/*!
2017+
* \brief Get the value of the non-dimensionalized freestream heat capacity at constant pressure.
2018+
* \return Non-dimensionalized freestream heat capacity at constant pressure.
2019+
*/
2020+
su2double GetSpecificHeatCp_FreeStreamND(void) const { return SpecificHeatCp_FreeStreamND; }
2021+
19942022
/*!
19952023
* \brief Get the value of the non-dimensionalized freestream viscosity.
19962024
* \return Non-dimensionalized freestream viscosity.
@@ -2610,6 +2638,18 @@ class CConfig {
26102638
*/
26112639
void SetViscosity_FreeStream(su2double val_viscosity_freestream) { Viscosity_FreeStream = val_viscosity_freestream; }
26122640

2641+
/*!
2642+
* \brief Set the freestream thermal conductivity.
2643+
* \param[in] val_thermalconductivity_freestream - Value of the freestream thermal conductivity.
2644+
*/
2645+
void SetThermalConductivity_FreeStream(su2double val_thermalconductivity_freestream) { ThermalConductivity_FreeStream = val_thermalconductivity_freestream; }
2646+
2647+
/*!
2648+
* \brief Set the freestream specific heat capacity at constant pressure.
2649+
* \param[in] val_specificheatCp_freestream - Value of the freestream specific heat capacity at constant pressure.
2650+
*/
2651+
void SetSpecificHeatCp_FreeStream(su2double val_specificheatCp_freestream) { SpecificHeatCp_FreeStream = val_specificheatCp_freestream; }
2652+
26132653
/*!
26142654
* \brief Set the magnitude of the free-stream velocity.
26152655
* \param[in] val_modvel_freestream - Magnitude of the free-stream velocity.
@@ -2672,6 +2712,18 @@ class CConfig {
26722712
*/
26732713
void SetViscosity_FreeStreamND(su2double val_viscosity_freestreamnd) { Viscosity_FreeStreamND = val_viscosity_freestreamnd; }
26742714

2715+
/*!
2716+
* \brief Set the non-dimensional free-stream thermal conductivity.
2717+
* \param[in] val_thermalconductivity_freestreamnd - Value of the non-dimensional free-stream thermal conductivity.
2718+
*/
2719+
void SetThermalConductivity_FreeStreamND(su2double val_thermalconductivity_freestreamnd) { ThermalConductivity_FreeStreamND = val_thermalconductivity_freestreamnd; }
2720+
2721+
/*!
2722+
* \brief Set the non-dimensional free-stream specific heat capacity at constant pressure.
2723+
* \param[in] val_specificheatCp_freestreamnd - Value of the non-dimensional free-stream specific heat capacity at constant pressure.
2724+
*/
2725+
void SetSpecificHeatCp_FreeStreamND(su2double val_specificheatCp_freestreamnd) { SpecificHeatCp_FreeStreamND = val_specificheatCp_freestreamnd; }
2726+
26752727
/*!
26762728
* \brief Set the non-dimensional freestream turbulent kinetic energy.
26772729
* \param[in] val_tke_freestreamnd - Value of the non-dimensional freestream turbulent kinetic energy.

Common/src/CConfig.cpp

Lines changed: 0 additions & 4 deletions
Original file line numberDiff line numberDiff line change
@@ -4214,10 +4214,6 @@ void CConfig::SetPostprocessing(SU2_COMPONENT val_software, unsigned short val_i
42144214
SU2_MPI::Error("Only SUTHERLAND viscosity model can be used with US Measurement", CURRENT_FUNCTION);
42154215
}
42164216
}
4217-
if (Kind_ConductivityModel != CONDUCTIVITYMODEL::CONSTANT_PRANDTL) {
4218-
SU2_MPI::Error("Only CONSTANT_PRANDTL thermal conductivity model can be used with STANDARD_AIR and IDEAL_GAS",
4219-
CURRENT_FUNCTION);
4220-
}
42214217
}
42224218
/*--- Check for Boundary condition option agreement ---*/
42234219
if (Kind_InitOption == REYNOLDS){

Common/src/geometry/CPhysicalGeometryFEM.cpp

Lines changed: 3 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -2228,11 +2228,12 @@ void CPhysicalGeometry::DetermineTimeLevelElements(CConfig* config, const vector
22282228
step is based on free stream values at the moment, but this is easy
22292229
to change, if needed. ---*/
22302230
const su2double Gamma = config->GetGamma();
2231-
const su2double Prandtl = config->GetPrandtl_Lam();
22322231

22332232
const su2double Density = config->GetDensity_FreeStreamND();
22342233
const su2double* Vel = config->GetVelocity_FreeStreamND();
22352234
const su2double Viscosity = config->GetViscosity_FreeStreamND();
2235+
const su2double Thermal_Conductivity = config->GetThermalConductivity_FreeStreamND();
2236+
const su2double Cp = config->GetSpecificHeatCp_FreeStreamND();
22362237

22372238
su2double VelMag = 0.0;
22382239
for (unsigned short iDim = 0; iDim < nDim; ++iDim) VelMag += Vel[iDim] * Vel[iDim];
@@ -2253,7 +2254,7 @@ void CPhysicalGeometry::DetermineTimeLevelElements(CConfig* config, const vector
22532254
const su2double charVel = sqrt(charVel2);
22542255

22552256
/* Also the viscous contribution to the time step is constant. Compute it. */
2256-
const su2double factHeatFlux = Gamma / Prandtl;
2257+
const su2double factHeatFlux = (Thermal_Conductivity * Gamma) / (Cp * Viscosity);
22572258
const su2double lambdaOverMu = -TWO3;
22582259
const su2double radVisc = max(max(1.0, 2.0 + lambdaOverMu), factHeatFlux) * Viscosity / Density;
22592260

SU2_CFD/include/numerics/CNumerics.hpp

Lines changed: 0 additions & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -53,7 +53,6 @@ class CNumerics {
5353
su2double Gamma_Minus_One; /*!< \brief Fluids's Gamma - 1.0 . */
5454
su2double Minf; /*!< \brief Free stream Mach number . */
5555
su2double Gas_Constant; /*!< \brief Gas constant. */
56-
su2double Prandtl_Lam; /*!< \brief Laminar Prandtl's number. */
5756
su2double Prandtl_Turb; /*!< \brief Turbulent Prandtl's number. */
5857
su2double MassFlux; /*!< \brief Mass flux across edge. */
5958
su2double

SU2_CFD/include/numerics/flow/flow_diffusion.hpp

Lines changed: 15 additions & 26 deletions
Original file line numberDiff line numberDiff line change
@@ -57,6 +57,8 @@ class CAvgGrad_Base : public CNumerics {
5757
su2double **Mean_GradPrimVar = nullptr, /*!< \brief Mean value of the gradient. */
5858
Mean_Laminar_Viscosity, /*!< \brief Mean value of the viscosity. */
5959
Mean_Eddy_Viscosity, /*!< \brief Mean value of the eddy viscosity. */
60+
Mean_Thermal_Conductivity, /*!< \brief Mean value of the thermal conductivity. */
61+
Mean_Cp, /*!< \brief Mean value of the specific heat capacity at constant pressure. */
6062
Mean_turb_ke, /*!< \brief Mean value of the turbulent kinetic energy. */
6163
Mean_TauWall, /*!< \brief Mean wall shear stress (wall functions). */
6264
TauWall_i, TauWall_j, /*!< \brief Wall shear stress at point i and j (wall functions). */
@@ -214,6 +216,16 @@ class CAvgGrad_Base : public CNumerics {
214216
*/
215217
inline su2double GetStressTensor(unsigned short iDim, unsigned short jDim) const { return tau[iDim][jDim];}
216218

219+
/*!
220+
* \brief Compute the heat flux due to molecular and turbulent diffusivity
221+
* \param[in] val_gradprimvar - Gradient of the primitive variables.
222+
* \param[in] val_eddy_viscosity - Eddy viscosity.
223+
* \param[in] val_thermal_conductivity - Thermal Conductivity.
224+
* \param[in] val_heat_capacity_cp - Heat Capacity at constant pressure.
225+
*/
226+
void SetHeatFluxVector(const su2double* const* val_gradprimvar, su2double val_eddy_viscosity,
227+
su2double val_thermal_conductivity, su2double val_heat_capacity_cp);
228+
217229
/*!
218230
* \brief Get a component of the heat flux vector.
219231
* \param[in] iDim - The index of the component
@@ -248,16 +260,6 @@ class CAvgGrad_Flow final : public CAvgGrad_Base {
248260
*/
249261
ResidualType<> ComputeResidual(const CConfig* config) override;
250262

251-
/*!
252-
* \brief Compute the heat flux due to molecular and turbulent diffusivity
253-
* \param[in] val_gradprimvar - Gradient of the primitive variables.
254-
* \param[in] val_laminar_viscosity - Laminar viscosity.
255-
* \param[in] val_eddy_viscosity - Eddy viscosity.
256-
*/
257-
void SetHeatFluxVector(const su2double* const *val_gradprimvar,
258-
su2double val_laminar_viscosity,
259-
su2double val_eddy_viscosity);
260-
261263
/*!
262264
* \brief Compute the Jacobian of the heat flux vector
263265
*
@@ -266,13 +268,14 @@ class CAvgGrad_Flow final : public CAvgGrad_Base {
266268
*
267269
* \param[in] val_Mean_PrimVar - Mean value of the primitive variables.
268270
* \param[in] val_gradprimvar - Mean value of the gradient of the primitive variables.
269-
* \param[in] val_laminar_viscosity - Value of the laminar viscosity.
271+
* \param[in] val_heat_capacity_cp - Value of the heat capacity at constant pressure.
270272
* \param[in] val_eddy_viscosity - Value of the eddy viscosity.
271273
* \param[in] val_dist_ij - Distance between the points.
272274
* \param[in] val_normal - Normal vector, the norm of the vector is the area of the face.
273275
*/
274276
void SetHeatFluxJacobian(const su2double *val_Mean_PrimVar,
275-
su2double val_laminar_viscosity,
277+
su2double val_heat_capacity_cp,
278+
su2double val_thermal_conductivity,
276279
su2double val_eddy_viscosity,
277280
su2double val_dist_ij,
278281
const su2double *val_normal);
@@ -351,20 +354,6 @@ class CGeneralAvgGrad_Flow final : public CAvgGrad_Base {
351354
Mean_Thermal_Conductivity, /*!< \brief Mean value of the thermal conductivity. */
352355
Mean_Cp; /*!< \brief Mean value of the Cp. */
353356

354-
/*!
355-
* \brief Compute the heat flux due to molecular and turbulent diffusivity
356-
* \param[in] val_gradprimvar - Gradient of the primitive variables.
357-
* \param[in] val_laminar_viscosity - Laminar viscosity.
358-
* \param[in] val_eddy_viscosity - Eddy viscosity.
359-
* \param[in] val_thermal_conductivity - Thermal Conductivity.
360-
* \param[in] val_heat_capacity_cp - Heat Capacity at constant pressure.
361-
*/
362-
void SetHeatFluxVector(const su2double* const *val_gradprimvar,
363-
su2double val_laminar_viscosity,
364-
su2double val_eddy_viscosity,
365-
su2double val_thermal_conductivity,
366-
su2double val_heat_capacity_cp);
367-
368357
/*!
369358
* \brief Compute the Jacobian of the heat flux vector
370359
*

SU2_CFD/include/numerics_simd/flow/diffusion/viscous_fluxes.hpp

Lines changed: 2 additions & 8 deletions
Original file line numberDiff line numberDiff line change
@@ -75,9 +75,7 @@ class CCompressibleViscousFluxBase : public CNumericsSIMD {
7575

7676
const su2double gamma;
7777
const su2double gasConst;
78-
const su2double prandtlLam;
7978
const su2double prandtlTurb;
80-
const su2double cp;
8179
const bool correct;
8280
const bool useSA_QCR;
8381
const bool wallFun;
@@ -97,9 +95,7 @@ class CCompressibleViscousFluxBase : public CNumericsSIMD {
9795
const CVariable* turbVars_, Ts&...) :
9896
gamma(config.GetGamma()),
9997
gasConst(config.GetGas_ConstantND()),
100-
prandtlLam(config.GetPrandtl_Lam()),
10198
prandtlTurb(config.GetPrandtl_Turb()),
102-
cp(gamma * gasConst / (gamma - 1)),
10399
correct(iMesh == MESH_0),
104100
useSA_QCR(config.GetSAParsedOptions().qcr2000),
105101
wallFun(config.GetWall_Functions()),
@@ -256,13 +252,11 @@ class CCompressibleViscousFluxBase : public CNumericsSIMD {
256252
template<size_t NDIM>
257253
class CCompressibleViscousFlux : public CCompressibleViscousFluxBase<NDIM, CCompressibleViscousFlux<NDIM> > {
258254
public:
259-
static constexpr size_t nPrimVar = NDIM+7;
255+
static constexpr size_t nPrimVar = NDIM+9;
260256
using Base = CCompressibleViscousFluxBase<NDIM, CCompressibleViscousFlux<NDIM> >;
261257
using Base::gamma;
262258
using Base::gasConst;
263-
using Base::prandtlLam;
264259
using Base::prandtlTurb;
265-
using Base::cp;
266260

267261
/*!
268262
* \brief Constructor, initialize constants and booleans.
@@ -275,7 +269,7 @@ class CCompressibleViscousFlux : public CCompressibleViscousFluxBase<NDIM, CComp
275269
*/
276270
template<class PrimitiveType>
277271
FORCEINLINE Double thermalConductivity(const PrimitiveType& V) const {
278-
return cp * (V.laminarVisc()/prandtlLam + V.eddyVisc()/prandtlTurb);
272+
return V.thermalCond() + V.cp() * V.eddyVisc() / prandtlTurb;
279273
}
280274

281275
/*!

SU2_CFD/include/solvers/CEulerSolver.hpp

Lines changed: 0 additions & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -41,7 +41,6 @@ class CEulerSolver : public CFVMFlowSolverBase<CEulerVariable, ENUM_REGIME::COMP
4141
using BaseClass = CFVMFlowSolverBase<CEulerVariable, ENUM_REGIME::COMPRESSIBLE>;
4242

4343
su2double
44-
Prandtl_Lam = 0.0, /*!< \brief Laminar Prandtl number. */
4544
Prandtl_Turb = 0.0; /*!< \brief Turbulent Prandtl number. */
4645

4746
su2double AllBound_CEquivArea_Inv=0.0; /*!< \brief equivalent area coefficient (inviscid contribution) for all the boundaries. */

SU2_CFD/include/solvers/CFVMFlowSolverBase.inl

Lines changed: 2 additions & 8 deletions
Original file line numberDiff line numberDiff line change
@@ -2389,7 +2389,7 @@ void CFVMFlowSolverBase<V, FlowRegime>::Friction_Forces(const CGeometry* geometr
23892389
unsigned long iVertex, iPoint, iPointNormal;
23902390
unsigned short iMarker, iMarker_Monitoring, iDim, jDim;
23912391
su2double Viscosity = 0.0, Area, Density = 0.0, FrictionVel,
2392-
UnitNormal[3] = {0.0}, TauElem[3] = {0.0}, Tau[3][3] = {{0.0}}, Cp,
2392+
UnitNormal[3] = {0.0}, TauElem[3] = {0.0}, Tau[3][3] = {{0.0}},
23932393
thermal_conductivity, MaxNorm = 8.0, Grad_Vel[3][3] = {{0.0}}, Grad_Temp[3] = {0.0},
23942394
Grad_Temp_ve[3] = {0.0}, AxiFactor;
23952395
const su2double *Coord = nullptr, *Coord_Normal = nullptr, *Normal = nullptr;
@@ -2400,10 +2400,8 @@ void CFVMFlowSolverBase<V, FlowRegime>::Friction_Forces(const CGeometry* geometr
24002400
const su2double RefLength = config->GetRefLength();
24012401
const su2double RefHeatFlux = config->GetHeat_Flux_Ref();
24022402
const su2double RefTemperature = config->GetTemperature_Ref();
2403-
const su2double Gas_Constant = config->GetGas_ConstantND();
24042403
auto Origin = config->GetRefOriginMoment(0);
24052404

2406-
const su2double Prandtl_Lam = config->GetPrandtl_Lam();
24072405
const bool energy = config->GetEnergy_Equation();
24082406
const bool QCR = config->GetSAParsedOptions().qcr2000;
24092407
const bool axisymmetric = config->GetAxisymmetric();
@@ -2544,11 +2542,7 @@ void CFVMFlowSolverBase<V, FlowRegime>::Friction_Forces(const CGeometry* geometr
25442542
/*--- Compute total and maximum heat flux on the wall ---*/
25452543

25462544
if (!nemo) {
2547-
if (FlowRegime == ENUM_REGIME::COMPRESSIBLE) {
2548-
Cp = (Gamma / Gamma_Minus_One) * Gas_Constant;
2549-
thermal_conductivity = Cp * Viscosity / Prandtl_Lam;
2550-
}
2551-
if (FlowRegime == ENUM_REGIME::INCOMPRESSIBLE) {
2545+
if ((FlowRegime == ENUM_REGIME::COMPRESSIBLE) || (FlowRegime == ENUM_REGIME::INCOMPRESSIBLE)) {
25522546
thermal_conductivity = nodes->GetThermalConductivity(iPoint);
25532547
}
25542548

SU2_CFD/include/solvers/CHeatSolver.hpp

Lines changed: 5 additions & 7 deletions
Original file line numberDiff line numberDiff line change
@@ -67,7 +67,6 @@ class CHeatSolver final : public CScalarSolver<CHeatVariable> {
6767
if (!geometry->nodes->GetDomain(iPoint)) return;
6868

6969
const bool implicit = config->GetKind_TimeIntScheme() == EULER_IMPLICIT;
70-
const su2double prandtl_lam = config->GetPrandtl_Lam();
7170
const su2double const_diffusivity = config->GetThermalDiffusivity();
7271

7372
const auto Point_Normal = geometry->vertex[iMarker][iVertex]->GetNormal_Neighbor();
@@ -83,7 +82,8 @@ class CHeatSolver final : public CScalarSolver<CHeatVariable> {
8382

8483
su2double thermal_diffusivity = const_diffusivity;
8584
if (flow) {
86-
thermal_diffusivity = flow_solver->GetNodes()->GetLaminarViscosity(iPoint) / prandtl_lam;
85+
thermal_diffusivity =
86+
flow_solver->GetNodes()->GetThermalConductivity(iPoint) / flow_solver->GetNodes()->GetSpecificHeatCp(iPoint);
8787
}
8888
LinSysRes(iPoint, 0) -= thermal_diffusivity * dTdn * Area;
8989

@@ -107,21 +107,19 @@ class CHeatSolver final : public CScalarSolver<CHeatVariable> {
107107
const CVariable* flow_nodes = flow ? solver_container[FLOW_SOL]->GetNodes() : nullptr;
108108

109109
const su2double const_diffusivity = config->GetThermalDiffusivity();
110-
const su2double pr_lam = config->GetPrandtl_Lam();
111110
const su2double pr_turb = config->GetPrandtl_Turb();
112111

113112
su2double thermal_diffusivity_i{}, thermal_diffusivity_j{};
114113

115114
/*--- Computes the thermal diffusivity to use in the viscous numerics. ---*/
116115
auto compute_thermal_diffusivity = [&](unsigned long iPoint, unsigned long jPoint) {
117116
if (flow) {
118-
thermal_diffusivity_i = flow_nodes->GetLaminarViscosity(iPoint) / pr_lam +
117+
thermal_diffusivity_i = flow_nodes->GetThermalConductivity(iPoint) / flow_nodes->GetSpecificHeatCp(iPoint) +
119118
flow_nodes->GetEddyViscosity(iPoint) / pr_turb;
120-
thermal_diffusivity_j = flow_nodes->GetLaminarViscosity(jPoint) / pr_lam +
119+
thermal_diffusivity_j = flow_nodes->GetThermalConductivity(jPoint) / flow_nodes->GetSpecificHeatCp(jPoint) +
121120
flow_nodes->GetEddyViscosity(jPoint) / pr_turb;
122121
numerics->SetDiffusionCoeff(&thermal_diffusivity_i, &thermal_diffusivity_j);
123-
}
124-
else {
122+
} else {
125123
numerics->SetDiffusionCoeff(&const_diffusivity, &const_diffusivity);
126124
}
127125
};

SU2_CFD/src/interfaces/cht/CConjugateHeatInterface.cpp

Lines changed: 1 addition & 8 deletions
Original file line numberDiff line numberDiff line change
@@ -75,14 +75,7 @@ void CConjugateHeatInterface::GetDonor_Variable(CSolver *donor_solution, CGeomet
7575

7676
if (compressible_flow) {
7777

78-
const su2double Gamma = donor_config->GetGamma();
79-
const su2double Gas_Constant = donor_config->GetGas_ConstantND();
80-
const su2double Cp = (Gamma / (Gamma - 1.0)) * Gas_Constant;
81-
82-
const su2double Prandtl_Lam = donor_config->GetPrandtl_Lam();
83-
const su2double laminar_viscosity = donor_solution->GetNodes()->GetLaminarViscosity(Point_Donor); // TDE check for consistency
84-
85-
const su2double thermal_conductivityND = Cp*(laminar_viscosity/Prandtl_Lam);
78+
const su2double thermal_conductivityND = donor_solution->GetNodes()->GetThermalConductivity(Point_Donor);
8679
heat_flux_density = thermal_conductivityND*dTdn;
8780

8881
if ((donor_config->GetKind_CHT_Coupling() == CHT_COUPLING::DIRECT_TEMPERATURE_ROBIN_HEATFLUX) ||

0 commit comments

Comments
 (0)