From c339d3018c98cb67c3455ab09db316c7c0618d5c Mon Sep 17 00:00:00 2001 From: Henry Weller Date: Mon, 5 Sep 2016 11:46:42 +0100 Subject: [PATCH] PBiCGStab: New preconditioned bi-conjugate gradient stabilized solver for asymmetric lduMatrices using a run-time selectable preconditioner References: Van der Vorst, H. A. (1992). Bi-CGSTAB: A fast and smoothly converging variant of Bi-CG for the solution of nonsymmetric linear systems. SIAM Journal on scientific and Statistical Computing, 13(2), 631-644. Barrett, R., Berry, M. W., Chan, T. F., Demmel, J., Donato, J., Dongarra, J., Eijkhout, V., Pozo, R., Romine, C. & Van der Vorst, H. (1994). Templates for the solution of linear systems: building blocks for iterative methods (Vol. 43). Siam. See also: https://en.wikipedia.org/wiki/Biconjugate_gradient_stabilized_method Tests have shown that PBiCGStab with the DILU preconditioner is more robust, reliable and shows faster convergence (~2x) than PBiCG with DILU, in particular in parallel where PBiCG occasionally diverges. This remarkable improvement over PBiCG prompted the update of all tutorial cases currently using PBiCG to use PBiCGStab instead. If any issues arise with this update please report on Mantis: http://bugs.openfoam.org --- src/OpenFOAM/Make/files | 1 + .../matrices/lduMatrix/solvers/PBiCG/PBiCG.C | 44 +-- .../lduMatrix/solvers/PBiCGStab/PBiCGStab.C | 252 ++++++++++++++++++ .../lduMatrix/solvers/PBiCGStab/PBiCGStab.H | 123 +++++++++ .../pitzDaily/system/fvSolution | 2 +- .../system/fvSolution | 4 +- .../moriyoshiHomogeneous/system/fvSolution | 4 +- .../combustion/chemFoam/gri/system/fvSolution | 2 +- .../combustion/chemFoam/h2/system/fvSolution | 2 +- .../chemFoam/ic8h18/system/fvSolution | 2 +- .../chemFoam/ic8h18_TDAC/system/fvSolution | 2 +- .../chemFoam/nc7h16/system/fvSolution | 2 +- .../engineFoam/kivaTest/system/fvSolution | 2 +- .../system/filmRegion/fvSolution | 6 +- .../system/fvSolution | 2 +- .../system/pyrolysisRegion/fvSolution | 2 +- .../oppositeBurningPanels/system/fvSolution | 2 +- .../system/panelRegion/fvSolution | 2 +- .../les/smallPoolFire2D/system/fvSolution | 2 +- .../les/smallPoolFire3D/system/fvSolution | 2 +- .../counterFlowFlame2D/system/fvSolution | 2 +- .../counterFlowFlame2DLTS/system/fvSolution | 2 +- .../counterFlowFlame2D_GRI/system/fvSolution | 2 +- .../system/fvSolution | 2 +- .../movingCone/system/fvSolution | 2 +- .../sonicDyMFoam/movingCone/system/fvSolution | 2 +- .../ras/nacaAirfoil/system/fvSolution | 2 +- .../europeanCall/system/fvSolution | 2 +- .../hotRoom/system/fvSolution | 2 +- .../hotRoom/system/fvSolution | 2 +- .../iglooWithFridges/system/fvSolution | 2 +- .../hotRoom/system/fvSolution | 2 +- .../buoyantCavity/system/fvSolution | 2 +- .../circuitBoardCooling/system/fvSolution | 2 +- .../externalCoupledCavity/system/fvSolution | 2 +- .../hotRadiationRoom/system/fvSolution | 2 +- .../hotRadiationRoomFvDOM/system/fvSolution | 2 +- .../system/bottomWater/fvSolution | 2 +- .../system/topAir/fvSolution | 2 +- .../system/bottomAir/fvSolution | 2 +- .../system/topAir/fvSolution | 2 +- .../heatExchanger/system/air/fvSolution | 2 +- .../heatExchanger/system/porous/fvSolution | 2 +- .../system/bottomAir/fvSolution | 2 +- .../system/topAir/fvSolution | 2 +- .../simpleFoam/motorBike/system/fvSolution | 38 +-- .../cylinder/system/fvSolution | 4 +- .../hotBoxes/system/fvSolution | 2 +- .../splashPanel/system/fvSolution | 4 +- .../system/wallFilmRegion/fvSolution | 4 +- .../filter/system/fvSolution | 2 +- .../parcelInBox/system/fvSolution | 2 +- .../verticalChannel/system/fvSolution | 2 +- .../sprayFoam/aachenBomb/system/fvSolution | 2 +- .../SnakeRiverCanyon/system/fvSolution | 2 +- .../driftFluxFoam/ras/dahl/system/fvSolution | 3 +- .../ras/mixerVessel2D/system/fvSolution | 4 +- .../ras/tank3D/system/fvSolution | 4 +- 58 files changed, 481 insertions(+), 102 deletions(-) create mode 100644 src/OpenFOAM/matrices/lduMatrix/solvers/PBiCGStab/PBiCGStab.C create mode 100644 src/OpenFOAM/matrices/lduMatrix/solvers/PBiCGStab/PBiCGStab.H diff --git a/src/OpenFOAM/Make/files b/src/OpenFOAM/Make/files index e530cb2a0..bcd75424a 100644 --- a/src/OpenFOAM/Make/files +++ b/src/OpenFOAM/Make/files @@ -271,6 +271,7 @@ $(lduMatrix)/solvers/diagonalSolver/diagonalSolver.C $(lduMatrix)/solvers/smoothSolver/smoothSolver.C $(lduMatrix)/solvers/PCG/PCG.C $(lduMatrix)/solvers/PBiCG/PBiCG.C +$(lduMatrix)/solvers/PBiCGStab/PBiCGStab.C $(lduMatrix)/smoothers/GaussSeidel/GaussSeidelSmoother.C $(lduMatrix)/smoothers/symGaussSeidel/symGaussSeidelSmoother.C diff --git a/src/OpenFOAM/matrices/lduMatrix/solvers/PBiCG/PBiCG.C b/src/OpenFOAM/matrices/lduMatrix/solvers/PBiCG/PBiCG.C index 3d43c64a0..092877e7a 100644 --- a/src/OpenFOAM/matrices/lduMatrix/solvers/PBiCG/PBiCG.C +++ b/src/OpenFOAM/matrices/lduMatrix/solvers/PBiCG/PBiCG.C @@ -76,37 +76,25 @@ Foam::solverPerformance Foam::PBiCG::solve fieldName_ ); - label nCells = psi.size(); + const label nCells = psi.size(); scalar* __restrict__ psiPtr = psi.begin(); scalarField pA(nCells); scalar* __restrict__ pAPtr = pA.begin(); - scalarField pT(nCells, 0.0); - scalar* __restrict__ pTPtr = pT.begin(); - scalarField wA(nCells); scalar* __restrict__ wAPtr = wA.begin(); - scalarField wT(nCells); - scalar* __restrict__ wTPtr = wT.begin(); - - scalar wArT = solverPerf.great_; - scalar wArTold = wArT; - - // --- Calculate A.psi and T.psi + // --- Calculate A.psi matrix_.Amul(wA, psi, interfaceBouCoeffs_, interfaces_, cmpt); - matrix_.Tmul(wT, psi, interfaceIntCoeffs_, interfaces_, cmpt); - // --- Calculate initial residual and transpose residual fields + // --- Calculate initial residual field scalarField rA(source - wA); - scalarField rT(source - wT); scalar* __restrict__ rAPtr = rA.begin(); - scalar* __restrict__ rTPtr = rT.begin(); // --- Calculate normalisation factor - scalar normFactor = this->normFactor(psi, source, wA, pA); + const scalar normFactor = this->normFactor(psi, source, wA, pA); if (lduMatrix::debug >= 2) { @@ -126,6 +114,22 @@ Foam::solverPerformance Foam::PBiCG::solve || !solverPerf.checkConvergence(tolerance_, relTol_) ) { + scalarField pT(nCells, 0); + scalar* __restrict__ pTPtr = pT.begin(); + + scalarField wT(nCells); + scalar* __restrict__ wTPtr = wT.begin(); + + // --- Calculate T.psi + matrix_.Tmul(wT, psi, interfaceIntCoeffs_, interfaces_, cmpt); + + // --- Calculate initial transpose residual field + scalarField rT(source - wT); + scalar* __restrict__ rTPtr = rT.begin(); + + // --- Initial value not used + scalar wArT = 0; + // --- Select and construct the preconditioner autoPtr preconPtr = lduMatrix::preconditioner::New @@ -138,7 +142,7 @@ Foam::solverPerformance Foam::PBiCG::solve do { // --- Store previous wArT - wArTold = wArT; + const scalar wArTold = wArT; // --- Precondition residuals preconPtr->precondition(wA, rA, cmpt); @@ -157,7 +161,7 @@ Foam::solverPerformance Foam::PBiCG::solve } else { - scalar beta = wArT/wArTold; + const scalar beta = wArT/wArTold; for (label cell=0; cell. + +\*---------------------------------------------------------------------------*/ + +#include "PBiCGStab.H" + +// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // + +namespace Foam +{ + defineTypeNameAndDebug(PBiCGStab, 0); + + lduMatrix::solver::addasymMatrixConstructorToTable + addPBiCGStabAsymMatrixConstructorToTable_; +} + + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +Foam::PBiCGStab::PBiCGStab +( + const word& fieldName, + const lduMatrix& matrix, + const FieldField& interfaceBouCoeffs, + const FieldField& interfaceIntCoeffs, + const lduInterfaceFieldPtrsList& interfaces, + const dictionary& solverControls +) +: + lduMatrix::solver + ( + fieldName, + matrix, + interfaceBouCoeffs, + interfaceIntCoeffs, + interfaces, + solverControls + ) +{} + + +// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // + +Foam::solverPerformance Foam::PBiCGStab::solve +( + scalarField& psi, + const scalarField& source, + const direction cmpt +) const +{ + // --- Setup class containing solver performance data + solverPerformance solverPerf + ( + lduMatrix::preconditioner::getName(controlDict_) + typeName, + fieldName_ + ); + + const label nCells = psi.size(); + + scalar* __restrict__ psiPtr = psi.begin(); + + scalarField pA(nCells); + scalar* __restrict__ pAPtr = pA.begin(); + + scalarField yA(nCells); + scalar* __restrict__ yAPtr = yA.begin(); + + // --- Calculate A.psi + matrix_.Amul(yA, psi, interfaceBouCoeffs_, interfaces_, cmpt); + + // --- Calculate initial residual field + scalarField rA(source - yA); + scalar* __restrict__ rAPtr = rA.begin(); + + // --- Calculate normalisation factor + const scalar normFactor = this->normFactor(psi, source, yA, pA); + + if (lduMatrix::debug >= 2) + { + Info<< " Normalisation factor = " << normFactor << endl; + } + + // --- Calculate normalised residual norm + solverPerf.initialResidual() = + gSumMag(rA, matrix().mesh().comm()) + /normFactor; + solverPerf.finalResidual() = solverPerf.initialResidual(); + + // --- Check convergence, solve if not converged + if + ( + minIter_ > 0 + || !solverPerf.checkConvergence(tolerance_, relTol_) + ) + { + scalarField AyA(nCells); + scalar* __restrict__ AyAPtr = AyA.begin(); + + scalarField sA(nCells); + scalar* __restrict__ sAPtr = sA.begin(); + + scalarField zA(nCells); + scalar* __restrict__ zAPtr = zA.begin(); + + scalarField tA(nCells); + scalar* __restrict__ tAPtr = tA.begin(); + + // --- Store initial residual + const scalarField rA0(rA); + + // --- Initial values not used + scalar rA0rA = 0; + scalar alpha = 0; + scalar omega = 0; + + // --- Select and construct the preconditioner + autoPtr preconPtr = + lduMatrix::preconditioner::New + ( + *this, + controlDict_ + ); + + // --- Solver iteration + do + { + // --- Store previous rA0rA + const scalar rA0rAold = rA0rA; + + rA0rA = gSumProd(rA0, rA, matrix().mesh().comm()); + + // --- Test for singularity + if (solverPerf.checkSingularity(mag(rA0rA))) + { + break; + } + + // --- Update pA + if (solverPerf.nIterations() == 0) + { + for (label cell=0; cellprecondition(yA, pA, cmpt); + + // --- Calculate AyA + matrix_.Amul(AyA, yA, interfaceBouCoeffs_, interfaces_, cmpt); + + const scalar rA0AyA = gSumProd(rA0, AyA, matrix().mesh().comm()); + + alpha = rA0rA/rA0AyA; + + // --- Calculate sA + for (label cell=0; cellprecondition(zA, sA, cmpt); + + // --- Calculate tA + matrix_.Amul(tA, zA, interfaceBouCoeffs_, interfaces_, cmpt); + + const scalar tAtA = gSumSqr(tA, matrix().mesh().comm()); + + // --- Calculate omega from tA and sA + // (cheaper than using zA with preconditioned tA) + omega = gSumProd(tA, sA)/tAtA; + + // --- Update solution and residual + for (label cell=0; cell. + +Class + Foam::PBiCGStab + +Description + Preconditioned bi-conjugate gradient stabilized solver for asymmetric + lduMatrices using a run-time selectable preconditiioner. + + References: + \verbatim + Van der Vorst, H. A. (1992). + Bi-CGSTAB: A fast and smoothly converging variant of Bi-CG + for the solution of nonsymmetric linear systems. + SIAM Journal on scientific and Statistical Computing, 13(2), 631-644. + + Barrett, R., Berry, M. W., Chan, T. F., Demmel, J., Donato, J., + Dongarra, J., Eijkhout, V., Pozo, R., Romine, C. & Van der Vorst, H. + (1994). + Templates for the solution of linear systems: + building blocks for iterative methods + (Vol. 43). Siam. + \endverbatim + +SourceFiles + PBiCGStab.C + +\*---------------------------------------------------------------------------*/ + +#ifndef PBiCGStab_H +#define PBiCGStab_H + +#include "lduMatrix.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + +/*---------------------------------------------------------------------------*\ + Class PBiCGStab Declaration +\*---------------------------------------------------------------------------*/ + +class PBiCGStab +: + public lduMatrix::solver +{ + // Private Member Functions + + //- Disallow default bitwise copy construct + PBiCGStab(const PBiCGStab&); + + //- Disallow default bitwise assignment + void operator=(const PBiCGStab&); + + +public: + + //- Runtime type information + TypeName("PBiCGStab"); + + + // Constructors + + //- Construct from matrix components and solver data stream + PBiCGStab + ( + const word& fieldName, + const lduMatrix& matrix, + const FieldField& interfaceBouCoeffs, + const FieldField& interfaceIntCoeffs, + const lduInterfaceFieldPtrsList& interfaces, + const dictionary& solverControls + ); + + + //- Destructor + virtual ~PBiCGStab() + {} + + + // Member Functions + + //- Solve the matrix with this solver + virtual solverPerformance solve + ( + scalarField& psi, + const scalarField& source, + const direction cmpt=0 + ) const; +}; + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#endif + +// ************************************************************************* // diff --git a/tutorials/basic/scalarTransportFoam/pitzDaily/system/fvSolution b/tutorials/basic/scalarTransportFoam/pitzDaily/system/fvSolution index 245dcb70f..07d697430 100644 --- a/tutorials/basic/scalarTransportFoam/pitzDaily/system/fvSolution +++ b/tutorials/basic/scalarTransportFoam/pitzDaily/system/fvSolution @@ -19,7 +19,7 @@ solvers { T { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-06; relTol 0; diff --git a/tutorials/combustion/PDRFoam/flamePropagationWithObstacles/system/fvSolution b/tutorials/combustion/PDRFoam/flamePropagationWithObstacles/system/fvSolution index b76b24182..a7a0765cd 100644 --- a/tutorials/combustion/PDRFoam/flamePropagationWithObstacles/system/fvSolution +++ b/tutorials/combustion/PDRFoam/flamePropagationWithObstacles/system/fvSolution @@ -49,7 +49,7 @@ solvers "(b|Xi|ft|ha|hau|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-06; relTol 0.1; @@ -57,7 +57,7 @@ solvers "(b|Xi|ft|ha|hau|k|epsilon)Final" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-06; relTol 0; diff --git a/tutorials/combustion/XiFoam/ras/moriyoshiHomogeneous/system/fvSolution b/tutorials/combustion/XiFoam/ras/moriyoshiHomogeneous/system/fvSolution index 706044c8b..800bf49f3 100644 --- a/tutorials/combustion/XiFoam/ras/moriyoshiHomogeneous/system/fvSolution +++ b/tutorials/combustion/XiFoam/ras/moriyoshiHomogeneous/system/fvSolution @@ -34,7 +34,7 @@ solvers "(U|b|Su|Xi|ha|hau|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-05; relTol 0.1; @@ -42,7 +42,7 @@ solvers "(U|b|Su|Xi|ha|hau|k|epsilon)Final" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-05; relTol 0; diff --git a/tutorials/combustion/chemFoam/gri/system/fvSolution b/tutorials/combustion/chemFoam/gri/system/fvSolution index c090558aa..6b16dd403 100644 --- a/tutorials/combustion/chemFoam/gri/system/fvSolution +++ b/tutorials/combustion/chemFoam/gri/system/fvSolution @@ -19,7 +19,7 @@ solvers { Yi { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-12; relTol 0; diff --git a/tutorials/combustion/chemFoam/h2/system/fvSolution b/tutorials/combustion/chemFoam/h2/system/fvSolution index c090558aa..6b16dd403 100644 --- a/tutorials/combustion/chemFoam/h2/system/fvSolution +++ b/tutorials/combustion/chemFoam/h2/system/fvSolution @@ -19,7 +19,7 @@ solvers { Yi { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-12; relTol 0; diff --git a/tutorials/combustion/chemFoam/ic8h18/system/fvSolution b/tutorials/combustion/chemFoam/ic8h18/system/fvSolution index c090558aa..6b16dd403 100644 --- a/tutorials/combustion/chemFoam/ic8h18/system/fvSolution +++ b/tutorials/combustion/chemFoam/ic8h18/system/fvSolution @@ -19,7 +19,7 @@ solvers { Yi { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-12; relTol 0; diff --git a/tutorials/combustion/chemFoam/ic8h18_TDAC/system/fvSolution b/tutorials/combustion/chemFoam/ic8h18_TDAC/system/fvSolution index c090558aa..6b16dd403 100644 --- a/tutorials/combustion/chemFoam/ic8h18_TDAC/system/fvSolution +++ b/tutorials/combustion/chemFoam/ic8h18_TDAC/system/fvSolution @@ -19,7 +19,7 @@ solvers { Yi { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-12; relTol 0; diff --git a/tutorials/combustion/chemFoam/nc7h16/system/fvSolution b/tutorials/combustion/chemFoam/nc7h16/system/fvSolution index c090558aa..6b16dd403 100644 --- a/tutorials/combustion/chemFoam/nc7h16/system/fvSolution +++ b/tutorials/combustion/chemFoam/nc7h16/system/fvSolution @@ -19,7 +19,7 @@ solvers { Yi { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-12; relTol 0; diff --git a/tutorials/combustion/engineFoam/kivaTest/system/fvSolution b/tutorials/combustion/engineFoam/kivaTest/system/fvSolution index b16474687..64ba5515c 100644 --- a/tutorials/combustion/engineFoam/kivaTest/system/fvSolution +++ b/tutorials/combustion/engineFoam/kivaTest/system/fvSolution @@ -49,7 +49,7 @@ solvers "(U|Xi|hau|eau|ft|b|ha|ea|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-05; relTol 0.1; diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/fvSolution b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/fvSolution index e247ccbf4..0dd063c8a 100644 --- a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/fvSolution +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/fvSolution @@ -19,21 +19,21 @@ solvers { hf { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 0; relTol 1e-3; } "(Uf|deltaf\*rhof)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-10; relTol 0; } deltaf { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-10; relTol 0; diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/fvSolution b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/fvSolution index 12f3b6643..fc3a6c4ab 100644 --- a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/fvSolution +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/fvSolution @@ -57,7 +57,7 @@ solvers "(U|Yi|h|k)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-8; relTol 0.1; diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/pyrolysisRegion/fvSolution b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/pyrolysisRegion/fvSolution index 45714f1a1..b400e253f 100644 --- a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/pyrolysisRegion/fvSolution +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/pyrolysisRegion/fvSolution @@ -26,7 +26,7 @@ solvers "Yi" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-06; relTol 0; diff --git a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/fvSolution b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/fvSolution index 1329cb1ca..7bacd5c63 100644 --- a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/fvSolution +++ b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/fvSolution @@ -47,7 +47,7 @@ solvers "(U|Yi|k|h|omega)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0.1; diff --git a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/panelRegion/fvSolution b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/panelRegion/fvSolution index 88bd5c58e..08c57ca2b 100644 --- a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/panelRegion/fvSolution +++ b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/panelRegion/fvSolution @@ -26,7 +26,7 @@ solvers "Yi" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-06; relTol 0; diff --git a/tutorials/combustion/fireFoam/les/smallPoolFire2D/system/fvSolution b/tutorials/combustion/fireFoam/les/smallPoolFire2D/system/fvSolution index dcf0353bf..4506a3793 100644 --- a/tutorials/combustion/fireFoam/les/smallPoolFire2D/system/fvSolution +++ b/tutorials/combustion/fireFoam/les/smallPoolFire2D/system/fvSolution @@ -56,7 +56,7 @@ solvers "(U|Yi|k|h|omega)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0.1; diff --git a/tutorials/combustion/fireFoam/les/smallPoolFire3D/system/fvSolution b/tutorials/combustion/fireFoam/les/smallPoolFire3D/system/fvSolution index a26c2f30b..e89bec79c 100644 --- a/tutorials/combustion/fireFoam/les/smallPoolFire3D/system/fvSolution +++ b/tutorials/combustion/fireFoam/les/smallPoolFire3D/system/fvSolution @@ -48,7 +48,7 @@ solvers "(U|Yi|k|h)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0.1; diff --git a/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2D/system/fvSolution b/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2D/system/fvSolution index 7491893cc..7ff37c843 100644 --- a/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2D/system/fvSolution +++ b/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2D/system/fvSolution @@ -39,7 +39,7 @@ solvers "(U|h|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0.1; diff --git a/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2DLTS/system/fvSolution b/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2DLTS/system/fvSolution index 4d0db2d72..38d993782 100644 --- a/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2DLTS/system/fvSolution +++ b/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2DLTS/system/fvSolution @@ -38,7 +38,7 @@ solvers "(U|h|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0.1; diff --git a/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2D_GRI/system/fvSolution b/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2D_GRI/system/fvSolution index 7491893cc..7ff37c843 100644 --- a/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2D_GRI/system/fvSolution +++ b/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2D_GRI/system/fvSolution @@ -39,7 +39,7 @@ solvers "(U|h|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0.1; diff --git a/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2D_GRI_TDAC/system/fvSolution b/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2D_GRI_TDAC/system/fvSolution index 7491893cc..7ff37c843 100644 --- a/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2D_GRI_TDAC/system/fvSolution +++ b/tutorials/combustion/reactingFoam/laminar/counterFlowFlame2D_GRI_TDAC/system/fvSolution @@ -39,7 +39,7 @@ solvers "(U|h|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0.1; diff --git a/tutorials/compressible/rhoCentralDyMFoam/movingCone/system/fvSolution b/tutorials/compressible/rhoCentralDyMFoam/movingCone/system/fvSolution index 5161002b2..7a434bd22 100644 --- a/tutorials/compressible/rhoCentralDyMFoam/movingCone/system/fvSolution +++ b/tutorials/compressible/rhoCentralDyMFoam/movingCone/system/fvSolution @@ -19,7 +19,7 @@ solvers { p { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-06; relTol 0.01; diff --git a/tutorials/compressible/sonicDyMFoam/movingCone/system/fvSolution b/tutorials/compressible/sonicDyMFoam/movingCone/system/fvSolution index 5161002b2..7a434bd22 100644 --- a/tutorials/compressible/sonicDyMFoam/movingCone/system/fvSolution +++ b/tutorials/compressible/sonicDyMFoam/movingCone/system/fvSolution @@ -19,7 +19,7 @@ solvers { p { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-06; relTol 0.01; diff --git a/tutorials/compressible/sonicFoam/ras/nacaAirfoil/system/fvSolution b/tutorials/compressible/sonicFoam/ras/nacaAirfoil/system/fvSolution index afc24d24a..1a0146a64 100644 --- a/tutorials/compressible/sonicFoam/ras/nacaAirfoil/system/fvSolution +++ b/tutorials/compressible/sonicFoam/ras/nacaAirfoil/system/fvSolution @@ -24,7 +24,7 @@ solvers "p.*" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-12; relTol 0; diff --git a/tutorials/financial/financialFoam/europeanCall/system/fvSolution b/tutorials/financial/financialFoam/europeanCall/system/fvSolution index 3b95a4847..14d17e1f9 100644 --- a/tutorials/financial/financialFoam/europeanCall/system/fvSolution +++ b/tutorials/financial/financialFoam/europeanCall/system/fvSolution @@ -19,7 +19,7 @@ solvers { V { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-05; relTol 0; diff --git a/tutorials/heatTransfer/buoyantBoussinesqPimpleFoam/hotRoom/system/fvSolution b/tutorials/heatTransfer/buoyantBoussinesqPimpleFoam/hotRoom/system/fvSolution index 324df46ad..dfaf067c8 100644 --- a/tutorials/heatTransfer/buoyantBoussinesqPimpleFoam/hotRoom/system/fvSolution +++ b/tutorials/heatTransfer/buoyantBoussinesqPimpleFoam/hotRoom/system/fvSolution @@ -33,7 +33,7 @@ solvers "(U|T|k|epsilon|R)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0.1; diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/system/fvSolution b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/system/fvSolution index a5df85e65..6965c865a 100644 --- a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/system/fvSolution +++ b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/system/fvSolution @@ -27,7 +27,7 @@ solvers "(U|T|k|epsilon|R)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-05; relTol 0.1; diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/system/fvSolution b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/system/fvSolution index 627615c53..5e871f1bb 100644 --- a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/system/fvSolution +++ b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/system/fvSolution @@ -27,7 +27,7 @@ solvers "(U|T|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-07; relTol 0.1; diff --git a/tutorials/heatTransfer/buoyantPimpleFoam/hotRoom/system/fvSolution b/tutorials/heatTransfer/buoyantPimpleFoam/hotRoom/system/fvSolution index 7127fdc8c..4e0487cd9 100644 --- a/tutorials/heatTransfer/buoyantPimpleFoam/hotRoom/system/fvSolution +++ b/tutorials/heatTransfer/buoyantPimpleFoam/hotRoom/system/fvSolution @@ -41,7 +41,7 @@ solvers "(U|h|e|k|epsilon|R)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0.1; diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/buoyantCavity/system/fvSolution b/tutorials/heatTransfer/buoyantSimpleFoam/buoyantCavity/system/fvSolution index 90ffdd49b..17183ab5c 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/buoyantCavity/system/fvSolution +++ b/tutorials/heatTransfer/buoyantSimpleFoam/buoyantCavity/system/fvSolution @@ -29,7 +29,7 @@ solvers "(U|h|k|epsilon|omega)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-8; relTol 0.1; diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSolution b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSolution index 66346036c..7f853270f 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSolution +++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSolution @@ -29,7 +29,7 @@ solvers "(U|h|k|epsilon|omega)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-7; relTol 0.01; diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/externalCoupledCavity/system/fvSolution b/tutorials/heatTransfer/buoyantSimpleFoam/externalCoupledCavity/system/fvSolution index d9b7d98e9..de519c1e1 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/externalCoupledCavity/system/fvSolution +++ b/tutorials/heatTransfer/buoyantSimpleFoam/externalCoupledCavity/system/fvSolution @@ -29,7 +29,7 @@ solvers "(U|h|k|epsilon|omega)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-8; relTol 0.1; diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoom/system/fvSolution b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoom/system/fvSolution index c4fd0cde0..24cdb3029 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoom/system/fvSolution +++ b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoom/system/fvSolution @@ -27,7 +27,7 @@ solvers "(U|h|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-05; relTol 0.1; diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/system/fvSolution b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/system/fvSolution index 42b3fef28..f610c939f 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/system/fvSolution +++ b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/system/fvSolution @@ -37,7 +37,7 @@ solvers "(U|h|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-05; relTol 0.1; diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/fvSolution index 07635c7d2..0eb178deb 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/fvSolution @@ -50,7 +50,7 @@ solvers "(U|h|k|epsilon|R)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-7; relTol 0.1; diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSolution index 07635c7d2..0eb178deb 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSolution @@ -50,7 +50,7 @@ solvers "(U|h|k|epsilon|R)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-7; relTol 0.1; diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSolution index 1527d53d6..066616d55 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSolution @@ -43,7 +43,7 @@ solvers "(U|h|k|epsilon|R)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-7; relTol 0.1; diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSolution index 1527d53d6..066616d55 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSolution @@ -43,7 +43,7 @@ solvers "(U|h|k|epsilon|R)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-7; relTol 0.1; diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/air/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/air/fvSolution index f8de0ffe7..895988eac 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/air/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/air/fvSolution @@ -31,7 +31,7 @@ solvers "(U|h|e|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0.1; diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/porous/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/porous/fvSolution index f912142c5..945f8ea24 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/porous/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/porous/fvSolution @@ -30,7 +30,7 @@ solvers "(U|h|e|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-7; relTol 0.1; diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/fvSolution index fc149dff1..2f353374c 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/fvSolution @@ -36,7 +36,7 @@ solvers "(U|h|k|epsilon|G|Ii)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-7; relTol 0.1; diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution index fc149dff1..2f353374c 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution @@ -36,7 +36,7 @@ solvers "(U|h|k|epsilon|G|Ii)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-7; relTol 0.1; diff --git a/tutorials/incompressible/simpleFoam/motorBike/system/fvSolution b/tutorials/incompressible/simpleFoam/motorBike/system/fvSolution index 1aa8af7b2..e19623c35 100644 --- a/tutorials/incompressible/simpleFoam/motorBike/system/fvSolution +++ b/tutorials/incompressible/simpleFoam/motorBike/system/fvSolution @@ -18,10 +18,10 @@ solvers { p { - solver GAMG; - tolerance 1e-7; - relTol 0.01; - smoother GaussSeidel; + solver GAMG; + smoother GaussSeidel; + tolerance 1e-7; + relTol 0.01; } Phi @@ -31,29 +31,29 @@ solvers U { - solver smoothSolver; - smoother GaussSeidel; - tolerance 1e-8; - relTol 0.1; - nSweeps 1; + solver smoothSolver; + smoother GaussSeidel; + tolerance 1e-8; + relTol 0.1; + nSweeps 1; } k { - solver smoothSolver; - smoother GaussSeidel; - tolerance 1e-8; - relTol 0.1; - nSweeps 1; + solver smoothSolver; + smoother GaussSeidel; + tolerance 1e-8; + relTol 0.1; + nSweeps 1; } omega { - solver smoothSolver; - smoother GaussSeidel; - tolerance 1e-8; - relTol 0.1; - nSweeps 1; + solver smoothSolver; + smoother GaussSeidel; + tolerance 1e-8; + relTol 0.1; + nSweeps 1; } } diff --git a/tutorials/lagrangian/reactingParcelFilmFoam/cylinder/system/fvSolution b/tutorials/lagrangian/reactingParcelFilmFoam/cylinder/system/fvSolution index 63c6e0ce0..a1faf2da4 100644 --- a/tutorials/lagrangian/reactingParcelFilmFoam/cylinder/system/fvSolution +++ b/tutorials/lagrangian/reactingParcelFilmFoam/cylinder/system/fvSolution @@ -70,14 +70,14 @@ solvers "(h|Yi|O2|N2|H2O)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0; } hFinal { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0; diff --git a/tutorials/lagrangian/reactingParcelFilmFoam/hotBoxes/system/fvSolution b/tutorials/lagrangian/reactingParcelFilmFoam/hotBoxes/system/fvSolution index 59523edc8..cb05b065e 100644 --- a/tutorials/lagrangian/reactingParcelFilmFoam/hotBoxes/system/fvSolution +++ b/tutorials/lagrangian/reactingParcelFilmFoam/hotBoxes/system/fvSolution @@ -34,7 +34,7 @@ solvers "(U|h|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-5; relTol 0.1; diff --git a/tutorials/lagrangian/reactingParcelFilmFoam/splashPanel/system/fvSolution b/tutorials/lagrangian/reactingParcelFilmFoam/splashPanel/system/fvSolution index d10b1fda2..3bb49837a 100644 --- a/tutorials/lagrangian/reactingParcelFilmFoam/splashPanel/system/fvSolution +++ b/tutorials/lagrangian/reactingParcelFilmFoam/splashPanel/system/fvSolution @@ -66,14 +66,14 @@ solvers "(h|Yi|O2|N2|H2O)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0; } hFinal { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0; diff --git a/tutorials/lagrangian/reactingParcelFilmFoam/splashPanel/system/wallFilmRegion/fvSolution b/tutorials/lagrangian/reactingParcelFilmFoam/splashPanel/system/wallFilmRegion/fvSolution index ae07f4217..0aab30d80 100644 --- a/tutorials/lagrangian/reactingParcelFilmFoam/splashPanel/system/wallFilmRegion/fvSolution +++ b/tutorials/lagrangian/reactingParcelFilmFoam/splashPanel/system/wallFilmRegion/fvSolution @@ -19,14 +19,14 @@ solvers { "(Uf|hf|deltaf\*rhof)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-10; relTol 0; } deltaf { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-10; relTol 0; diff --git a/tutorials/lagrangian/reactingParcelFoam/filter/system/fvSolution b/tutorials/lagrangian/reactingParcelFoam/filter/system/fvSolution index 7248e662b..1914fbdcb 100644 --- a/tutorials/lagrangian/reactingParcelFoam/filter/system/fvSolution +++ b/tutorials/lagrangian/reactingParcelFoam/filter/system/fvSolution @@ -64,7 +64,7 @@ solvers "(Yi|O2|N2|H2O)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0; diff --git a/tutorials/lagrangian/reactingParcelFoam/parcelInBox/system/fvSolution b/tutorials/lagrangian/reactingParcelFoam/parcelInBox/system/fvSolution index 6d07e4ca2..b2d5ddbe4 100644 --- a/tutorials/lagrangian/reactingParcelFoam/parcelInBox/system/fvSolution +++ b/tutorials/lagrangian/reactingParcelFoam/parcelInBox/system/fvSolution @@ -65,7 +65,7 @@ solvers "(Yi|O2|N2|H2O)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0; diff --git a/tutorials/lagrangian/reactingParcelFoam/verticalChannel/system/fvSolution b/tutorials/lagrangian/reactingParcelFoam/verticalChannel/system/fvSolution index 404226dba..71738b6dc 100644 --- a/tutorials/lagrangian/reactingParcelFoam/verticalChannel/system/fvSolution +++ b/tutorials/lagrangian/reactingParcelFoam/verticalChannel/system/fvSolution @@ -69,7 +69,7 @@ solvers "(Yi|O2|N2|H2O)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0; diff --git a/tutorials/lagrangian/sprayFoam/aachenBomb/system/fvSolution b/tutorials/lagrangian/sprayFoam/aachenBomb/system/fvSolution index a9aed26fb..86340f525 100644 --- a/tutorials/lagrangian/sprayFoam/aachenBomb/system/fvSolution +++ b/tutorials/lagrangian/sprayFoam/aachenBomb/system/fvSolution @@ -64,7 +64,7 @@ solvers "(Yi|O2|N2|H2O)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-6; relTol 0; diff --git a/tutorials/mesh/moveDynamicMesh/SnakeRiverCanyon/system/fvSolution b/tutorials/mesh/moveDynamicMesh/SnakeRiverCanyon/system/fvSolution index 028c7d881..236f0297a 100644 --- a/tutorials/mesh/moveDynamicMesh/SnakeRiverCanyon/system/fvSolution +++ b/tutorials/mesh/moveDynamicMesh/SnakeRiverCanyon/system/fvSolution @@ -27,7 +27,7 @@ solvers U { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; tolerance 1e-05; relTol 0; diff --git a/tutorials/multiphase/driftFluxFoam/ras/dahl/system/fvSolution b/tutorials/multiphase/driftFluxFoam/ras/dahl/system/fvSolution index 5cedaa31c..820077fa9 100644 --- a/tutorials/multiphase/driftFluxFoam/ras/dahl/system/fvSolution +++ b/tutorials/multiphase/driftFluxFoam/ras/dahl/system/fvSolution @@ -59,9 +59,8 @@ solvers "(U|k|epsilon)" { - solver PBiCG; + solver PBiCGStab; preconditioner DILU; - smoother symGaussSeidel; tolerance 1e-7; relTol 0.1; minIter 1; diff --git a/tutorials/multiphase/driftFluxFoam/ras/mixerVessel2D/system/fvSolution b/tutorials/multiphase/driftFluxFoam/ras/mixerVessel2D/system/fvSolution index d2397321e..23a99325b 100644 --- a/tutorials/multiphase/driftFluxFoam/ras/mixerVessel2D/system/fvSolution +++ b/tutorials/multiphase/driftFluxFoam/ras/mixerVessel2D/system/fvSolution @@ -67,8 +67,8 @@ solvers "(U|k|epsilon)" { - solver smoothSolver; - smoother symGaussSeidel; + solver PBiCGStab; + preconditioner DILU; tolerance 1e-6; relTol 0.1; } diff --git a/tutorials/multiphase/driftFluxFoam/ras/tank3D/system/fvSolution b/tutorials/multiphase/driftFluxFoam/ras/tank3D/system/fvSolution index ed4bd47af..9c3d51f7c 100644 --- a/tutorials/multiphase/driftFluxFoam/ras/tank3D/system/fvSolution +++ b/tutorials/multiphase/driftFluxFoam/ras/tank3D/system/fvSolution @@ -59,8 +59,8 @@ solvers "(U|k|epsilon)" { - solver smoothSolver; - smoother symGaussSeidel; + solver PBiCGStab; + preconditioner DILU; tolerance 1e-7; relTol 0.1; minIter 1;