Skip to content

Commit 2c0049f

Browse files
Cristopher-MoralesCristopher-Moralespcarruscagbigfooted
authored
Preconditioning for multicomponent flows (#2426)
* solving for enthalpy * fixing flux jacobian * fix output error * adding enthalpy diffusion * moving enthalpy diffusion terms to CIncNSSolver.cpp * small fix * cleaning and rewritting some functions * axisymetric source term and corrected flux jacobian at the wall * updating BC_ConjugateHeat_Interface for fluid mixture * activating muscl, consistent extrapolation for multicomponent * correct average enthalpy for multicomponent flows output * changing boolean names * up to date to develop * adding brackets * fixing warning * adding standard reference temperature T0=298.15K as default value * reformulating and cleaning * cleaning flow_diffusion.hpp and .cpp * removing spaces * fix description working variable * update parallel regresion test * fix non-dimensionalization issue * updating species Non-Dimensional test case * fix parallel_regression.py * updating regression test cases * update parallel regression test * adding adj enthalpy fields for incompressible solver * adding HeatFluxDiffusion in Preaccumulation * updating JST and Lax-Friedrich * updating BC far-field for multicomponent flows * fix small bug conductivity prandtl * adding regression cases * update residual JST-Lax_Friedrich * adding function for computing enthalpy due to species diffusion * adding setTDState_h for multicomponent * updating parallel_regresion residuals * update multizone restart for species transport * updating residual multizone species transport * Update SU2_CFD/include/numerics/CNumerics.hpp Co-authored-by: Pedro Gomes <[email protected]> * Update SU2_CFD/include/numerics/CNumerics.hpp Co-authored-by: Pedro Gomes <[email protected]> * Update SU2_CFD/src/fluid/CFluidScalar.cpp Co-authored-by: Pedro Gomes <[email protected]> * Update SU2_CFD/src/numerics/CNumerics.cpp Co-authored-by: Pedro Gomes <[email protected]> * fixing names according to review comment * fixing ComputeConsistentExtrapolation according to review comment * removing WorkingVar from numerics and small cleaning * formatting * updating residuals * defining enthalpy in each model and reformulating inlet BC * fix error JST and BC IncEulerSolver * using GetFluidModel in CIncEulerSolver * making enthalpy the working variable * fix warning * fixing outputs * fix centered scheme * fix ADJ_TEMPERATURE * changes energy_multicomponent, enthalpy and RMS_ENTHALPY in test cases * imposing temperature when energy equation is switched off * changing screenoutput BGS_ENTHALPY[0] in cht files * avoid duplicating enthalpy output for flamelet solver * renaming LIMITER_TEMPERATURE to LIMITER_ENTHALPY * Update SU2_CFD/include/numerics/flow/convection/centered.hpp Co-authored-by: Nijso <[email protected]> * Update SU2_CFD/include/numerics/flow/convection/centered.hpp Co-authored-by: Nijso <[email protected]> * adding eddy diffusivity in enthalpy diffusion * updating residuals species transport * updating residuals * update residual and fixing output temperature * small cleaning * updating residuals * updating residuals * updating residuals DAspecies tutorial case * Update SU2_CFD/include/variables/CIncEulerVariable.hpp Co-authored-by: Pedro Gomes <[email protected]> * Update SU2_CFD/src/fluid/CFluidScalar.cpp Co-authored-by: Pedro Gomes <[email protected]> * addressing comments part 1 * Update SU2_CFD/src/solvers/CIncNSSolver.cpp Co-authored-by: Pedro Gomes <[email protected]> * addressing comments part 2 * addressing comments part 3 * updating residuals * updating residuals and .ref files * updating residual custom_source_buoyancy * computing enthalpy based on NASA polynomials for CIncIdealGasPolynomial * updating residuals inc_poly_cylinder * adding explanation enthalpy as passive scalar and updating zimont pywrapper * small addition to the explanation * updating residual python wrapper test case zimont * update residuals * Update SU2_CFD/include/fluid/CConstantDensity.hpp Co-authored-by: Nijso <[email protected]> * returning minimum temperature limits for Newton_Raphson when Cp is a polynomial * Update SU2_CFD/include/variables/CIncEulerVariable.hpp Co-authored-by: Pedro Gomes <[email protected]> * Update SU2_CFD/src/output/CFlowOutput.cpp Co-authored-by: Pedro Gomes <[email protected]> * Update SU2_CFD/include/fluid/CConstantDensity.hpp Co-authored-by: Pedro Gomes <[email protected]> * Update SU2_CFD/src/output/CAdjFlowIncOutput.cpp Co-authored-by: Pedro Gomes <[email protected]> * fix compile issue * moving Energy flag to CIncNSVariable and making it constant * fixing jacobian contribution energy equation for radiation model * updating residuals p1model parallel regression * undo changes of_grad_cd.csv.ref p1adjoint test case * returning to develop branch in regression.yml --------- Co-authored-by: Cristopher-Morales <[email protected]> Co-authored-by: Pedro Gomes <[email protected]> Co-authored-by: Nijso <[email protected]>
1 parent e27908e commit 2c0049f

File tree

58 files changed

+1200
-291
lines changed

Some content is hidden

Large Commits have some content hidden by default. Use the searchbox below for content that may be hidden.

58 files changed

+1200
-291
lines changed

Common/include/CConfig.hpp

Lines changed: 7 additions & 0 deletions
Original file line numberDiff line numberDiff line change
@@ -919,6 +919,7 @@ class CConfig {
919919
Initial_BCThrust, /*!< \brief Ratio of turbulent to laminar viscosity at the actuator disk. */
920920
Pressure_FreeStream, /*!< \brief Total pressure of the fluid. */
921921
Pressure_Thermodynamic, /*!< \brief Thermodynamic pressure of the fluid. */
922+
Standard_Ref_Temperature, /*!< \brief Standard reference temperature for multicomponent flows. */
922923
Temperature_FreeStream, /*!< \brief Total temperature of the fluid. */
923924
Temperature_ve_FreeStream; /*!< \brief Total vibrational-electronic temperature of the fluid. */
924925
unsigned short wallModel_MaxIter; /*!< \brief maximum number of iterations for the Newton method for the wall model */
@@ -1958,6 +1959,12 @@ class CConfig {
19581959
*/
19591960
su2double GetPressure_Thermodynamic(void) const { return Pressure_Thermodynamic; }
19601961

1962+
/*!
1963+
* \brief Get the value of the standard reference temperature for multicomponent flows.
1964+
* \return Standard reference temperature, Non-dimensionalized if it is needed for Non-Dimensional problems.
1965+
*/
1966+
su2double GetStandard_RefTemperatureND(void) const { return Standard_Ref_Temperature / Temperature_Ref; }
1967+
19611968
/*!
19621969
* \brief Get the value of the non-dimensionalized thermodynamic pressure.
19631970
* \return Non-dimensionalized thermodynamic pressure.

Common/src/CConfig.cpp

Lines changed: 3 additions & 0 deletions
Original file line numberDiff line numberDiff line change
@@ -1229,6 +1229,9 @@ void CConfig::SetConfig_Options() {
12291229
addDoubleOption("GAMMA_VALUE", Gamma, 1.4);
12301230
/*!\brief THERMODYNAMIC_PRESSURE \n DESCRIPTION: Thermodynamics(operating) Pressure (101325 Pa), only for incompressible flows) \ingroup Config*/
12311231
addDoubleOption("THERMODYNAMIC_PRESSURE", Pressure_Thermodynamic, 101325.0);
1232+
/*!\brief STANDARD_REFERENCE_TEMPERATURE \n DESCRIPTION: Standard reference temperature (298.15K), only for
1233+
* multicomponent incompressible flows) \ingroup Config*/
1234+
addDoubleOption("STANDARD_REFERENCE_TEMPERATURE", Standard_Ref_Temperature, 298.15);
12321235
/*!\brief CP_VALUE \n DESCRIPTION: Specific heat at constant pressure, Cp (1004.703 J/kg*K (air), constant density incompressible fluids only) \ingroup Config*/
12331236
addDoubleListOption("SPECIFIC_HEAT_CP", nSpecific_Heat_Cp, Specific_Heat_Cp);
12341237
/*!\brief THERMAL_EXPANSION_COEFF \n DESCRIPTION: Thermal expansion coefficient (0.00347 K^-1 (air), used for Boussinesq approximation for liquids/non-ideal gases) \ingroup Config*/

SU2_CFD/include/fluid/CConstantDensity.hpp

Lines changed: 11 additions & 0 deletions
Original file line numberDiff line numberDiff line change
@@ -56,5 +56,16 @@ class CConstantDensity final : public CFluidModel {
5656
decoupled equation. Hence, we update the value.
5757
Note Cp = Cv, (gamma = 1).*/
5858
Temperature = t;
59+
Enthalpy = Cp * Temperature;
60+
}
61+
62+
/*!
63+
* \brief Set the Dimensionless State using Enthalpy.
64+
* \param[in] val_enthalpy - Enthalpy value at the point.
65+
* \param[in] val_scalars - not used here.
66+
*/
67+
void SetTDState_h(su2double val_enthalpy, const su2double* val_scalars = nullptr) override {
68+
Enthalpy = val_enthalpy;
69+
Temperature = Enthalpy / Cp;
5970
}
6071
};

SU2_CFD/include/fluid/CFluidFlamelet.hpp

Lines changed: 7 additions & 0 deletions
Original file line numberDiff line numberDiff line change
@@ -118,6 +118,13 @@ class CFluidFlamelet final : public CFluidModel {
118118
*/
119119
void SetTDState_T(su2double val_temperature, const su2double* val_scalars = nullptr) override;
120120

121+
/*!
122+
* \brief Set the thermodynamic state.
123+
* \param[in] val_enthalpy - enthalpy
124+
* \param[in] val_scalars - pointer to species mass fractions
125+
*/
126+
void SetTDState_h(su2double val_enthalpy, const su2double* val_scalars = nullptr) override;
127+
121128
/*!
122129
* \brief Evaluate data-set for flamelet simulations.
123130
* \param[in] input_scalar - controlling variables used to interpolate manifold.

SU2_CFD/include/fluid/CFluidModel.hpp

Lines changed: 37 additions & 0 deletions
Original file line numberDiff line numberDiff line change
@@ -47,6 +47,7 @@ class CLookUpTable;
4747
class CFluidModel {
4848
protected:
4949
su2double StaticEnergy{0.0}; /*!< \brief Internal Energy. */
50+
su2double Enthalpy{0.0}; /*!<*\brief Enthalpy. */
5051
su2double Entropy{0.0}; /*!< \brief Entropy. */
5152
su2double Density{0.0}; /*!< \brief Density. */
5253
su2double Pressure{0.0}; /*!< \brief Pressure. */
@@ -113,6 +114,11 @@ class CFluidModel {
113114
*/
114115
su2double GetStaticEnergy() const { return StaticEnergy; }
115116

117+
/*!
118+
* \brief Get fluid enthalpy.
119+
*/
120+
su2double GetEnthalpy() const { return Enthalpy; }
121+
116122
/*!
117123
* \brief Get fluid density.
118124
*/
@@ -186,6 +192,30 @@ class CFluidModel {
186192
return mass_diffusivity;
187193
}
188194

195+
/*!
196+
* \brief Get the enthalpy diffusivity terms for all species being solved.
197+
*
198+
* This function computes and retrieves the enthalpy diffusion terms required in the energy equation
199+
* for multicomponent flows.
200+
*
201+
* \param[in,out] enthalpy_diffusions - Array containing the enthalpy diffusion terms for all
202+
* species to be solved. The size of \p enthalpy_diffusions must be at least (n_species_mixture - 1),
203+
* corresponding to the number of species transport equations in the system.
204+
*/
205+
virtual void GetEnthalpyDiffusivity(su2double* enthalpy_diffusions = nullptr) const {}
206+
207+
/*!
208+
* \brief Get the gradient of enthalpy diffusivity terms for all species being solved.
209+
*
210+
* This function computes and retrieves the gradient of the enthalpy diffusion terms with respect to temperature.
211+
* These terms are required for implicit computations when solving the energy equation for multicomponent flows.
212+
*
213+
* \param[in,out] grad_enthalpy_diffusions - Array containing the gradient of enthalpy diffusion terms for all
214+
* species to be solved. The size of \p grad_enthalpy_diffusions must be at least (n_species_mixture - 1),
215+
* corresponding to the number of species transport equations in the system.
216+
*/
217+
virtual void GetGradEnthalpyDiffusivity(su2double* grad_enthalpy_diffusions = nullptr) const {}
218+
189219
/*!
190220
* \brief Get fluid pressure partial derivative.
191221
*/
@@ -339,6 +369,13 @@ class CFluidModel {
339369
*/
340370
virtual void SetTDState_T(su2double val_Temperature, const su2double* val_scalars = nullptr) {}
341371

372+
/*!
373+
* \brief Virtual member.
374+
* \param[in] val_enthalpy - Enthalpy value at the point.
375+
* \param[in] val_scalars - Scalar mass fractions.
376+
*/
377+
virtual void SetTDState_h(su2double val_enthalpy, const su2double* val_scalars = nullptr) {}
378+
342379
/*!
343380
* \brief Set fluid eddy viscosity provided by a turbulence model needed for computing effective thermal conductivity.
344381
*/

SU2_CFD/include/fluid/CFluidScalar.hpp

Lines changed: 41 additions & 3 deletions
Original file line numberDiff line numberDiff line change
@@ -40,10 +40,12 @@
4040
class CFluidScalar final : public CFluidModel {
4141
private:
4242
const int n_species_mixture; /*!< \brief Number of species in mixture. */
43-
su2double Gas_Constant; /*!< \brief Specific gas constant. */
43+
su2double Gas_Constant; /*!< \brief Specific gas constant. */
4444
const su2double Pressure_Thermodynamic; /*!< \brief Constant pressure thermodynamic. */
45+
const su2double Ref_Temperature; /*!< \brief Standard Reference temperature, usually set to 298.15 K. */
4546
const su2double GasConstant_Ref; /*!< \brief Gas constant reference needed for Nondimensional problems. */
46-
const su2double Prandtl_Number; /*!< \brief Prandlt number.*/
47+
const su2double Prandtl_Turb_Number; /*!< \brief Prandlt turbulent number.*/
48+
const su2double Schmidt_Turb_Number; /*!< \brief Schmidt turbulent number.*/
4749

4850
const bool wilke;
4951
const bool davidson;
@@ -91,6 +93,11 @@ class CFluidScalar final : public CFluidModel {
9193
*/
9294
su2double ComputeMeanSpecificHeatCp(const su2double* val_scalars);
9395

96+
/*!
97+
* \brief Compute Enthalpy given the temperature and scalars.
98+
*/
99+
su2double ComputeEnthalpyFromT(const su2double val_temperature, const su2double* val_scalars);
100+
94101
/*!
95102
* \brief Compute gas constant for mixture.
96103
*/
@@ -130,16 +137,47 @@ class CFluidScalar final : public CFluidModel {
130137
/*!
131138
* \brief Get fluid thermal conductivity.
132139
*/
133-
inline su2double GetThermalConductivity() override { return Kt + Mu_Turb * Cp / Prandtl_Number; }
140+
inline su2double GetThermalConductivity() override { return Kt + Mu_Turb * Cp / Prandtl_Turb_Number; }
134141

135142
/*!
136143
* \brief Get fluid mass diffusivity.
137144
*/
138145
inline su2double GetMassDiffusivity(int ivar) override { return massDiffusivity[ivar]; }
139146

147+
/*!
148+
* \brief Get the enthalpy diffusivity terms for all species being solved.
149+
*
150+
* This function computes and retrieves the enthalpy diffusion terms required in the energy equation
151+
* for multicomponent flows.
152+
*
153+
* \param[in,out] enthalpy_diffusions - Array containing the enthalpy diffusion terms for all
154+
* species to be solved. The size of \p enthalpy_diffusions must be at least (n_species_mixture - 1),
155+
* corresponding to the number of species transport equations in the system.
156+
*/
157+
void GetEnthalpyDiffusivity(su2double* enthalpy_diffusions) const override;
158+
159+
/*!
160+
* \brief Get the gradient of enthalpy diffusivity terms for all species being solved.
161+
*
162+
* This function computes and retrieves the gradient of the enthalpy diffusion terms with respect to temperature.
163+
* These terms are required for implicit computations when solving the energy equation for multicomponent flows.
164+
*
165+
* \param[in,out] grad_enthalpy_diffusions - Array containing the gradient of enthalpy diffusion terms for all
166+
* species to be solved. The size of \p grad_enthalpy_diffusions must be at least (n_species_mixture - 1),
167+
* corresponding to the number of species transport equations in the system.
168+
*/
169+
void GetGradEnthalpyDiffusivity(su2double* grad_enthalpy_diffusions) const override;
170+
140171
/*!
141172
* \brief Set the Dimensionless State using Temperature.
142173
* \param[in] t - Temperature value at the point.
143174
*/
144175
void SetTDState_T(su2double val_temperature, const su2double* val_scalars) override;
176+
177+
/*!
178+
* \brief Virtual member.
179+
* \param[in] val_enthalpy - Enthalpy value at the point.
180+
* \param[in] val_scalars - Scalar mass fractions.
181+
*/
182+
void SetTDState_h(su2double val_enthalpy, const su2double* val_scalars = nullptr) override;
145183
};

SU2_CFD/include/fluid/CIncIdealGas.hpp

Lines changed: 11 additions & 0 deletions
Original file line numberDiff line numberDiff line change
@@ -58,6 +58,17 @@ class CIncIdealGas final : public CFluidModel {
5858
/*--- The EoS only depends upon temperature. ---*/
5959
Temperature = t;
6060
Density = Pressure / (Temperature * Gas_Constant);
61+
Enthalpy = Cp * Temperature;
62+
}
63+
64+
/*!
65+
* \brief Set the Dimensionless State using Enthalpy.
66+
* \param[in] val_enthalpy - Enthalpy value at the point.
67+
*/
68+
void SetTDState_h(su2double val_enthalpy, const su2double* val_scalars = nullptr) override {
69+
Enthalpy = val_enthalpy;
70+
Temperature = Enthalpy / Cp;
71+
Density = Pressure / (Temperature * Gas_Constant);
6172
}
6273

6374
private:

SU2_CFD/include/fluid/CIncIdealGasPolynomial.hpp

Lines changed: 60 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -58,9 +58,15 @@ class CIncIdealGasPolynomial final : public CFluidModel {
5858
* \param[in] config - configuration container for the problem.
5959
*/
6060
void SetCpModel(const CConfig* config) override {
61+
const su2double t_ref = config->GetStandard_RefTemperatureND();
62+
Enthalpy_Ref = 0.0;
63+
su2double t_i = 1.0;
6164
for (int i = 0; i < N; ++i) {
65+
t_i *= t_ref;
6266
coeffs_[i] = config->GetCp_PolyCoeffND(i);
67+
Enthalpy_Ref += coeffs_[i] * t_i / (i + 1);
6368
}
69+
Temperature_Min = config->GetTemperatureLimits(0);
6470
}
6571

6672
/*!
@@ -72,18 +78,70 @@ class CIncIdealGasPolynomial final : public CFluidModel {
7278
Temperature = t;
7379
Density = Pressure / (Temperature * Gas_Constant);
7480

75-
/* Evaluate the new Cp from the coefficients and temperature. */
81+
/* Evaluate the new Cp and enthalpy from the coefficients and temperature. */
7682
Cp = coeffs_[0];
83+
Enthalpy = coeffs_[0] * t - Enthalpy_Ref;
7784
su2double t_i = 1.0;
7885
for (int i = 1; i < N; ++i) {
7986
t_i *= t;
8087
Cp += coeffs_[i] * t_i;
88+
Enthalpy += coeffs_[i] * t_i * t / (i + 1);
89+
}
90+
Cv = Cp / Gamma;
91+
}
92+
93+
/*!
94+
* \brief Set the Dimensionless State using enthalpy.
95+
* \param[in] val_enthalpy - Enthalpy value at the point.
96+
*/
97+
void SetTDState_h(su2double val_enthalpy, const su2double* val_scalars = nullptr) override {
98+
Enthalpy = val_enthalpy;
99+
/*--- convergence criterion for temperature in [K], high accuracy needed for restarts. ---*/
100+
const su2double toll = 1e-5;
101+
su2double temp_iter = 300.0;
102+
su2double Cp_iter = 0.0;
103+
su2double delta_temp_iter = 1e10;
104+
su2double delta_enthalpy_iter;
105+
const int counter_limit = 20;
106+
107+
int counter = 0;
108+
109+
/*--- Computing temperature given enthalpy using Newton-Raphson. ---*/
110+
while ((abs(delta_temp_iter) > toll) && (counter++ < counter_limit)) {
111+
/* Evaluate the new Cp and enthalpy from the coefficients and temperature. */
112+
Cp_iter = coeffs_[0];
113+
su2double Enthalpy_iter = coeffs_[0] * temp_iter - Enthalpy_Ref;
114+
su2double t_i = 1.0;
115+
for (int i = 1; i < N; ++i) {
116+
t_i *= temp_iter;
117+
Cp_iter += coeffs_[i] * t_i;
118+
Enthalpy_iter += coeffs_[i] * t_i * temp_iter / (i + 1);
119+
}
120+
121+
delta_enthalpy_iter = Enthalpy - Enthalpy_iter;
122+
123+
delta_temp_iter = delta_enthalpy_iter / Cp_iter;
124+
125+
temp_iter += delta_temp_iter;
126+
if (temp_iter < Temperature_Min) {
127+
cout << "Warning: Negative temperature has been found during Newton-Raphson" << endl;
128+
temp_iter = Temperature_Min;
129+
break;
130+
}
131+
}
132+
Temperature = temp_iter;
133+
Cp = Cp_iter;
134+
if (counter == counter_limit) {
135+
cout << "Warning Newton-Raphson exceed number of max iteration in temperature computation" << endl;
81136
}
137+
Density = Pressure / (Temperature * Gas_Constant);
82138
Cv = Cp / Gamma;
83139
}
84140

85141
private:
86142
su2double Gas_Constant{0.0}; /*!< \brief Specific Gas Constant. */
87143
su2double Gamma{0.0}; /*!< \brief Ratio of specific heats. */
88-
array<su2double, N> coeffs_; /*!< \brief Polynomial coefficients for conductivity as a function of temperature. */
144+
array<su2double, N> coeffs_; /*!< \brief Polynomial coefficients for heat capacity as a function of temperature. */
145+
su2double Enthalpy_Ref; /*!< \brief Enthalpy computed at the reference temperature. */
146+
su2double Temperature_Min; /*!< \brief Minimum temperature value allowed in Newton-Raphson iterations. */
89147
};

SU2_CFD/include/numerics/CNumerics.hpp

Lines changed: 26 additions & 10 deletions
Original file line numberDiff line numberDiff line change
@@ -129,6 +129,10 @@ class CNumerics {
129129
const su2double
130130
*ScalarVar_i, /*!< \brief Vector of scalar variables at point i. */
131131
*ScalarVar_j; /*!< \brief Vector of scalar variables at point j. */
132+
su2double
133+
HeatFluxDiffusion; /*!< \brief Heat flux due to enthalpy diffusion for multicomponent. */
134+
su2double
135+
JacHeatFluxDiffusion; /*!< \brief Heat flux jacobian due to enthalpy diffusion for multicomponent. */
132136
const su2double
133137
*TransVar_i, /*!< \brief Vector of turbulent variables at point i. */
134138
*TransVar_j; /*!< \brief Vector of turbulent variables at point j. */
@@ -187,6 +191,8 @@ class CNumerics {
187191

188192
bool nemo; /*!< \brief Flag for NEMO problems */
189193

194+
bool energy_multicomponent = false; /*!< \brief Flag for multicomponent and reacting flow */
195+
190196
bool bounded_scalar = false; /*!< \brief Flag for bounded scalar problem */
191197

192198
public:
@@ -750,6 +756,20 @@ class CNumerics {
750756
Diffusion_Coeff_j = val_diffusioncoeff_j;
751757
}
752758

759+
/*!
760+
* \brief Set the heat flux due to enthalpy diffusion
761+
* \param[in] val_heatfluxdiffusion - Value of the heat flux due to enthalpy diffusion.
762+
*/
763+
inline void SetHeatFluxDiffusion(su2double val_heatfluxdiffusion) { HeatFluxDiffusion = val_heatfluxdiffusion; }
764+
765+
/*!
766+
* \brief Set Jacobian of the heat flux due to enthalpy diffusion
767+
* \param[in] val_jacheatfluxdiffusion - Value of the heat flux jacobian due to enthalpy diffusion.
768+
*/
769+
inline void SetJacHeatFluxDiffusion(su2double val_jacheatfluxdiffusion) {
770+
JacHeatFluxDiffusion = val_jacheatfluxdiffusion;
771+
}
772+
753773
/*!
754774
* \brief Set the laminar viscosity.
755775
* \param[in] val_laminar_viscosity_i - Value of the laminar viscosity at point i.
@@ -1038,8 +1058,7 @@ class CNumerics {
10381058
* \param[in] val_density - Value of the density.
10391059
* \param[in] val_velocity - Pointer to the velocity.
10401060
* \param[in] val_betainc2 - Value of the artificial compresibility factor.
1041-
* \param[in] val_cp - Value of the specific heat at constant pressure.
1042-
* \param[in] val_temperature - Value of the temperature.
1061+
* \param[in] val_enthalpy - Value of the enthalpy.
10431062
* \param[in] val_dRhodT - Value of the derivative of density w.r.t. temperature.
10441063
* \param[in] val_normal - Normal vector, the norm of the vector is the area of the face.
10451064
* \param[in] val_scale - Scale of the projection.
@@ -1048,8 +1067,7 @@ class CNumerics {
10481067
void GetInviscidIncProjJac(const su2double *val_density,
10491068
const su2double *val_velocity,
10501069
const su2double *val_betainc2,
1051-
const su2double *val_cp,
1052-
const su2double *val_temperature,
1070+
const su2double *val_enthalpy,
10531071
const su2double *val_dRhodT,
10541072
const su2double *val_normal,
10551073
su2double val_scale,
@@ -1060,17 +1078,15 @@ class CNumerics {
10601078
* \param[in] val_density - Value of the density.
10611079
* \param[in] val_velocity - Pointer to the velocity.
10621080
* \param[in] val_betainc2 - Value of the artificial compresibility factor.
1063-
* \param[in] val_cp - Value of the specific heat at constant pressure.
1064-
* \param[in] val_temperature - Value of the temperature.
1065-
* \param[in] val_dRhodT - Value of the derivative of density w.r.t. temperature.
1081+
* \param[in] val_enthalpy - Value of the enthalpy.
1082+
* \param[in] val_dRhodh - Value of the derivative of density w.r.t. enthalpy.
10661083
* \param[out] val_Precon - Pointer to the preconditioning matrix.
10671084
*/
10681085
void GetPreconditioner(const su2double *val_density,
10691086
const su2double *val_velocity,
10701087
const su2double *val_betainc2,
1071-
const su2double *val_cp,
1072-
const su2double *val_temperature,
1073-
const su2double *val_drhodt,
1088+
const su2double *val_enthalpy,
1089+
const su2double *val_drhodh,
10741090
su2double **val_Precon) const;
10751091

10761092
/*!

0 commit comments

Comments
 (0)