Skip to content

Commit dc6fd60

Browse files
authored
Merge pull request #2394 from su2code/improve_heat_flux
Report heat fluxes as imposed by wall boundary conditions
2 parents fbf39d3 + 91fdb3f commit dc6fd60

File tree

11 files changed

+174
-152
lines changed

11 files changed

+174
-152
lines changed

Common/include/toolboxes/geometry_toolbox.hpp

Lines changed: 8 additions & 0 deletions
Original file line numberDiff line numberDiff line change
@@ -79,6 +79,14 @@ inline T Norm(Int nDim, const T* a) {
7979
return sqrt(SquaredNorm(nDim, a));
8080
}
8181

82+
/*! \brief dn = max(abs(n.(a-b)), 0.05 * ||a-b|| */
83+
template <class T, typename Int>
84+
inline T NormalDistance(Int nDim, const T* n, const T* a, const T* b) {
85+
T d[3] = {0};
86+
Distance(nDim, a, b, d);
87+
return fmax(fabs(DotProduct(nDim, n, d)), 0.05 * Norm(nDim, d));
88+
}
89+
8290
/*! \brief c = a x b */
8391
template <class T>
8492
inline void CrossProduct(const T* a, const T* b, T* c) {

SU2_CFD/include/solvers/CFVMFlowSolverBase.inl

Lines changed: 34 additions & 13 deletions
Original file line numberDiff line numberDiff line change
@@ -2357,12 +2357,11 @@ void CFVMFlowSolverBase<V, FlowRegime>::Friction_Forces(const CGeometry* geometr
23572357
const su2double *Coord = nullptr, *Coord_Normal = nullptr, *Normal = nullptr;
23582358
const su2double minYPlus = config->GetwallModel_MinYPlus();
23592359

2360-
string Marker_Tag, Monitoring_Tag;
2361-
23622360
const su2double Alpha = config->GetAoA() * PI_NUMBER / 180.0;
23632361
const su2double Beta = config->GetAoS() * PI_NUMBER / 180.0;
23642362
const su2double RefLength = config->GetRefLength();
23652363
const su2double RefHeatFlux = config->GetHeat_Flux_Ref();
2364+
const su2double RefTemperature = config->GetTemperature_Ref();
23662365
const su2double Gas_Constant = config->GetGas_ConstantND();
23672366
auto Origin = config->GetRefOriginMoment(0);
23682367

@@ -2393,15 +2392,17 @@ void CFVMFlowSolverBase<V, FlowRegime>::Friction_Forces(const CGeometry* geometr
23932392

23942393
for (iMarker = 0; iMarker < nMarker; iMarker++) {
23952394

2396-
Marker_Tag = config->GetMarker_All_TagBound(iMarker);
23972395
if (!config->GetViscous_Wall(iMarker)) continue;
2396+
const auto Marker_Tag = config->GetMarker_All_TagBound(iMarker);
2397+
2398+
const bool py_custom = config->GetMarker_All_PyCustom(iMarker);
23982399

23992400
/*--- Obtain the origin for the moment computation for a particular marker ---*/
24002401

24012402
const auto Monitoring = config->GetMarker_All_Monitoring(iMarker);
24022403
if (Monitoring == YES) {
24032404
for (iMarker_Monitoring = 0; iMarker_Monitoring < config->GetnMarker_Monitoring(); iMarker_Monitoring++) {
2404-
Monitoring_Tag = config->GetMarker_Monitoring_TagBound(iMarker_Monitoring);
2405+
const auto Monitoring_Tag = config->GetMarker_Monitoring_TagBound(iMarker_Monitoring);
24052406
if (Marker_Tag == Monitoring_Tag) Origin = config->GetRefOriginMoment(iMarker_Monitoring);
24062407
}
24072408
}
@@ -2506,26 +2507,47 @@ void CFVMFlowSolverBase<V, FlowRegime>::Friction_Forces(const CGeometry* geometr
25062507

25072508
/*--- Compute total and maximum heat flux on the wall ---*/
25082509

2509-
su2double dTdn = -GeometryToolbox::DotProduct(nDim, Grad_Temp, UnitNormal);
2510-
2511-
if (!nemo){
2512-
2510+
if (!nemo) {
25132511
if (FlowRegime == ENUM_REGIME::COMPRESSIBLE) {
2514-
25152512
Cp = (Gamma / Gamma_Minus_One) * Gas_Constant;
25162513
thermal_conductivity = Cp * Viscosity / Prandtl_Lam;
25172514
}
25182515
if (FlowRegime == ENUM_REGIME::INCOMPRESSIBLE) {
2519-
if (!energy) dTdn = 0.0;
25202516
thermal_conductivity = nodes->GetThermalConductivity(iPoint);
25212517
}
2522-
HeatFlux[iMarker][iVertex] = -thermal_conductivity * dTdn * RefHeatFlux;
25232518

2519+
if (config->GetMarker_All_KindBC(iMarker) == BC_TYPE::HEAT_FLUX) {
2520+
if (py_custom) {
2521+
HeatFlux[iMarker][iVertex] = -geometry->GetCustomBoundaryHeatFlux(iMarker, iVertex);
2522+
} else {
2523+
HeatFlux[iMarker][iVertex] = -config->GetWall_HeatFlux(Marker_Tag);
2524+
if (config->GetIntegrated_HeatFlux()) {
2525+
HeatFlux[iMarker][iVertex] /= geometry->GetSurfaceArea(config, iMarker);
2526+
}
2527+
}
2528+
} else if (config->GetMarker_All_KindBC(iMarker) == BC_TYPE::ISOTHERMAL) {
2529+
su2double Twall = 0.0;
2530+
if (py_custom) {
2531+
Twall = geometry->GetCustomBoundaryTemperature(iMarker, iVertex) / RefTemperature;
2532+
} else {
2533+
Twall = config->GetIsothermal_Temperature(Marker_Tag) / RefTemperature;
2534+
}
2535+
iPointNormal = geometry->vertex[iMarker][iVertex]->GetNormal_Neighbor();
2536+
Coord_Normal = geometry->nodes->GetCoord(iPointNormal);
2537+
const su2double dist_ij = GeometryToolbox::NormalDistance(nDim, UnitNormal, Coord, Coord_Normal);
2538+
const su2double There = nodes->GetTemperature(iPointNormal);
2539+
HeatFlux[iMarker][iVertex] = thermal_conductivity * (There - Twall) / dist_ij * RefHeatFlux;
2540+
} else {
2541+
su2double dTdn = GeometryToolbox::DotProduct(nDim, Grad_Temp, UnitNormal);
2542+
if (FlowRegime == ENUM_REGIME::INCOMPRESSIBLE && !energy) dTdn = 0.0;
2543+
HeatFlux[iMarker][iVertex] = thermal_conductivity * dTdn * RefHeatFlux;
2544+
}
25242545
} else {
25252546

25262547
const auto& thermal_conductivity_tr = nodes->GetThermalConductivity(iPoint);
25272548
const auto& thermal_conductivity_ve = nodes->GetThermalConductivity_ve(iPoint);
25282549

2550+
const su2double dTdn = -GeometryToolbox::DotProduct(nDim, Grad_Temp, UnitNormal);
25292551
const su2double dTvedn = -GeometryToolbox::DotProduct(nDim, Grad_Temp_ve, UnitNormal);
25302552

25312553
/*--- Surface energy balance: trans-rot heat flux, vib-el heat flux ---*/
@@ -2653,8 +2675,7 @@ void CFVMFlowSolverBase<V, FlowRegime>::Friction_Forces(const CGeometry* geometr
26532675
/*--- Compute the coefficients per surface ---*/
26542676

26552677
for (iMarker_Monitoring = 0; iMarker_Monitoring < config->GetnMarker_Monitoring(); iMarker_Monitoring++) {
2656-
Monitoring_Tag = config->GetMarker_Monitoring_TagBound(iMarker_Monitoring);
2657-
Marker_Tag = config->GetMarker_All_TagBound(iMarker);
2678+
const auto Monitoring_Tag = config->GetMarker_Monitoring_TagBound(iMarker_Monitoring);
26582679
if (Marker_Tag == Monitoring_Tag) {
26592680
SurfaceViscCoeff.CL[iMarker_Monitoring] += ViscCoeff.CL[iMarker];
26602681
SurfaceViscCoeff.CD[iMarker_Monitoring] += ViscCoeff.CD[iMarker];

SU2_CFD/src/solvers/CIncNSSolver.cpp

Lines changed: 12 additions & 15 deletions
Original file line numberDiff line numberDiff line change
@@ -341,7 +341,6 @@ void CIncNSSolver::BC_Wall_Generic(const CGeometry *geometry, const CConfig *con
341341
/*--- Variables for streamwise periodicity ---*/
342342
const bool streamwise_periodic = (config->GetKind_Streamwise_Periodic() != ENUM_STREAMWISE_PERIODIC::NONE);
343343
const bool streamwise_periodic_temperature = config->GetStreamwise_Periodic_Temperature();
344-
su2double Cp, thermal_conductivity, dot_product, scalar_factor;
345344

346345
/*--- Identify the boundary by string name ---*/
347346

@@ -434,15 +433,17 @@ void CIncNSSolver::BC_Wall_Generic(const CGeometry *geometry, const CConfig *con
434433
/*--- With streamwise periodic flow and heatflux walls an additional term is introduced in the boundary formulation ---*/
435434
if (streamwise_periodic && streamwise_periodic_temperature) {
436435

437-
Cp = nodes->GetSpecificHeatCp(iPoint);
438-
thermal_conductivity = nodes->GetThermalConductivity(iPoint);
436+
const su2double Cp = nodes->GetSpecificHeatCp(iPoint);
437+
const su2double thermal_conductivity = nodes->GetThermalConductivity(iPoint);
439438

440439
/*--- Scalar factor of the residual contribution ---*/
441440
const su2double norm2_translation = GeometryToolbox::SquaredNorm(nDim, config->GetPeriodic_Translation(0));
442-
scalar_factor = SPvals.Streamwise_Periodic_IntegratedHeatFlow*thermal_conductivity / (SPvals.Streamwise_Periodic_MassFlow * Cp * norm2_translation);
441+
const su2double scalar_factor =
442+
SPvals.Streamwise_Periodic_IntegratedHeatFlow*thermal_conductivity /
443+
(SPvals.Streamwise_Periodic_MassFlow * Cp * norm2_translation);
443444

444445
/*--- Dot product ---*/
445-
dot_product = GeometryToolbox::DotProduct(nDim, config->GetPeriodic_Translation(0), Normal);
446+
const su2double dot_product = GeometryToolbox::DotProduct(nDim, config->GetPeriodic_Translation(0), Normal);
446447

447448
LinSysRes(iPoint, nDim+1) += scalar_factor*dot_product;
448449
} // if streamwise_periodic
@@ -472,18 +473,17 @@ void CIncNSSolver::BC_Wall_Generic(const CGeometry *geometry, const CConfig *con
472473

473474
const auto Coord_i = geometry->nodes->GetCoord(iPoint);
474475
const auto Coord_j = geometry->nodes->GetCoord(Point_Normal);
475-
su2double Edge_Vector[MAXNDIM];
476-
GeometryToolbox::Distance(nDim, Coord_j, Coord_i, Edge_Vector);
477-
su2double dist_ij_2 = GeometryToolbox::SquaredNorm(nDim, Edge_Vector);
478-
su2double dist_ij = sqrt(dist_ij_2);
476+
su2double UnitNormal[MAXNDIM] = {0.0};
477+
for (auto iDim = 0u; iDim < nDim; ++iDim) UnitNormal[iDim] = Normal[iDim] / Area;
478+
const su2double dist_ij = GeometryToolbox::NormalDistance(nDim, UnitNormal, Coord_i, Coord_j);
479479

480480
/*--- Compute the normal gradient in temperature using Twall ---*/
481481

482-
su2double dTdn = -(nodes->GetTemperature(Point_Normal) - Twall)/dist_ij;
482+
const su2double dTdn = -(nodes->GetTemperature(Point_Normal) - Twall)/dist_ij;
483483

484484
/*--- Get thermal conductivity ---*/
485485

486-
su2double thermal_conductivity = nodes->GetThermalConductivity(iPoint);
486+
const su2double thermal_conductivity = nodes->GetThermalConductivity(iPoint);
487487

488488
/*--- Apply a weak boundary condition for the energy equation.
489489
Compute the residual due to the prescribed heat flux. ---*/
@@ -493,10 +493,7 @@ void CIncNSSolver::BC_Wall_Generic(const CGeometry *geometry, const CConfig *con
493493
/*--- Jacobian contribution for temperature equation. ---*/
494494

495495
if (implicit) {
496-
su2double proj_vector_ij = 0.0;
497-
if (dist_ij_2 > 0.0)
498-
proj_vector_ij = GeometryToolbox::DotProduct(nDim, Edge_Vector, Normal) / dist_ij_2;
499-
Jacobian.AddVal2Diag(iPoint, nDim+1, thermal_conductivity*proj_vector_ij);
496+
Jacobian.AddVal2Diag(iPoint, nDim+1, thermal_conductivity * Area / dist_ij);
500497
}
501498
break;
502499
} // switch

SU2_CFD/src/solvers/CNSSolver.cpp

Lines changed: 4 additions & 8 deletions
Original file line numberDiff line numberDiff line change
@@ -672,22 +672,19 @@ void CNSSolver::BC_Isothermal_Wall_Generic(CGeometry *geometry, CSolver **solver
672672

673673
const auto Coord_i = geometry->nodes->GetCoord(iPoint);
674674
const auto Coord_j = geometry->nodes->GetCoord(Point_Normal);
675-
676-
su2double dist_ij = GeometryToolbox::Distance(nDim, Coord_i, Coord_j);
675+
const su2double dist_ij = GeometryToolbox::NormalDistance(nDim, UnitNormal, Coord_i, Coord_j);
677676

678677
/*--- Store the corrected velocity at the wall which will
679678
be zero (v = 0), unless there is grid motion (v = u_wall)---*/
680679

681680
if (dynamic_grid) {
682681
nodes->SetVelocity_Old(iPoint, geometry->nodes->GetGridVel(iPoint));
683-
}
684-
else {
682+
} else {
685683
su2double zero[MAXNDIM] = {0.0};
686684
nodes->SetVelocity_Old(iPoint, zero);
687685
}
688686

689-
for (auto iDim = 0u; iDim < nDim; iDim++)
690-
LinSysRes(iPoint, iDim+1) = 0.0;
687+
for (auto iDim = 0u; iDim < nDim; iDim++) LinSysRes(iPoint, iDim+1) = 0.0;
691688
nodes->SetVel_ResTruncError_Zero(iPoint);
692689

693690
/*--- Get transport coefficients ---*/
@@ -708,8 +705,7 @@ void CNSSolver::BC_Isothermal_Wall_Generic(CGeometry *geometry, CSolver **solver
708705
if (cht_mode) {
709706
Twall = GetCHTWallTemperature(config, val_marker, iVertex, dist_ij,
710707
thermal_conductivity, There, Temperature_Ref);
711-
}
712-
else if (config->GetMarker_All_PyCustom(val_marker)) {
708+
} else if (config->GetMarker_All_PyCustom(val_marker)) {
713709
Twall = geometry->GetCustomBoundaryTemperature(val_marker, iVertex) / Temperature_Ref;
714710
}
715711

TestCases/hybrid_regression.py

Lines changed: 17 additions & 17 deletions
Original file line numberDiff line numberDiff line change
@@ -103,32 +103,32 @@ def main():
103103
flatplate.cfg_dir = "navierstokes/flatplate"
104104
flatplate.cfg_file = "lam_flatplate.cfg"
105105
flatplate.test_iter = 100
106-
flatplate.test_vals = [-7.679131, -2.206953, 0.001084, 0.036233, 2.361500, -2.325300, -1.984700, -1.984700]
106+
flatplate.test_vals = [-7.679131, -2.206953, 0.001084, 0.036233, 2.361500, -2.325300, 0, 0]
107107
test_list.append(flatplate)
108108

109109
# Laminar cylinder (steady)
110110
cylinder = TestCase('cylinder')
111111
cylinder.cfg_dir = "navierstokes/cylinder"
112112
cylinder.cfg_file = "lam_cylinder.cfg"
113113
cylinder.test_iter = 25
114-
cylinder.test_vals = [-8.266513, -2.783904, -0.019899, 1.615668, -0.010207]
114+
cylinder.test_vals = [-8.266513, -2.783904, -0.019899, 1.615668, 0]
115115
test_list.append(cylinder)
116116

117117
# Laminar cylinder (low Mach correction)
118118
cylinder_lowmach = TestCase('cylinder_lowmach')
119119
cylinder_lowmach.cfg_dir = "navierstokes/cylinder"
120120
cylinder_lowmach.cfg_file = "cylinder_lowmach.cfg"
121121
cylinder_lowmach.test_iter = 25
122-
cylinder_lowmach.test_vals = [-6.830996, -1.368850, -0.143956, 73.963354, 0.002457]
123-
cylinder_lowmach.test_vals_aarch64 = [-6.830996, -1.368850, -0.143956, 73.963354, 0.002457]
122+
cylinder_lowmach.test_vals = [-6.830996, -1.368850, -0.143956, 73.963354, 0]
123+
cylinder_lowmach.test_vals_aarch64 = [-6.830996, -1.368850, -0.143956, 73.963354, 0]
124124
test_list.append(cylinder_lowmach)
125125

126126
# 2D Poiseuille flow (body force driven with periodic inlet / outlet)
127127
poiseuille = TestCase('poiseuille')
128128
poiseuille.cfg_dir = "navierstokes/poiseuille"
129129
poiseuille.cfg_file = "lam_poiseuille.cfg"
130130
poiseuille.test_iter = 10
131-
poiseuille.test_vals = [-5.046131, 0.652984, 0.008355, 13.735818, -2.142500]
131+
poiseuille.test_vals = [-5.046131, 0.652984, 0.008355, 13.735818, 0]
132132
test_list.append(poiseuille)
133133

134134
# 2D Poiseuille flow (inlet profile file)
@@ -157,15 +157,15 @@ def main():
157157
rae2822_sa.cfg_dir = "rans/rae2822"
158158
rae2822_sa.cfg_file = "turb_SA_RAE2822.cfg"
159159
rae2822_sa.test_iter = 20
160-
rae2822_sa.test_vals = [-2.020123, -5.269339, 0.807147, 0.060499, -80603.000000]
160+
rae2822_sa.test_vals = [-2.020123, -5.269339, 0.807147, 0.060499, 0]
161161
test_list.append(rae2822_sa)
162162

163163
# RAE2822 SST
164164
rae2822_sst = TestCase('rae2822_sst')
165165
rae2822_sst.cfg_dir = "rans/rae2822"
166166
rae2822_sst.cfg_file = "turb_SST_RAE2822.cfg"
167167
rae2822_sst.test_iter = 20
168-
rae2822_sst.test_vals = [-0.510363, 4.872736, 0.815617, 0.060920, -73391.000000]
168+
rae2822_sst.test_vals = [-0.510363, 4.872736, 0.815617, 0.060920, 0]
169169
test_list.append(rae2822_sst)
170170

171171
# RAE2822 SST_SUST
@@ -189,24 +189,24 @@ def main():
189189
turb_oneram6.cfg_dir = "rans/oneram6"
190190
turb_oneram6.cfg_file = "turb_ONERAM6.cfg"
191191
turb_oneram6.test_iter = 10
192-
turb_oneram6.test_vals = [-2.408523, -6.662833, 0.238333, 0.158910, -52718]
192+
turb_oneram6.test_vals = [-2.408523, -6.662833, 0.238333, 0.158910, 0]
193193
test_list.append(turb_oneram6)
194194

195195
# NACA0012 (SA, FUN3D finest grid results: CL=1.0983, CD=0.01242)
196196
turb_naca0012_sa = TestCase('turb_naca0012_sa')
197197
turb_naca0012_sa.cfg_dir = "rans/naca0012"
198198
turb_naca0012_sa.cfg_file = "turb_NACA0012_sa.cfg"
199199
turb_naca0012_sa.test_iter = 5
200-
turb_naca0012_sa.test_vals = [-12.098325, -14.149988, 1.057665, 0.022971, 20.000000, -2.292707, 0.000000, -12.068169, -44.871000]
201-
turb_naca0012_sa.test_vals_aarch64 = [-12.098325, -14.149988, 1.057665, 0.022971, 20.000000, -2.292707, 0.000000, -12.068169, -44.871000]
200+
turb_naca0012_sa.test_vals = [-12.098325, -14.149988, 1.057665, 0.022971, 20.000000, -2.292707, 0.000000, -12.068169, 0]
201+
turb_naca0012_sa.test_vals_aarch64 = [-12.098325, -14.149988, 1.057665, 0.022971, 20.000000, -2.292707, 0.000000, -12.068169, 0]
202202
test_list.append(turb_naca0012_sa)
203203

204204
# NACA0012 (SST, FUN3D finest grid results: CL=1.0840, CD=0.01253)
205205
turb_naca0012_sst = TestCase('turb_naca0012_sst')
206206
turb_naca0012_sst.cfg_dir = "rans/naca0012"
207207
turb_naca0012_sst.cfg_file = "turb_NACA0012_sst.cfg"
208208
turb_naca0012_sst.test_iter = 10
209-
turb_naca0012_sst.test_vals = [-12.105781, -15.277738, -6.210248, 1.049757, 0.019249, -2.807857, -38.976000]
209+
turb_naca0012_sst.test_vals = [-12.105781, -15.277738, -6.210248, 1.049757, 0.019249, -2.807857, 0]
210210
test_list.append(turb_naca0012_sst)
211211

212212
# NACA0012 (SST_SUST, FUN3D finest grid results: CL=1.0840, CD=0.01253)
@@ -250,7 +250,7 @@ def main():
250250
axi_rans_air_nozzle_restart.cfg_dir = "axisymmetric_rans/air_nozzle"
251251
axi_rans_air_nozzle_restart.cfg_file = "air_nozzle_restart.cfg"
252252
axi_rans_air_nozzle_restart.test_iter = 10
253-
axi_rans_air_nozzle_restart.test_vals = [-12.070954, -7.407644, -8.698118, -4.008751, -3572.100000]
253+
axi_rans_air_nozzle_restart.test_vals = [-12.070954, -7.407644, -8.698118, -4.008751, 0]
254254
test_list.append(axi_rans_air_nozzle_restart)
255255

256256
#################################
@@ -381,8 +381,8 @@ def main():
381381
inc_poly_cylinder.cfg_dir = "incomp_navierstokes/cylinder"
382382
inc_poly_cylinder.cfg_file = "poly_cylinder.cfg"
383383
inc_poly_cylinder.test_iter = 20
384-
inc_poly_cylinder.test_vals = [-7.851512, -2.093420, 0.029974, 1.921595, -175.300000]
385-
inc_poly_cylinder.test_vals_aarch64 = [-7.851510, -2.093419, 0.029974, 1.921595, -175.300000]
384+
inc_poly_cylinder.test_vals = [-7.827942, -2.061513, 0.029525, 1.953498, -174.780000]
385+
inc_poly_cylinder.test_vals_aarch64 = [-7.827942, -2.061513, 0.029525, 1.953498, -174.780000]
386386
test_list.append(inc_poly_cylinder)
387387

388388
# X-coarse laminar bend as a mixed element CGNS test
@@ -452,8 +452,8 @@ def main():
452452
square_cylinder.cfg_dir = "unsteady/square_cylinder"
453453
square_cylinder.cfg_file = "turb_square.cfg"
454454
square_cylinder.test_iter = 3
455-
square_cylinder.test_vals = [-2.560839, -1.173497, 0.061188, 1.399403, 2.220575, 1.399351, 2.218781, -0.584690]
456-
square_cylinder.test_vals_aarch64 = [-2.557902, -1.173574, 0.058050, 1.399794, 2.220402, 1.399748, 2.218604, -0.453270]
455+
square_cylinder.test_vals = [-2.560839, -1.173497, 0.061188, 1.399403, 2.220575, 1.399351, 2.218781, 0]
456+
square_cylinder.test_vals_aarch64 = [-2.557902, -1.173574, 0.058050, 1.399794, 2.220402, 1.399748, 2.218604, 0]
457457
square_cylinder.unsteady = True
458458
test_list.append(square_cylinder)
459459

@@ -503,7 +503,7 @@ def main():
503503
ddes_flatplate.cfg_dir = "ddes/flatplate"
504504
ddes_flatplate.cfg_file = "ddes_flatplate.cfg"
505505
ddes_flatplate.test_iter = 10
506-
ddes_flatplate.test_vals = [-2.714786, -5.882652, -0.215041, 0.023758, -617.470000]
506+
ddes_flatplate.test_vals = [-2.714786, -5.882652, -0.215041, 0.023758, 0]
507507
ddes_flatplate.unsteady = True
508508
test_list.append(ddes_flatplate)
509509

TestCases/hybrid_regression_AD.py

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -110,8 +110,8 @@ def main():
110110
discadj_incomp_cylinder.cfg_dir = "disc_adj_incomp_navierstokes/cylinder"
111111
discadj_incomp_cylinder.cfg_file = "heated_cylinder.cfg"
112112
discadj_incomp_cylinder.test_iter = 20
113-
discadj_incomp_cylinder.test_vals = [20.000000, -2.705921, -2.837904, 0.000000]
114-
discadj_incomp_cylinder.test_vals_aarch64 = [20.000000, -2.705918, -2.837766, 0.000000]
113+
discadj_incomp_cylinder.test_vals = [20.000000, -2.746353, -2.934792, 0.000000]
114+
discadj_incomp_cylinder.test_vals_aarch64 = [20.000000, -2.746353, -2.934792, 0.000000]
115115
test_list.append(discadj_incomp_cylinder)
116116

117117
######################################

0 commit comments

Comments
 (0)