mirror of
https://develop.openfoam.com/Development/openfoam.git
synced 2025-11-28 03:28:01 +00:00
applications/test/LduMatrix: no longer compiles and needs replacing
This commit is contained in:
@ -1,162 +0,0 @@
|
|||||||
/*---------------------------------------------------------------------------*\
|
|
||||||
========= |
|
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
|
||||||
\\ / O peration |
|
|
||||||
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
|
|
||||||
\\/ M anipulation |
|
|
||||||
-------------------------------------------------------------------------------
|
|
||||||
License
|
|
||||||
This file is part of OpenFOAM.
|
|
||||||
|
|
||||||
OpenFOAM is free software: you can redistribute it and/or modify it
|
|
||||||
under the terms of the GNU General Public License as published by
|
|
||||||
the Free Software Foundation, either version 3 of the License, or
|
|
||||||
(at your option) any later version.
|
|
||||||
|
|
||||||
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
|
|
||||||
ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
|
|
||||||
FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
|
|
||||||
for more details.
|
|
||||||
|
|
||||||
You should have received a copy of the GNU General Public License
|
|
||||||
along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
|
|
||||||
|
|
||||||
\*---------------------------------------------------------------------------*/
|
|
||||||
|
|
||||||
#include "argList.H"
|
|
||||||
#include "Time.H"
|
|
||||||
#include "fvMesh.H"
|
|
||||||
#include "volFields.H"
|
|
||||||
#include "LduMatrix.H"
|
|
||||||
#include "diagTensorField.H"
|
|
||||||
#include "TPCG.H"
|
|
||||||
#include "TPBiCG.H"
|
|
||||||
#include "NoPreconditioner.H"
|
|
||||||
|
|
||||||
using namespace Foam;
|
|
||||||
|
|
||||||
typedef Foam::LduMatrix<vector, diagTensor, scalar>
|
|
||||||
lduVectorMatrix;
|
|
||||||
defineNamedTemplateTypeNameAndDebug(lduVectorMatrix, 0);
|
|
||||||
|
|
||||||
typedef Foam::DiagonalSolver<vector, diagTensor, scalar>
|
|
||||||
lduVectorDiagonalSolver;
|
|
||||||
defineNamedTemplateTypeNameAndDebug(lduVectorDiagonalSolver, 0);
|
|
||||||
|
|
||||||
template<>
|
|
||||||
const vector lduVectorMatrix::great_(1e15, 1e15, 1e15);
|
|
||||||
|
|
||||||
template<>
|
|
||||||
const vector lduVectorMatrix::small_(1e-15, 1e-15, 1e-15);
|
|
||||||
|
|
||||||
namespace Foam
|
|
||||||
{
|
|
||||||
typedef LduMatrix<vector, diagTensor, scalar>::preconditioner
|
|
||||||
lduVectorPreconditioner;
|
|
||||||
defineTemplateRunTimeSelectionTable(lduVectorPreconditioner, symMatrix);
|
|
||||||
defineTemplateRunTimeSelectionTable(lduVectorPreconditioner, asymMatrix);
|
|
||||||
|
|
||||||
typedef LduMatrix<vector, diagTensor, scalar>::smoother
|
|
||||||
lduVectorSmoother;
|
|
||||||
defineTemplateRunTimeSelectionTable(lduVectorSmoother, symMatrix);
|
|
||||||
defineTemplateRunTimeSelectionTable(lduVectorSmoother, asymMatrix);
|
|
||||||
|
|
||||||
typedef LduMatrix<vector, diagTensor, scalar>::solver
|
|
||||||
lduVectorSolver;
|
|
||||||
defineTemplateRunTimeSelectionTable(lduVectorSolver, symMatrix);
|
|
||||||
defineTemplateRunTimeSelectionTable(lduVectorSolver, asymMatrix);
|
|
||||||
|
|
||||||
typedef TPCG<vector, diagTensor, scalar> TPCGVector;
|
|
||||||
defineNamedTemplateTypeNameAndDebug(TPCGVector, 0);
|
|
||||||
|
|
||||||
LduMatrix<vector, diagTensor, scalar>::solver::
|
|
||||||
addsymMatrixConstructorToTable<TPCGVector>
|
|
||||||
addTPCGSymMatrixConstructorToTable_;
|
|
||||||
|
|
||||||
typedef TPBiCG<vector, diagTensor, scalar> TPBiCGVector;
|
|
||||||
defineNamedTemplateTypeNameAndDebug(TPBiCGVector, 0);
|
|
||||||
|
|
||||||
LduMatrix<vector, diagTensor, scalar>::solver::
|
|
||||||
addasymMatrixConstructorToTable<TPBiCGVector>
|
|
||||||
addTPBiCGSymMatrixConstructorToTable_;
|
|
||||||
|
|
||||||
typedef NoPreconditioner<vector, diagTensor, scalar> NoPreconditionerVector;
|
|
||||||
defineNamedTemplateTypeNameAndDebug(NoPreconditionerVector, 0);
|
|
||||||
|
|
||||||
LduMatrix<vector, diagTensor, scalar>::preconditioner::
|
|
||||||
addsymMatrixConstructorToTable<NoPreconditionerVector>
|
|
||||||
addNoPreconditionerSymMatrixConstructorToTable_;
|
|
||||||
|
|
||||||
LduMatrix<vector, diagTensor, scalar>::preconditioner::
|
|
||||||
addasymMatrixConstructorToTable<NoPreconditionerVector>
|
|
||||||
addNoPreconditionerAsymMatrixConstructorToTable_;
|
|
||||||
}
|
|
||||||
|
|
||||||
|
|
||||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
|
||||||
// Main program:
|
|
||||||
|
|
||||||
int main(int argc, char *argv[])
|
|
||||||
{
|
|
||||||
#include "setRootCase.H"
|
|
||||||
|
|
||||||
#include "createTime.H"
|
|
||||||
#include "createMesh.H"
|
|
||||||
|
|
||||||
volVectorField psi
|
|
||||||
(
|
|
||||||
IOobject
|
|
||||||
(
|
|
||||||
"U",
|
|
||||||
runTime.timeName(),
|
|
||||||
mesh,
|
|
||||||
IOobject::MUST_READ,
|
|
||||||
IOobject::AUTO_WRITE
|
|
||||||
),
|
|
||||||
mesh
|
|
||||||
);
|
|
||||||
|
|
||||||
lduVectorMatrix testMatrix(mesh);
|
|
||||||
testMatrix.diag() = 2*pTraits<diagTensor>::one;
|
|
||||||
testMatrix.source() = pTraits<vector>::one;
|
|
||||||
testMatrix.upper() = 0.1;
|
|
||||||
testMatrix.lower() = -0.1;
|
|
||||||
|
|
||||||
Info<< testMatrix << endl;
|
|
||||||
|
|
||||||
FieldField<Field, scalar> boundaryCoeffs(0);
|
|
||||||
FieldField<Field, scalar> internalCoeffs(0);
|
|
||||||
|
|
||||||
autoPtr<lduVectorMatrix::solver> testMatrixSolver =
|
|
||||||
lduVectorMatrix::solver::New
|
|
||||||
(
|
|
||||||
psi.name(),
|
|
||||||
testMatrix,
|
|
||||||
boundaryCoeffs,
|
|
||||||
internalCoeffs,
|
|
||||||
psi.boundaryField().interfaces(),
|
|
||||||
IStringStream
|
|
||||||
(
|
|
||||||
"PBiCG"
|
|
||||||
"{"
|
|
||||||
" preconditioner none;"
|
|
||||||
" tolerance (1e-05 1e-05 1e-05);"
|
|
||||||
" relTol (0 0 0);"
|
|
||||||
"}"
|
|
||||||
)()
|
|
||||||
);
|
|
||||||
|
|
||||||
lduVectorMatrix::solverPerformance solverPerf =
|
|
||||||
testMatrixSolver->solve(psi);
|
|
||||||
|
|
||||||
solverPerf.print();
|
|
||||||
|
|
||||||
Info<< psi << endl;
|
|
||||||
|
|
||||||
Info<< "End\n" << endl;
|
|
||||||
|
|
||||||
return 0;
|
|
||||||
}
|
|
||||||
|
|
||||||
|
|
||||||
// ************************************************************************* //
|
|
||||||
@ -1,162 +0,0 @@
|
|||||||
/*---------------------------------------------------------------------------*\
|
|
||||||
========= |
|
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
|
||||||
\\ / O peration |
|
|
||||||
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
|
|
||||||
\\/ M anipulation |
|
|
||||||
-------------------------------------------------------------------------------
|
|
||||||
License
|
|
||||||
This file is part of OpenFOAM.
|
|
||||||
|
|
||||||
OpenFOAM is free software: you can redistribute it and/or modify it
|
|
||||||
under the terms of the GNU General Public License as published by
|
|
||||||
the Free Software Foundation, either version 3 of the License, or
|
|
||||||
(at your option) any later version.
|
|
||||||
|
|
||||||
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
|
|
||||||
ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
|
|
||||||
FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
|
|
||||||
for more details.
|
|
||||||
|
|
||||||
You should have received a copy of the GNU General Public License
|
|
||||||
along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
|
|
||||||
|
|
||||||
\*---------------------------------------------------------------------------*/
|
|
||||||
|
|
||||||
#include "argList.H"
|
|
||||||
#include "Time.H"
|
|
||||||
#include "fvMesh.H"
|
|
||||||
#include "volFields.H"
|
|
||||||
#include "LduMatrix.H"
|
|
||||||
#include "tensorField.H"
|
|
||||||
#include "TPCG.H"
|
|
||||||
#include "TPBiCG.H"
|
|
||||||
#include "NoPreconditioner.H"
|
|
||||||
|
|
||||||
using namespace Foam;
|
|
||||||
|
|
||||||
typedef Foam::LduMatrix<vector, tensor, scalar>
|
|
||||||
lduVectorMatrix;
|
|
||||||
defineNamedTemplateTypeNameAndDebug(lduVectorMatrix, 0);
|
|
||||||
|
|
||||||
typedef Foam::DiagonalSolver<vector, tensor, scalar>
|
|
||||||
lduVectorDiagonalSolver;
|
|
||||||
defineNamedTemplateTypeNameAndDebug(lduVectorDiagonalSolver, 0);
|
|
||||||
|
|
||||||
template<>
|
|
||||||
const vector lduVectorMatrix::great_(1e15, 1e15, 1e15);
|
|
||||||
|
|
||||||
template<>
|
|
||||||
const vector lduVectorMatrix::small_(1e-15, 1e-15, 1e-15);
|
|
||||||
|
|
||||||
namespace Foam
|
|
||||||
{
|
|
||||||
typedef LduMatrix<vector, tensor, scalar>::preconditioner
|
|
||||||
lduVectorPreconditioner;
|
|
||||||
defineTemplateRunTimeSelectionTable(lduVectorPreconditioner, symMatrix);
|
|
||||||
defineTemplateRunTimeSelectionTable(lduVectorPreconditioner, asymMatrix);
|
|
||||||
|
|
||||||
typedef LduMatrix<vector, tensor, scalar>::smoother
|
|
||||||
lduVectorSmoother;
|
|
||||||
defineTemplateRunTimeSelectionTable(lduVectorSmoother, symMatrix);
|
|
||||||
defineTemplateRunTimeSelectionTable(lduVectorSmoother, asymMatrix);
|
|
||||||
|
|
||||||
typedef LduMatrix<vector, tensor, scalar>::solver
|
|
||||||
lduVectorSolver;
|
|
||||||
defineTemplateRunTimeSelectionTable(lduVectorSolver, symMatrix);
|
|
||||||
defineTemplateRunTimeSelectionTable(lduVectorSolver, asymMatrix);
|
|
||||||
|
|
||||||
typedef TPCG<vector, tensor, scalar> TPCGVector;
|
|
||||||
defineNamedTemplateTypeNameAndDebug(TPCGVector, 0);
|
|
||||||
|
|
||||||
LduMatrix<vector, tensor, scalar>::solver::
|
|
||||||
addsymMatrixConstructorToTable<TPCGVector>
|
|
||||||
addTPCGSymMatrixConstructorToTable_;
|
|
||||||
|
|
||||||
typedef TPBiCG<vector, tensor, scalar> TPBiCGVector;
|
|
||||||
defineNamedTemplateTypeNameAndDebug(TPBiCGVector, 0);
|
|
||||||
|
|
||||||
LduMatrix<vector, tensor, scalar>::solver::
|
|
||||||
addasymMatrixConstructorToTable<TPBiCGVector>
|
|
||||||
addTPBiCGSymMatrixConstructorToTable_;
|
|
||||||
|
|
||||||
typedef NoPreconditioner<vector, tensor, scalar> NoPreconditionerVector;
|
|
||||||
defineNamedTemplateTypeNameAndDebug(NoPreconditionerVector, 0);
|
|
||||||
|
|
||||||
LduMatrix<vector, tensor, scalar>::preconditioner::
|
|
||||||
addsymMatrixConstructorToTable<NoPreconditionerVector>
|
|
||||||
addNoPreconditionerSymMatrixConstructorToTable_;
|
|
||||||
|
|
||||||
LduMatrix<vector, tensor, scalar>::preconditioner::
|
|
||||||
addasymMatrixConstructorToTable<NoPreconditionerVector>
|
|
||||||
addNoPreconditionerAsymMatrixConstructorToTable_;
|
|
||||||
}
|
|
||||||
|
|
||||||
|
|
||||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
|
||||||
// Main program:
|
|
||||||
|
|
||||||
int main(int argc, char *argv[])
|
|
||||||
{
|
|
||||||
#include "setRootCase.H"
|
|
||||||
|
|
||||||
#include "createTime.H"
|
|
||||||
#include "createMesh.H"
|
|
||||||
|
|
||||||
volVectorField psi
|
|
||||||
(
|
|
||||||
IOobject
|
|
||||||
(
|
|
||||||
"U",
|
|
||||||
runTime.timeName(),
|
|
||||||
mesh,
|
|
||||||
IOobject::MUST_READ,
|
|
||||||
IOobject::AUTO_WRITE
|
|
||||||
),
|
|
||||||
mesh
|
|
||||||
);
|
|
||||||
|
|
||||||
lduVectorMatrix testMatrix(mesh);
|
|
||||||
testMatrix.diag() = 2*I;
|
|
||||||
testMatrix.source() = pTraits<vector>::one;
|
|
||||||
testMatrix.upper() = 0.1;
|
|
||||||
testMatrix.lower() = -0.1;
|
|
||||||
|
|
||||||
Info<< testMatrix << endl;
|
|
||||||
|
|
||||||
FieldField<Field, scalar> boundaryCoeffs(0);
|
|
||||||
FieldField<Field, scalar> internalCoeffs(0);
|
|
||||||
|
|
||||||
autoPtr<lduVectorMatrix::solver> testMatrixSolver =
|
|
||||||
lduVectorMatrix::solver::New
|
|
||||||
(
|
|
||||||
psi.name(),
|
|
||||||
testMatrix,
|
|
||||||
//boundaryCoeffs,
|
|
||||||
//internalCoeffs,
|
|
||||||
//psi.boundaryField().interfaces(),
|
|
||||||
IStringStream
|
|
||||||
(
|
|
||||||
"PBiCG"
|
|
||||||
"{"
|
|
||||||
" preconditioner none;"
|
|
||||||
" tolerance (1e-05 1e-05 1e-05);"
|
|
||||||
" relTol (0 0 0);"
|
|
||||||
"}"
|
|
||||||
)()
|
|
||||||
);
|
|
||||||
|
|
||||||
lduVectorMatrix::solverPerformance solverPerf =
|
|
||||||
testMatrixSolver->solve(psi);
|
|
||||||
|
|
||||||
solverPerf.print();
|
|
||||||
|
|
||||||
Info<< psi << endl;
|
|
||||||
|
|
||||||
Info<< "End\n" << endl;
|
|
||||||
|
|
||||||
return 0;
|
|
||||||
}
|
|
||||||
|
|
||||||
|
|
||||||
// ************************************************************************* //
|
|
||||||
@ -1,147 +0,0 @@
|
|||||||
/*---------------------------------------------------------------------------*\
|
|
||||||
========= |
|
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
|
||||||
\\ / O peration |
|
|
||||||
\\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation
|
|
||||||
\\/ M anipulation |
|
|
||||||
-------------------------------------------------------------------------------
|
|
||||||
License
|
|
||||||
This file is part of OpenFOAM.
|
|
||||||
|
|
||||||
OpenFOAM is free software: you can redistribute it and/or modify it
|
|
||||||
under the terms of the GNU General Public License as published by
|
|
||||||
the Free Software Foundation, either version 3 of the License, or
|
|
||||||
(at your option) any later version.
|
|
||||||
|
|
||||||
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
|
|
||||||
ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
|
|
||||||
FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
|
|
||||||
for more details.
|
|
||||||
|
|
||||||
You should have received a copy of the GNU General Public License
|
|
||||||
along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
|
|
||||||
|
|
||||||
Application
|
|
||||||
icoFoam
|
|
||||||
|
|
||||||
Description
|
|
||||||
Transient solver for incompressible, laminar flow of Newtonian fluids.
|
|
||||||
|
|
||||||
\*---------------------------------------------------------------------------*/
|
|
||||||
|
|
||||||
#include "fvCFD.H"
|
|
||||||
#include "LduMatrix.H"
|
|
||||||
#include "diagTensorField.H"
|
|
||||||
|
|
||||||
typedef LduMatrix<vector, scalar, scalar> lduVectorMatrix;
|
|
||||||
|
|
||||||
|
|
||||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
|
||||||
|
|
||||||
int main(int argc, char *argv[])
|
|
||||||
{
|
|
||||||
#include "setRootCase.H"
|
|
||||||
|
|
||||||
#include "createTime.H"
|
|
||||||
#include "createMesh.H"
|
|
||||||
#include "createFields.H"
|
|
||||||
#include "initContinuityErrs.H"
|
|
||||||
|
|
||||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
|
||||||
|
|
||||||
Info<< "\nStarting time loop\n" << endl;
|
|
||||||
|
|
||||||
while (runTime.loop())
|
|
||||||
{
|
|
||||||
Info<< "Time = " << runTime.timeName() << nl << endl;
|
|
||||||
|
|
||||||
#include "readPISOControls.H"
|
|
||||||
#include "CourantNo.H"
|
|
||||||
|
|
||||||
fvVectorMatrix UEqn
|
|
||||||
(
|
|
||||||
fvm::ddt(U)
|
|
||||||
+ fvm::div(phi, U)
|
|
||||||
- fvm::laplacian(nu, U)
|
|
||||||
);
|
|
||||||
|
|
||||||
fvVectorMatrix UEqnp(UEqn == -fvc::grad(p));
|
|
||||||
|
|
||||||
lduVectorMatrix U3Eqnp(mesh);
|
|
||||||
U3Eqnp.diag() = UEqnp.diag();
|
|
||||||
U3Eqnp.upper() = UEqnp.upper();
|
|
||||||
U3Eqnp.lower() = UEqnp.lower();
|
|
||||||
U3Eqnp.source() = UEqnp.source();
|
|
||||||
|
|
||||||
UEqnp.addBoundaryDiag(U3Eqnp.diag(), 0);
|
|
||||||
UEqnp.addBoundarySource(U3Eqnp.source(), false);
|
|
||||||
|
|
||||||
autoPtr<lduVectorMatrix::solver> U3EqnpSolver =
|
|
||||||
lduVectorMatrix::solver::New
|
|
||||||
(
|
|
||||||
U.name(),
|
|
||||||
U3Eqnp,
|
|
||||||
dictionary
|
|
||||||
(
|
|
||||||
IStringStream
|
|
||||||
(
|
|
||||||
"{"
|
|
||||||
" solver PBiCG;"
|
|
||||||
" preconditioner DILU;"
|
|
||||||
" tolerance (1e-5 1e-5 1);"
|
|
||||||
" relTol (0 0 0);"
|
|
||||||
"}"
|
|
||||||
)()
|
|
||||||
)
|
|
||||||
);
|
|
||||||
|
|
||||||
U3EqnpSolver->solve(U).print(Info);
|
|
||||||
|
|
||||||
// --- PISO loop
|
|
||||||
|
|
||||||
for (int corr=0; corr<nCorr; corr++)
|
|
||||||
{
|
|
||||||
volScalarField rAU(1.0/UEqn.A());
|
|
||||||
|
|
||||||
U = rAU*UEqn.H();
|
|
||||||
phi = (fvc::interpolate(U) & mesh.Sf())
|
|
||||||
+ fvc::ddtCorr(rAU, U, phi);
|
|
||||||
|
|
||||||
adjustPhi(phi, U, p);
|
|
||||||
|
|
||||||
for (int nonOrth=0; nonOrth<=nNonOrthCorr; nonOrth++)
|
|
||||||
{
|
|
||||||
fvScalarMatrix pEqn
|
|
||||||
(
|
|
||||||
fvm::laplacian(rAU, p) == fvc::div(phi)
|
|
||||||
);
|
|
||||||
|
|
||||||
pEqn.setReference(pRefCell, pRefValue);
|
|
||||||
pEqn.solve();
|
|
||||||
|
|
||||||
if (nonOrth == nNonOrthCorr)
|
|
||||||
{
|
|
||||||
phi -= pEqn.flux();
|
|
||||||
}
|
|
||||||
}
|
|
||||||
|
|
||||||
#include "continuityErrs.H"
|
|
||||||
|
|
||||||
U -= rAU*fvc::grad(p);
|
|
||||||
U.correctBoundaryConditions();
|
|
||||||
}
|
|
||||||
|
|
||||||
runTime.write();
|
|
||||||
|
|
||||||
Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s"
|
|
||||||
<< " ClockTime = " << runTime.elapsedClockTime() << " s"
|
|
||||||
<< nl << endl;
|
|
||||||
}
|
|
||||||
|
|
||||||
Info<< "End\n" << endl;
|
|
||||||
|
|
||||||
return 0;
|
|
||||||
}
|
|
||||||
|
|
||||||
|
|
||||||
// ************************************************************************* //
|
|
||||||
@ -1,3 +0,0 @@
|
|||||||
LduMatrixTest3.C
|
|
||||||
|
|
||||||
EXE = $(FOAM_USER_APPBIN)/LduMatrixTest
|
|
||||||
@ -1,4 +0,0 @@
|
|||||||
EXE_INC = \
|
|
||||||
-I$(LIB_SRC)/finiteVolume/lnInclude
|
|
||||||
|
|
||||||
EXE_LIBS = -lfiniteVolume
|
|
||||||
@ -1,55 +0,0 @@
|
|||||||
Info<< "Reading transportProperties\n" << endl;
|
|
||||||
|
|
||||||
IOdictionary transportProperties
|
|
||||||
(
|
|
||||||
IOobject
|
|
||||||
(
|
|
||||||
"transportProperties",
|
|
||||||
runTime.constant(),
|
|
||||||
mesh,
|
|
||||||
IOobject::MUST_READ_IF_MODIFIED,
|
|
||||||
IOobject::NO_WRITE
|
|
||||||
)
|
|
||||||
);
|
|
||||||
|
|
||||||
dimensionedScalar nu
|
|
||||||
(
|
|
||||||
transportProperties.lookup("nu")
|
|
||||||
);
|
|
||||||
|
|
||||||
Info<< "Reading field p\n" << endl;
|
|
||||||
volScalarField p
|
|
||||||
(
|
|
||||||
IOobject
|
|
||||||
(
|
|
||||||
"p",
|
|
||||||
runTime.timeName(),
|
|
||||||
mesh,
|
|
||||||
IOobject::MUST_READ,
|
|
||||||
IOobject::AUTO_WRITE
|
|
||||||
),
|
|
||||||
mesh
|
|
||||||
);
|
|
||||||
|
|
||||||
|
|
||||||
Info<< "Reading field U\n" << endl;
|
|
||||||
volVectorField U
|
|
||||||
(
|
|
||||||
IOobject
|
|
||||||
(
|
|
||||||
"U",
|
|
||||||
runTime.timeName(),
|
|
||||||
mesh,
|
|
||||||
IOobject::MUST_READ,
|
|
||||||
IOobject::AUTO_WRITE
|
|
||||||
),
|
|
||||||
mesh
|
|
||||||
);
|
|
||||||
|
|
||||||
|
|
||||||
# include "createPhi.H"
|
|
||||||
|
|
||||||
|
|
||||||
label pRefCell = 0;
|
|
||||||
scalar pRefValue = 0.0;
|
|
||||||
setRefCell(p, mesh.solutionDict().subDict("PISO"), pRefCell, pRefValue);
|
|
||||||
Reference in New Issue
Block a user