https://mooseframework.inl.gov
LinearAssemblySegregatedSolve.C
Go to the documentation of this file.
1 //* This file is part of the MOOSE framework
2 //* https://mooseframework.inl.gov
3 //*
4 //* All rights reserved, see COPYRIGHT for full restrictions
5 //* https://github.com/idaholab/moose/blob/master/COPYRIGHT
6 //*
7 //* Licensed under LGPL 2.1, please see LICENSE for details
8 //* https://www.gnu.org/licenses/lgpl-2.1.html
9 
11 #include "FEProblem.h"
12 #include "SegregatedSolverUtils.h"
13 #include "LinearSystem.h"
14 #include "Executioner.h"
15 
16 using namespace libMesh;
17 
20 {
22 
23  params.addParam<std::vector<SolverSystemName>>(
24  "active_scalar_systems", {}, "The solver system for each active scalar advection equation.");
25 
26  /*
27  * Parameters to control the solution of each scalar advection system
28  */
29  params.addParam<std::vector<Real>>("active_scalar_equation_relaxation",
30  std::vector<Real>(),
31  "The relaxation which should be used for the active scalar "
32  "equations. (=1 for no relaxation, "
33  "diagonal dominance will still be enforced)");
34 
35  params.addParam<MultiMooseEnum>("active_scalar_petsc_options",
37  "Singleton PETSc options for the active scalar equation(s)");
38  params.addParam<MultiMooseEnum>(
39  "active_scalar_petsc_options_iname",
41  "Names of PETSc name/value pairs for the active scalar equation(s)");
42  params.addParam<std::vector<std::string>>(
43  "active_scalar_petsc_options_value",
44  "Values of PETSc name/value pairs (must correspond with \"petsc_options_iname\" for the "
45  "active scalar equation(s)");
46  params.addParam<std::vector<Real>>(
47  "active_scalar_absolute_tolerance",
48  std::vector<Real>(),
49  "The absolute tolerance(s) on the normalized residual(s) of the active scalar equation(s).");
50  params.addRangeCheckedParam<Real>("active_scalar_l_tol",
51  1e-5,
52  "0.0<=active_scalar_l_tol & active_scalar_l_tol<1.0",
53  "The relative tolerance on the normalized residual in the "
54  "linear solver of the active scalar equation(s).");
55  params.addRangeCheckedParam<Real>("active_scalar_l_abs_tol",
56  1e-10,
57  "0.0<active_scalar_l_abs_tol",
58  "The absolute tolerance on the normalized residual in the "
59  "linear solver of the active scalar equation(s).");
60  params.addParam<unsigned int>(
61  "active_scalar_l_max_its",
62  10000,
63  "The maximum allowed iterations in the linear solver of the turbulence equation.");
64 
65  params.addParamNamesToGroup(
66  "active_scalar_systems active_scalar_equation_relaxation active_scalar_petsc_options "
67  "active_scalar_petsc_options_iname "
68  "active_scalar_petsc_options_value active_scalar_petsc_options_value "
69  "active_scalar_absolute_tolerance "
70  "active_scalar_l_tol active_scalar_l_abs_tol active_scalar_l_max_its",
71  "Active Scalars Equations");
72 
73  /*
74  * Parameters to control the conjugate heat transfer
75  */
77 
78  return params;
79 }
80 
82  : SIMPLESolveBase(ex),
83  _pressure_sys_number(_problem.linearSysNum(getParam<SolverSystemName>("pressure_system"))),
84  _pressure_system(_problem.getLinearSystem(_pressure_sys_number)),
85  _energy_sys_number(_has_energy_system
86  ? _problem.linearSysNum(getParam<SolverSystemName>("energy_system"))
88  _energy_system(_has_energy_system ? &_problem.getLinearSystem(_energy_sys_number) : nullptr),
89  _solid_energy_sys_number(
90  _has_solid_energy_system
91  ? _problem.linearSysNum(getParam<SolverSystemName>("solid_energy_system"))
93  _solid_energy_system(
94  _has_solid_energy_system ? &_problem.getLinearSystem(_solid_energy_sys_number) : nullptr),
95  _active_scalar_system_names(getParam<std::vector<SolverSystemName>>("active_scalar_systems")),
96  _has_active_scalar_systems(!_active_scalar_system_names.empty()),
97  _active_scalar_equation_relaxation(
98  getParam<std::vector<Real>>("active_scalar_equation_relaxation")),
99  _active_scalar_l_abs_tol(getParam<Real>("active_scalar_l_abs_tol")),
100  _active_scalar_absolute_tolerance(
101  getParam<std::vector<Real>>("active_scalar_absolute_tolerance")),
102  _cht(ex.parameters())
103 {
104  // We fetch the systems and their numbers for the momentum equations.
105  for (auto system_i : index_range(_momentum_system_names))
106  {
109  _systems_to_solve.push_back(_momentum_systems.back());
110  }
111 
113 
114  if (_has_energy_system)
116 
119  // and for the turbulence surrogate equations
121  for (auto system_i : index_range(_turbulence_system_names))
122  {
123  _turbulence_system_numbers.push_back(
125  _turbulence_systems.push_back(
127  }
128 
129  // and for the passive scalar equations
131  for (auto system_i : index_range(_passive_scalar_system_names))
132  {
135  _passive_scalar_systems.push_back(
137  _systems_to_solve.push_back(_passive_scalar_systems.back());
138  }
139 
140  // and for the active scalar equations
142  for (auto system_i : index_range(_active_scalar_system_names))
143  {
146  _active_scalar_systems.push_back(
148  _systems_to_solve.push_back(_active_scalar_systems.back());
149 
150  const auto & active_scalar_petsc_options =
151  getParam<MultiMooseEnum>("active_scalar_petsc_options");
152  const auto & active_scalar_petsc_pair_options = getParam<MooseEnumItem, std::string>(
153  "active_scalar_petsc_options_iname", "active_scalar_petsc_options_value");
155  active_scalar_petsc_options, "", *this, _active_scalar_petsc_options);
156  Moose::PetscSupport::addPetscPairsToPetscOptions(active_scalar_petsc_pair_options,
157  _problem.mesh().dimension(),
158  "",
159  *this,
161 
163  getParam<Real>("active_scalar_l_tol");
165  getParam<Real>("active_scalar_l_abs_tol");
167  getParam<unsigned int>("active_scalar_l_max_its");
168  }
169 
171  paramError("active_scalar_equation_relaxation",
172  "Should be the same size as the number of systems");
173 
174  // We disable the prefix here for the time being, the segregated solvers use a different approach
175  // for setting the petsc parameters
176  for (auto & system : _systems_to_solve)
177  system->system().prefix_with_name(false);
178 
179  // Link CHT objects, this will also do some error checking
180  if (_cht.enabled())
182 }
183 
184 void
186 {
187  _rc_uo =
188  const_cast<RhieChowMassFlux *>(&getUserObject<RhieChowMassFlux>("rhie_chow_user_object"));
191 
192  // Initialize the face velocities in the RC object
193  if (!_app.isRecovering())
196 }
197 
198 std::vector<std::pair<unsigned int, Real>>
200 {
201  // Temporary storage for the (flux-normalized) residuals from
202  // different momentum components
203  std::vector<std::pair<unsigned int, Real>> its_normalized_residuals;
204 
205  LinearImplicitSystem & momentum_system_0 =
206  libMesh::cast_ref<LinearImplicitSystem &>(_momentum_systems[0]->system());
207 
208  PetscLinearSolver<Real> & momentum_solver =
209  libMesh::cast_ref<PetscLinearSolver<Real> &>(*momentum_system_0.get_linear_solver());
210 
211  // Solve the momentum equations.
212  // TO DO: These equations are VERY similar. If we can store the differences (things coming from
213  // BCs for example) separately, it is enough to construct one matrix.
214  for (const auto system_i : index_range(_momentum_systems))
215  {
217 
218  // We will need the right hand side and the solution of the next component
219  LinearImplicitSystem & momentum_system =
220  libMesh::cast_ref<LinearImplicitSystem &>(_momentum_systems[system_i]->system());
221 
222  NumericVector<Number> & solution = *(momentum_system.solution);
223  NumericVector<Number> & rhs = *(momentum_system.rhs);
224  SparseMatrix<Number> & mmat = *(momentum_system.matrix);
225 
226  auto diff_diagonal = solution.zero_clone();
227 
228  // We assemble the matrix and the right hand side
229  _problem.computeLinearSystemSys(momentum_system, mmat, rhs, /*compute_grads*/ true);
230 
231  // Still need to relax the right hand side with the same vector
232  NS::FV::relaxMatrix(mmat, _momentum_equation_relaxation, *diff_diagonal);
233  NS::FV::relaxRightHandSide(rhs, solution, *diff_diagonal);
234 
235  // The normalization factor depends on the right hand side so we need to recompute it for this
236  // component
237  Real norm_factor = NS::FV::computeNormalizationFactor(solution, mmat, rhs);
238 
239  // Very important, for deciding the convergence, we need the unpreconditioned
240  // norms in the linear solve
241  LibmeshPetscCall(KSPSetNormType(momentum_solver.ksp(), KSP_NORM_UNPRECONDITIONED));
242  // Solve this component. We don't update the ghosted solution yet, that will come at the end
243  // of the corrector step. Also setting the linear tolerances and maximum iteration counts.
245  momentum_solver.set_solver_configuration(_momentum_linear_control);
246 
247  // We solve the equation
248  auto its_resid_pair = momentum_solver.solve(mmat, mmat, solution, rhs);
249  momentum_system.update();
250 
251  // We will reuse the preconditioner for every momentum system
252  if (system_i == 0)
253  momentum_solver.reuse_preconditioner(true);
254 
255  // Save the normalized residual
256  its_normalized_residuals.push_back(
257  std::make_pair(its_resid_pair.first, momentum_solver.get_initial_residual() / norm_factor));
258 
259  if (_print_fields)
260  {
261  _console << " solution after solve " << std::endl;
262  solution.print();
263  _console << " matrix when we solve " << std::endl;
264  mmat.print();
265  _console << " rhs when we solve " << std::endl;
266  rhs.print();
267  _console << " velocity solution component " << system_i << std::endl;
268  solution.print();
269  _console << "Norm factor " << norm_factor << std::endl;
270  _console << Moose::stringify(momentum_solver.get_initial_residual()) << std::endl;
271  }
272 
273  // Printing residuals
274  _console << " Momentum equation:"
275  << (_momentum_systems.size() > 1
276  ? std::string(" Component ") + std::to_string(system_i + 1) + std::string(" ")
277  : std::string(" "))
278  << COLOR_GREEN << its_normalized_residuals[system_i].second << COLOR_DEFAULT
279  << " Linear its: " << its_normalized_residuals[system_i].first << std::endl;
280  }
281 
282  for (const auto system_i : index_range(_momentum_systems))
283  {
284  LinearImplicitSystem & momentum_system =
285  libMesh::cast_ref<LinearImplicitSystem &>(_momentum_systems[system_i]->system());
286  _momentum_systems[system_i]->setSolution(*(momentum_system.current_local_solution));
287  _momentum_systems[system_i]->copyPreviousNonlinearSolutions();
288  }
289 
290  // We reset this to ensure the preconditioner is recomputed new time we go to the momentum
291  // predictor
292  momentum_solver.reuse_preconditioner(false);
293 
294  return its_normalized_residuals;
295 }
296 
297 void
299 {
300  if (_cht.enabled())
301  {
304  }
305 }
306 
307 std::pair<unsigned int, Real>
309 {
311 
312  // We will need some members from the linear system
313  LinearImplicitSystem & pressure_system =
314  libMesh::cast_ref<LinearImplicitSystem &>(_pressure_system.system());
315 
316  // We will need the solution, the right hand side and the matrix
317  NumericVector<Number> & current_local_solution = *(pressure_system.current_local_solution);
318  NumericVector<Number> & solution = *(pressure_system.solution);
319  SparseMatrix<Number> & mmat = *(pressure_system.matrix);
320  NumericVector<Number> & rhs = *(pressure_system.rhs);
321 
322  // Fetch the linear solver from the system
323  PetscLinearSolver<Real> & pressure_solver =
324  libMesh::cast_ref<PetscLinearSolver<Real> &>(*pressure_system.get_linear_solver());
325 
326  _problem.computeLinearSystemSys(pressure_system, mmat, rhs, false);
327 
328  if (_print_fields)
329  {
330  _console << "Pressure matrix" << std::endl;
331  mmat.print();
332  }
333 
334  // We compute the normalization factors based on the fluxes
335  Real norm_factor = NS::FV::computeNormalizationFactor(solution, mmat, rhs);
336 
337  // We need the non-preconditioned norm to be consistent with the norm factor
338  LibmeshPetscCall(KSPSetNormType(pressure_solver.ksp(), KSP_NORM_UNPRECONDITIONED));
339 
340  // Setting the linear tolerances and maximum iteration counts
343 
344  if (_pin_pressure)
346  pressure_system.update();
347 
348  auto its_res_pair = pressure_solver.solve(mmat, mmat, solution, rhs);
349  pressure_system.update();
350 
351  if (_print_fields)
352  {
353  _console << " rhs when we solve pressure " << std::endl;
354  rhs.print();
355  _console << " Pressure " << std::endl;
356  solution.print();
357  _console << "Norm factor " << norm_factor << std::endl;
358  }
359 
360  _pressure_system.setSolution(current_local_solution);
361 
362  const auto residuals =
363  std::make_pair(its_res_pair.first, pressure_solver.get_initial_residual() / norm_factor);
364 
365  _console << " Pressure equation: " << COLOR_GREEN << residuals.second << COLOR_DEFAULT
366  << " Linear its: " << residuals.first << std::endl;
367 
368  return residuals;
369 }
370 
371 std::pair<unsigned int, Real>
373 {
375 
376  // We will need some members from the linear system
377  LinearImplicitSystem & system =
378  libMesh::cast_ref<LinearImplicitSystem &>(_solid_energy_system->system());
379 
380  // We will need the solution, the right hand side and the matrix
381  NumericVector<Number> & current_local_solution = *(system.current_local_solution);
382  NumericVector<Number> & solution = *(system.solution);
383  SparseMatrix<Number> & mmat = *(system.matrix);
384  NumericVector<Number> & rhs = *(system.rhs);
385 
386  // Fetch the linear solver from the system
387  PetscLinearSolver<Real> & solver =
388  libMesh::cast_ref<PetscLinearSolver<Real> &>(*system.get_linear_solver());
389 
390  _problem.computeLinearSystemSys(system, mmat, rhs, false);
391 
392  if (_print_fields)
393  {
394  _console << "Solid energy matrix" << std::endl;
395  mmat.print();
396  }
397 
398  // We compute the normalization factors based on the fluxes
399  Real norm_factor = NS::FV::computeNormalizationFactor(solution, mmat, rhs);
400 
401  // We need the non-preconditioned norm to be consistent with the norm factor
402  LibmeshPetscCall(KSPSetNormType(solver.ksp(), KSP_NORM_UNPRECONDITIONED));
403 
404  // Setting the linear tolerances and maximum iteration counts
407 
408  auto its_res_pair = solver.solve(mmat, mmat, solution, rhs);
409  system.update();
410 
411  if (_print_fields)
412  {
413  _console << " rhs when we solve solid energy " << std::endl;
414  rhs.print();
415  _console << " Solid energy " << std::endl;
416  solution.print();
417  _console << "Norm factor " << norm_factor << std::endl;
418  }
419 
420  _solid_energy_system->setSolution(current_local_solution);
421 
422  const auto residuals =
423  std::make_pair(its_res_pair.first, solver.get_initial_residual() / norm_factor);
424 
425  _console << " Solid energy equation: " << COLOR_GREEN << residuals.second << COLOR_DEFAULT
426  << " Linear its: " << residuals.first << std::endl;
427 
428  return residuals;
429 }
430 
431 std::pair<unsigned int, Real>
432 LinearAssemblySegregatedSolve::correctVelocity(const bool subtract_updated_pressure,
433  const bool recompute_face_mass_flux,
434  const SolverParams & solver_params)
435 {
436  // Compute the coupling fields between the momentum and pressure equations.
437  // The first argument makes sure the pressure gradient is staged at the first
438  // iteration
439  _rc_uo->computeHbyA(subtract_updated_pressure, _print_fields);
440 
441  // We set the preconditioner/controllable parameters for the pressure equations through
442  // petsc options. Linear tolerances will be overridden within the solver.
444 
445  // Solve the pressure corrector
446  const auto residuals = solvePressureCorrector();
447 
448  // Compute the face velocity which is used in the advection terms. In certain
449  // segregated solver algorithms (like PISO) this is only done on the last iteration.
450  if (recompute_face_mass_flux)
452 
453  auto & pressure_current_solution = *(_pressure_system.system().current_local_solution.get());
454  auto & pressure_old_solution = *(_pressure_system.solutionPreviousNewton());
455 
456  // Relax the pressure update for the next momentum predictor
458  pressure_current_solution, pressure_old_solution, _pressure_variable_relaxation);
459 
460  // Overwrite old solution
461  pressure_old_solution = pressure_current_solution;
462  _pressure_system.setSolution(pressure_current_solution);
463 
464  // We recompute the updated pressure gradient
466 
467  // Reconstruct the cell velocity as well to accelerate convergence
469 
470  return residuals;
471 }
472 
473 std::pair<unsigned int, Real>
475  LinearSystem & system,
476  const Real relaxation_factor,
477  SolverConfiguration & solver_config,
478  const Real absolute_tol,
479  const Real field_relaxation,
480  const Real min_value_limiter)
481 {
482  _problem.setCurrentLinearSystem(system_num);
483 
484  // We will need some members from the implicit linear system
485  LinearImplicitSystem & li_system = libMesh::cast_ref<LinearImplicitSystem &>(system.system());
486 
487  // We will need the solution, the right hand side and the matrix
488  NumericVector<Number> & current_local_solution = *(li_system.current_local_solution);
489  NumericVector<Number> & solution = *(li_system.solution);
490  SparseMatrix<Number> & mmat = *(li_system.matrix);
491  NumericVector<Number> & rhs = *(li_system.rhs);
492 
493  // We need a vector that stores the (diagonal_relaxed-original_diagonal) vector
494  auto diff_diagonal = solution.zero_clone();
495 
496  // Fetch the linear solver from the system
497  PetscLinearSolver<Real> & linear_solver =
498  libMesh::cast_ref<PetscLinearSolver<Real> &>(*li_system.get_linear_solver());
499 
500  _problem.computeLinearSystemSys(li_system, mmat, rhs, true);
501 
502  // Go and relax the system matrix and the right hand side
503  NS::FV::relaxMatrix(mmat, relaxation_factor, *diff_diagonal);
504  NS::FV::relaxRightHandSide(rhs, solution, *diff_diagonal);
505 
506  if (_print_fields)
507  {
508  _console << system.name() << " system matrix" << std::endl;
509  mmat.print();
510  }
511 
512  // We compute the normalization factors based on the fluxes
513  Real norm_factor = NS::FV::computeNormalizationFactor(solution, mmat, rhs);
514 
515  // We need the non-preconditioned norm to be consistent with the norm factor
516  LibmeshPetscCall(KSPSetNormType(linear_solver.ksp(), KSP_NORM_UNPRECONDITIONED));
517 
518  // Setting the linear tolerances and maximum iteration counts
519  solver_config.real_valued_data["abs_tol"] = absolute_tol * norm_factor;
520  linear_solver.set_solver_configuration(solver_config);
521 
522  // Solve the system and update current local solution
523  auto its_res_pair = linear_solver.solve(mmat, mmat, solution, rhs);
524  li_system.update();
525 
526  if (_print_fields)
527  {
528  _console << " rhs when we solve " << system.name() << std::endl;
529  rhs.print();
530  _console << system.name() << " solution " << std::endl;
531  solution.print();
532  _console << " Norm factor " << norm_factor << std::endl;
533  }
534 
535  // Limiting scalar solution
536  if (min_value_limiter != std::numeric_limits<Real>::min())
537  NS::FV::limitSolutionUpdate(current_local_solution, min_value_limiter);
538 
539  // Relax the field update for the next momentum predictor
540  if (field_relaxation != 1.0)
541  {
542  auto & old_local_solution = *(system.solutionPreviousNewton());
543  NS::FV::relaxSolutionUpdate(current_local_solution, old_local_solution, field_relaxation);
544 
545  // Update old solution, only needed if relaxing the field
546  old_local_solution = current_local_solution;
547  }
548 
549  system.setSolution(current_local_solution);
550 
551  const auto residuals =
552  std::make_pair(its_res_pair.first, linear_solver.get_initial_residual() / norm_factor);
553 
554  _console << " Advected system: " << system.name() << " " << COLOR_GREEN << residuals.second
555  << COLOR_DEFAULT << " Linear its: " << residuals.first << std::endl;
556 
557  return residuals;
558 }
559 
560 bool
562 {
563  // Do not solve if problem is set not to
564  if (!_problem.shouldSolve())
565  return true;
566 
567  // Dummy solver parameter file which is needed for switching petsc options
568  SolverParams solver_params;
569  solver_params._type = Moose::SolveType::ST_LINEAR;
570  solver_params._line_search = Moose::LineSearchType::LS_NONE;
571 
572  // Initialize the SIMPLE iteration counter
573  unsigned int simple_iteration_counter = 0;
574 
575  // Assign residuals to general residual vector
576  const unsigned int no_systems = _momentum_systems.size() + 1 + _has_energy_system +
578  _turbulence_systems.size();
579 
580  std::vector<std::pair<unsigned int, Real>> ns_residuals(no_systems, std::make_pair(0, 1.0));
581  std::vector<Real> ns_abs_tols(_momentum_systems.size(), _momentum_absolute_tolerance);
582  ns_abs_tols.push_back(_pressure_absolute_tolerance);
583 
584  // Push back energy tolerances
585  if (_has_energy_system)
586  ns_abs_tols.push_back(_energy_absolute_tolerance);
588  ns_abs_tols.push_back(_solid_energy_absolute_tolerance);
590  for (const auto scalar_tol : _active_scalar_absolute_tolerance)
591  ns_abs_tols.push_back(scalar_tol);
592 
593  // Push back turbulence tolerances
595  for (const auto turbulence_tol : _turbulence_absolute_tolerance)
596  ns_abs_tols.push_back(turbulence_tol);
597 
598  bool converged = false;
599  // Loop until converged or hit the maximum allowed iteration number
600  if (_cht.enabled())
602 
603  while (simple_iteration_counter < _num_iterations && !converged)
604  {
605  simple_iteration_counter++;
606 
607  // We set the preconditioner/controllable parameters through petsc options. Linear
608  // tolerances will be overridden within the solver. In case of a segregated momentum
609  // solver, we assume that every velocity component uses the same preconditioner
611 
612  // Initialize pressure gradients, after this we just reuse the last ones from each
613  // iteration
614  if (simple_iteration_counter == 1)
616 
617  _console << "Iteration " << simple_iteration_counter << " Initial residual norms:" << std::endl;
618 
619  // Solve the momentum predictor step
620  auto momentum_residual = solveMomentumPredictor();
621  for (const auto system_i : index_range(momentum_residual))
622  ns_residuals[system_i] = momentum_residual[system_i];
623 
624  // Now we correct the velocity, this function depends on the method, it differs for
625  // SIMPLE/PIMPLE, this returns the pressure errors
626  ns_residuals[momentum_residual.size()] = correctVelocity(true, true, solver_params);
627 
628  // If we have an energy equation, solve it here.We assume the material properties in the
629  // Navier-Stokes equations depend on temperature, therefore we can not solve for temperature
630  // outside of the velocity-pressure loop
631  if (_has_energy_system)
632  {
633  // If there is no CHT specified this will just do go once through this block
635  while (!_cht.converged())
636  {
637  if (_cht.enabled())
639 
640  // We set the preconditioner/controllable parameters through petsc options. Linear
641  // tolerances will be overridden within the solver.
643  ns_residuals[momentum_residual.size() + _has_energy_system] =
649 
651  {
652  // For now we only update gradients if cht is needed, might change in the future
653  if (_cht.enabled())
654  {
657  }
658 
659  // We set the preconditioner/controllable parameters through petsc options. Linear
660  // tolerances will be overridden within the solver.
662  ns_residuals[momentum_residual.size() + _has_solid_energy_system + _has_energy_system] =
664 
665  // For now we only update gradients if cht is needed, might change in the future
666  if (_cht.enabled())
668  }
669 
670  if (_cht.enabled())
671  {
674  }
675 
677  }
678  if (_cht.enabled())
680  }
681 
682  // If we have active scalar equations, solve them here in case they depend on temperature
683  // or they affect the fluid properties such that they must be solved concurrently with
684  // pressure and velocity
686  {
688 
689  // We set the preconditioner/controllable parameters through petsc options. Linear
690  // tolerances will be overridden within the solver.
692  for (const auto i : index_range(_active_scalar_system_names))
693  ns_residuals[momentum_residual.size() + 1 + _has_energy_system + _has_solid_energy_system +
699  }
700 
701  // If we have turbulence equations, solve them here.
702  // The turbulent viscosity depends on the value of the turbulence surrogate variables
704  {
705  // We set the preconditioner/controllable parameters through petsc options. Linear
706  // tolerances will be overridden within the solver.
708  for (const auto i : index_range(_turbulence_system_names))
709  {
710  ns_residuals[momentum_residual.size() + 1 + _has_energy_system + _has_solid_energy_system +
711  _active_scalar_system_names.size() + i] =
719  }
720  }
721 
723 
724  converged = NS::FV::converged(ns_residuals, ns_abs_tols);
725  }
726 
727  // If we have passive scalar equations, solve them here. We assume the material properties in
728  // the Navier-Stokes equations do not depend on passive scalars, as they are passive, therefore
729  // we solve outside of the velocity-pressure loop
731  {
732  // The reason why we need more than one iteration is due to the matrix relaxation
733  // which can be used to stabilize the equations
734  bool passive_scalar_converged = false;
735  unsigned int ps_iteration_counter = 0;
736 
737  _console << "Passive scalar iteration " << ps_iteration_counter
738  << " Initial residual norms:" << std::endl;
739 
740  while (ps_iteration_counter < _num_iterations && !passive_scalar_converged)
741  {
742  ps_iteration_counter++;
743  std::vector<std::pair<unsigned int, Real>> scalar_residuals(
744  _passive_scalar_system_names.size(), std::make_pair(0, 1.0));
745  std::vector<Real> scalar_abs_tols;
746  for (const auto scalar_tol : _passive_scalar_absolute_tolerance)
747  scalar_abs_tols.push_back(scalar_tol);
748 
749  // We set the preconditioner/controllable parameters through petsc options. Linear
750  // tolerances will be overridden within the solver.
752  for (const auto i : index_range(_passive_scalar_system_names))
753  scalar_residuals[i] = solveAdvectedSystem(_passive_scalar_system_numbers[i],
758 
759  passive_scalar_converged = NS::FV::converged(scalar_residuals, scalar_abs_tols);
760  }
761 
762  // Both flow and scalars must converge
763  converged = passive_scalar_converged && converged;
764  }
765 
767 
768  return converged;
769 }
MultiMooseEnum getCommonPetscKeys()
void relaxMatrix(SparseMatrix< Number > &matrix_in, const Real relaxation_parameter, NumericVector< Number > &diff_diagonal)
Relax the matrix to ensure diagonal dominance, we hold onto the difference in diagonals for later use...
bool shouldSolve() const
const std::vector< Real > _active_scalar_equation_relaxation
The user-defined relaxation parameter(s) for the active scalar equation(s)
FEProblemBase & _problem
SIMPLESolverConfiguration _momentum_linear_control
Options for the linear solver of the momentum equation.
void addPetscFlagsToPetscOptions(const MultiMooseEnum &petsc_flags, std::string prefix, const ParallelParamObject &param_object, PetscOptions &petsc_options)
SIMPLESolverConfiguration _turbulence_linear_control
Options for the linear solver of the turbulence equation(s)
const Real _energy_absolute_tolerance
The user-defined absolute tolerance for determining the convergence in energy.
void updateCHTBoundaryCouplingFields(const NS::CHTSide side)
Update the coupling fields for.
Definition: CHTHandler.C:327
const unsigned int _num_iterations
The maximum number of momentum-pressure iterations.
User object responsible for determining the face fluxes using the Rhie-Chow interpolation in a segreg...
SIMPLESolverConfiguration _energy_linear_control
Options for the linear solver of the energy equation.
const unsigned int invalid_uint
void computeGradients()
void paramError(const std::string &param, Args... args) const
const bool _print_fields
Debug parameter which allows printing the coupling and solution vectors/matrices. ...
Moose::PetscSupport::PetscOptions _turbulence_petsc_options
Options which hold the petsc settings for the turbulence equation(s)
void addParam(const std::string &name, const std::initializer_list< typename T::value_type > &value, const std::string &doc_string)
const Real _solid_energy_l_abs_tol
Absolute linear tolerance for the energy equations.
const bool _has_energy_system
Boolean for easy check if a fluid energy system shall be solved or not.
Moose::LineSearchType _line_search
Real computeNormalizationFactor(const NumericVector< Number > &solution, const SparseMatrix< Number > &mat, const NumericVector< Number > &rhs)
Compute a normalization factor which is applied to the linear residual to determine convergence...
void addPetscPairsToPetscOptions(const std::vector< std::pair< MooseEnumItem, std::string >> &petsc_pair_options, const unsigned int mesh_dimension, std::string prefix, const ParallelParamObject &param_object, PetscOptions &petsc_options)
SIMPLESolverConfiguration _active_scalar_linear_control
Options for the linear solver of the active scalar equation(s)
std::vector< Real > _turbulence_field_relaxation
The user-defined relaxation parameter(s) for the turbulence field(s)
const Real _passive_scalar_l_abs_tol
Absolute linear tolerance for the passive scalar equation(s).
std::pair< unsigned int, Real > solveSolidEnergy()
Solve an equation which contains the solid energy conservation.
std::vector< LinearSystem * > _passive_scalar_systems
Pointer(s) to the system(s) corresponding to the passive scalar equation(s)
void resetIntegratedFluxes()
Reset the heat fluxes to 0.
Definition: CHTHandler.C:408
Moose::PetscSupport::PetscOptions _solid_energy_petsc_options
Options which hold the petsc settings for the fluid energy equation.
const Real _momentum_equation_relaxation
The user-defined relaxation parameter for the momentum equation.
virtual std::unique_ptr< NumericVector< T > > zero_clone() const=0
const bool _has_turbulence_systems
Boolean for easy check if a turbulence scalar systems shall be solved or not.
void computeFaceMassFlux()
Update the values of the face velocities in the containers.
std::vector< unsigned int > _turbulence_system_numbers
static InputParameters validParams()
void printIntegratedFluxes() const
Print the integrated heat fluxes.
Definition: CHTHandler.C:396
Definition: NS.h:197
LinearSystem * _solid_energy_system
Pointer to the linear system corresponding to the solid energy equation.
std::pair< unsigned int, Real > solveAdvectedSystem(const unsigned int system_num, LinearSystem &system, const Real relaxation_factor, libMesh::SolverConfiguration &solver_config, const Real abs_tol, const Real field_relaxation=1.0, const Real min_value_limiter=std::numeric_limits< Real >::min())
Solve an equation which contains an advection term that depends on the solution of the segregated Nav...
NumericVector< Number > * rhs
const Real _momentum_l_abs_tol
Absolute linear tolerance for the momentum equation(s).
void setSolution(const NumericVector< Number > &soln)
const bool _has_active_scalar_systems
Boolean for easy check if a active scalar systems shall be solved or not.
virtual std::pair< unsigned int, Real > solve(SparseMatrix< T > &matrix_in, NumericVector< T > &solution_in, NumericVector< T > &rhs_in, const std::optional< double > tol=std::nullopt, const std::optional< unsigned int > m_its=std::nullopt) override
const Real _active_scalar_l_abs_tol
Absolute linear tolerance for the active scalar equation(s).
virtual LinearSolver< Number > * get_linear_solver() const override
void initializeCHTCouplingFields()
Initialize the coupling fields for the conjugate heat transfer routines.
Definition: CHTHandler.C:306
RhieChowMassFlux * _rc_uo
Pointer to the segregated RhieChow interpolation object.
The following methods are specializations for using the Parallel::packed_range_* routines for a vecto...
void relaxRightHandSide(NumericVector< Number > &rhs_in, const NumericVector< Number > &solution_in, const NumericVector< Number > &diff_diagonal)
Relax the right hand side of an equation, this needs to be called once and the system matrix has been...
std::map< std::string, Real > real_valued_data
void setupConjugateHeatTransferContainers()
Set up the boundary condition pairs, functor maps, and every other necessary structure for the conjug...
Definition: CHTHandler.C:226
virtual std::pair< unsigned int, Real > correctVelocity(const bool subtract_updated_pressure, const bool recompute_face_mass_flux, const SolverParams &solver_params)
Computes new velocity field based on computed pressure gradients.
void resetCHTConvergence()
Reset the convergence data.
Definition: CHTHandler.h:144
bool converged(const std::vector< std::pair< unsigned int, Real >> &residuals, const std::vector< Real > &abs_tolerances)
Based on the residuals, determine if the iterative process converged or not.
const Real _pressure_absolute_tolerance
The user-defined absolute tolerance for determining the convergence in pressure.
const Real _pressure_variable_relaxation
The user-defined relaxation parameter for the pressure variable.
virtual void computeLinearSystemSys(libMesh::LinearImplicitSystem &sys, libMesh::SparseMatrix< libMesh::Number > &system_matrix, NumericVector< libMesh::Number > &rhs, const bool compute_gradients=true)
const Real _momentum_absolute_tolerance
The user-defined absolute tolerance for determining the convergence in momentum.
virtual const std::string & name() const
const std::vector< SolverSystemName > & _passive_scalar_system_names
The names of the passive scalar systems.
const unsigned int _solid_energy_sys_number
The number of the system corresponding to the solid energy equation.
std::vector< LinearSystem * > _active_scalar_systems
Pointer(s) to the system(s) corresponding to the active scalar equation(s)
SIMPLESolverConfiguration _passive_scalar_linear_control
Options for the linear solver of the passive scalar equation(s)
void computeHbyA(const bool with_updated_pressure, const bool verbose)
Computes the inverse of the diagonal (1/A) of the system matrix plus the H/A components for the press...
virtual void execute(const ExecFlagType &exec_type)
Moose::PetscSupport::PetscOptions _energy_petsc_options
Options which hold the petsc settings for the fluid energy equation.
LinearSystem & _pressure_system
Reference to the linear system corresponding to the pressure equation.
std::vector< unsigned int > _momentum_system_numbers
The number(s) of the system(s) corresponding to the momentum equation(s)
SIMPLESolverConfiguration _pressure_linear_control
Options for the linear solver of the pressure equation.
MultiMooseEnum getCommonPetscFlags()
LinearSystem * _energy_system
Pointer to the linear system corresponding to the fluid energy equation.
const unsigned int _energy_sys_number
The number of the system corresponding to the energy equation.
void incrementCHTIterators()
Increment CHT iterators in the loop.
Definition: CHTHandler.h:150
void linkEnergySystems(SystemBase *solid_energy_system, SystemBase *fluid_energy_system)
Link energy systems.
Definition: CHTHandler.C:91
Moose::PetscSupport::PetscOptions _passive_scalar_petsc_options
Options which hold the petsc settings for the passive scalar equation(s)
virtual unsigned int dimension() const
std::map< std::string, int > int_valued_data
bool converged() const
Check if CHT iteration converged.
Definition: CHTHandler.C:415
virtual std::unique_ptr< SparseMatrix< T > > zero_clone() const=0
void linkMomentumPressureSystems(const std::vector< LinearSystem *> &momentum_systems, const LinearSystem &pressure_system, const std::vector< unsigned int > &momentum_system_numbers)
Update the momentum system-related information.
Moose::PetscSupport::PetscOptions _momentum_petsc_options
Options which hold the petsc settings for the momentum equation.
const Real _pressure_l_abs_tol
Absolute linear tolerance for the pressure equation.
const std::vector< Real > _passive_scalar_absolute_tolerance
The user-defined absolute tolerance for determining the convergence in passive scalars.
std::unique_ptr< NumericVector< Number > > solution
dof_id_type _pressure_pin_dof
The dof ID where the pressure needs to be pinned.
void computeCellVelocity()
Update the cell values of the velocity variables.
Moose::SolveType _type
const std::vector< SolverSystemName > & _turbulence_system_names
The names of the turbulence systems.
virtual bool solve() override
Performs the momentum pressure coupling.
virtual void print(std::ostream &os=libMesh::out) const
const bool _pin_pressure
If the pressure needs to be pinned.
const Real _energy_l_abs_tol
Absolute linear tolerance for the energy equations.
std::string stringify(const T &t)
void petscSetOptions(const PetscOptions &po, const SolverParams &solver_params, FEProblemBase *const problem=nullptr)
void sumIntegratedFluxes()
Sum the integrated fluxes over all processors.
Definition: CHTHandler.C:385
virtual void linkRhieChowUserObject() override
Fetch the Rhie Chow user object that is reponsible for determining face velocities and mass flux...
LinearSystem & getLinearSystem(unsigned int sys_num)
void set_solver_configuration(SolverConfiguration &solver_configuration)
const std::vector< Real > _turbulence_equation_relaxation
The user-defined relaxation parameter(s) for the turbulence equation(s)
const std::vector< SolverSystemName > & _momentum_system_names
The names of the momentum systems.
std::vector< LinearSystem * > _turbulence_systems
Pointer(s) to the system(s) corresponding to the turbulence equation(s)
const ExecFlagType EXEC_NONLINEAR
const std::vector< Real > _passive_scalar_equation_relaxation
The user-defined relaxation parameter(s) for the passive scalar equation(s)
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
const std::vector< SolverSystemName > & _active_scalar_system_names
The names of the active scalar systems.
MooseApp & _app
const Real _energy_equation_relaxation
The user-defined relaxation parameter for the energy equation.
SparseMatrix< Number > * matrix
void setCurrentLinearSystem(unsigned int sys_num)
std::vector< LinearSystem * > _systems_to_solve
Shortcut to every linear system that we solve for here.
const Real _pressure_pin_value
The value we want to enforce for pressure.
virtual std::vector< std::pair< unsigned int, Real > > solveMomentumPredictor() override
Solve a momentum predictor step with a fixed pressure field.
const Real _turbulence_l_abs_tol
Absolute linear tolerance for the turbulence equation(s).
virtual MooseMesh & mesh() override
unsigned int linearSysNum(const LinearSystemName &linear_sys_name) const override
void deduceCHTBoundaryCoupling()
Run error checks and make sure everything works.
Definition: CHTHandler.C:103
virtual std::pair< unsigned int, Real > solvePressureCorrector() override
Solve a pressure corrector step.
Moose::PetscSupport::PetscOptions _active_scalar_petsc_options
Options which hold the petsc settings for the active scalar equation(s)
std::unique_ptr< NumericVector< Number > > current_local_solution
virtual const NumericVector< Number > * solutionPreviousNewton() const
Solve class serving as a base class for the two SIMPLE solvers that operate with different assembly a...
const bool _has_passive_scalar_systems
Boolean for easy check if a passive scalar systems shall be solved or not.
const std::vector< Real > _active_scalar_absolute_tolerance
The user-defined absolute tolerance for determining the convergence in active scalars.
virtual bool enabled() const override final
Check if CHT treatment is needed.
Definition: CHTHandler.h:138
void addRangeCheckedParam(const std::string &name, const T &value, const std::string &parsed_function, const std::string &doc_string)
const ConsoleStream _console
static InputParameters validParams()
Definition: CHTHandler.C:25
const Real _solid_energy_absolute_tolerance
The user-defined absolute tolerance for determining the convergence in solid energy.
std::vector< unsigned int > _active_scalar_system_numbers
SIMPLESolverConfiguration _solid_energy_linear_control
Options for the linear solver of the energy equation.
std::vector< LinearSystem * > _momentum_systems
Pointer(s) to the system(s) corresponding to the momentum equation(s)
const bool _continue_on_max_its
If solve should continue if maximum number of iterations is hit.
std::vector< Real > _turbulence_field_min_limit
The user-defined lower limit for turbulent quantities e.g. k, eps/omega, etc..
void constrainSystem(SparseMatrix< Number > &mx, NumericVector< Number > &rhs, const Real desired_value, const dof_id_type dof_id)
Implicitly constrain the system by adding a factor*(u-u_desired) to it at a desired dof value...
void limitSolutionUpdate(NumericVector< Number > &solution, const Real min_limit=std::numeric_limits< Real >::epsilon(), const Real max_limit=1e10)
Limit a solution to its minimum and maximum bounds: $u = min(max(u, min_limit), max_limit)$.
bool isRecovering() const
void relaxSolutionUpdate(NumericVector< Number > &vec_new, const NumericVector< Number > &vec_old, const Real relaxation_factor)
Relax the update on a solution field using the following approach: $u = u_{old}+ (u - u_{old})$...
const std::vector< Real > _turbulence_absolute_tolerance
The user-defined absolute tolerance for determining the convergence turbulence variables.
auto index_range(const T &sizable)
void print(std::ostream &os=libMesh::out, const bool sparse=false) const
std::vector< unsigned int > _passive_scalar_system_numbers
NS::FV::CHTHandler _cht
********************** Conjugate heat transfer variables ************** //
void initCouplingField()
Initialize the coupling fields (HbyA and Ainv)
Moose::PetscSupport::PetscOptions _pressure_petsc_options
Options which hold the petsc settings for the pressure equation.
virtual System & system() override
Definition: NS.h:196
const bool _has_solid_energy_system
Boolean for easy check if a solid energy system shall be solved or not.
void initFaceMassFlux()
Initialize the container for face velocities.
void addParamNamesToGroup(const std::string &space_delim_names, const std::string group_name)
const unsigned int _pressure_sys_number
The number of the system corresponding to the pressure equation.