solvers::solidDisplacement: New solver module for solid stress analysis

executed with foamRun for single region simulations of foamMultiRun for
multi-region simulations.  Replaces solidDisplacementFoam and
solidEquilibriumDisplacementFoam and all the corresponding tutorials have been
updated and moved to tutorials/modules/solidDisplacement.

Class
    Foam::solvers::solidDisplacement

Description
    Solver module for steady or transient segregated finite-volume solution of
    linear-elastic, small-strain deformation of a solid body, with optional
    thermal diffusion and thermal stresses.

    Solves for the displacement vector field D, also generating the stress
    tensor field sigma, including the thermal stress contribution if selected.

SourceFiles
    solidDisplacement.C
This commit is contained in:
Henry Weller
2023-01-03 18:12:04 +00:00
parent 20c7c7c21a
commit 55be8068d4
45 changed files with 1584 additions and 384 deletions

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2022 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2022-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -78,12 +78,16 @@ void Foam::solvers::solid::correctDiNum()
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
Foam::solvers::solid::solid(fvMesh& mesh)
Foam::solvers::solid::solid
(
fvMesh& mesh,
autoPtr<solidThermo> thermoPtr
)
:
solver(mesh),
pThermo(solidThermo::New(mesh)),
thermo(pThermo()),
thermo_(thermoPtr),
thermo(thermo_()),
T(thermo.T()),
@ -91,9 +95,6 @@ Foam::solvers::solid::solid(fvMesh& mesh)
DiNum(0)
{
// Read the controls
read();
thermo.validate("solid", "h", "e");
if (transient())
@ -110,6 +111,16 @@ Foam::solvers::solid::solid(fvMesh& mesh)
}
Foam::solvers::solid::solid(fvMesh& mesh)
:
solid(mesh, solidThermo::New(mesh))
{
// Read the controls
read();
}
// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * //
Foam::solvers::solid::~solid()

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2022 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2022-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -67,7 +67,7 @@ protected:
// Thermophysical properties
autoPtr<solidThermo> pThermo;
autoPtr<solidThermo> thermo_;
solidThermo& thermo;
@ -85,16 +85,16 @@ protected:
scalar DiNum;
// Protected Member Functions
//- Read controls
virtual void read();
private:
// Private Member Functions
//- Read controls
void read();
//- Set rDeltaT for LTS
// void setRDeltaT();
//- Correct the cached Courant numbers
void correctDiNum();
@ -107,6 +107,9 @@ public:
// Constructors
//- Construct from region mesh and thermophysical properties
solid(fvMesh& mesh, autoPtr<solidThermo>);
//- Construct from region mesh
solid(fvMesh& mesh);

View File

@ -1,5 +1,5 @@
derivedFvPatchFields/tractionDisplacement/tractionDisplacementFvPatchVectorField.C
derivedFvPatchFields/hydrostaticDisplacement/hydrostaticDisplacementFvPatchVectorField.C
solidDisplacementFoam.C
solidDisplacement.C
EXE = $(FOAM_APPBIN)/solidDisplacementFoam
LIB = $(FOAM_LIBBIN)/libsolidDisplacement

View File

@ -1,21 +1,23 @@
EXE_INC = \
-I. \
-IsolidDisplacementThermo \
-IderivedFvPatchFields/tractionDisplacement \
-IderivedFvPatchFields/hydrostaticDisplacement \
-I$(FOAM_SOLVERS)/modules/solid/lnInclude \
-I$(LIB_SRC)/physicalProperties/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/solidThermo/lnInclude \
-I$(LIB_SRC)/ThermophysicalTransportModels/thermophysicalTransportModel/lnInclude \
-I$(LIB_SRC)/ThermophysicalTransportModels/solid/lnInclude \
-I$(LIB_SRC)/finiteVolume/lnInclude \
-I$(LIB_SRC)/meshTools/lnInclude
-I$(LIB_SRC)/meshTools/lnInclude \
-I$(LIB_SRC)/sampling/lnInclude
EXE_LIBS = \
LIB_LIBS = \
-lsolid \
-lsolidThermo \
-lsolidDisplacementThermo \
-lsolidThermophysicalTransportModels \
-lcoupledThermophysicalTransportModels \
-lspecie \
-lfiniteVolume \
-lmeshTools \
-lsampling \
-lfvModels \
-lfvConstraints

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2018-2020 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2018-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2018-2020 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2018-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2022 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2022 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License

View File

@ -0,0 +1,276 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2023 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 "solidDisplacement.H"
#include "fvcGrad.H"
#include "fvcDiv.H"
#include "fvcLaplacian.H"
#include "fvmD2dt2.H"
#include "fvmLaplacian.H"
#include "addToRunTimeSelectionTable.H"
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
namespace Foam
{
namespace solvers
{
defineTypeNameAndDebug(solidDisplacement, 0);
addToRunTimeSelectionTable(solver, solidDisplacement, fvMesh);
}
}
// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
void Foam::solvers::solidDisplacement::read()
{
solid::read();
nCorr = pimple.dict().lookupOrDefault<int>("nCorrectors", 1);
convergenceTolerance = pimple.dict().lookupOrDefault<scalar>("D", 0);
pimple.dict().lookup("compactNormalStress") >> compactNormalStress;
accFac = pimple.dict().lookupOrDefault<scalar>("accelerationFactor", 1);
}
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
Foam::solvers::solidDisplacement::solidDisplacement(fvMesh& mesh)
:
solid
(
mesh,
autoPtr<solidThermo>(new solidDisplacementThermo(mesh))
),
thermo(refCast<solidDisplacementThermo>(solid::thermo)),
compactNormalStress(pimple.dict().lookup("compactNormalStress")),
D
(
IOobject
(
"D",
runTime.name(),
mesh,
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
mesh
),
E(thermo.E()),
nu(thermo.nu()),
mu(E/(2*(1 + nu))),
lambda
(
thermo.planeStress()
? nu*E/((1 + nu)*(1 - nu))
: nu*E/((1 + nu)*(1 - 2*nu))
),
threeK
(
thermo.planeStress()
? E/(1 - nu)
: E/(1 - 2*nu)
),
threeKalpha("threeKalpha", threeK*thermo.alphav()),
sigmaD
(
IOobject
(
"sigmaD",
runTime.name(),
mesh
),
mu*twoSymm(fvc::grad(D)) + lambda*(I*tr(fvc::grad(D)))
),
divSigmaExp
(
IOobject
(
"divSigmaExp",
runTime.name(),
mesh
),
fvc::div(sigmaD)
- (
compactNormalStress
? fvc::laplacian(2*mu + lambda, D, "laplacian(DD,D)")
: fvc::div((2*mu + lambda)*fvc::grad(D), "div(sigmaD)")
)
)
{
mesh.schemes().setFluxRequired(D.name());
// Read the controls
read();
}
// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * //
Foam::solvers::solidDisplacement::~solidDisplacement()
{}
// * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * * //
void Foam::solvers::solidDisplacement::prePredictor()
{
if (thermo.thermalStress())
{
solid::prePredictor();
}
}
void Foam::solvers::solidDisplacement::thermophysicalPredictor()
{
if (thermo.thermalStress())
{
solid::thermophysicalPredictor();
}
}
void Foam::solvers::solidDisplacement::pressureCorrector()
{
const volScalarField& rho = thermo.rho();
int iCorr = 0;
scalar initialResidual = 0;
{
{
fvVectorMatrix DEqn
(
fvm::d2dt2(rho, D)
==
fvm::laplacian(2*mu + lambda, D, "laplacian(DD,D)")
+ divSigmaExp
+ rho*fvModels().d2dt2(D)
);
if (thermo.thermalStress())
{
DEqn += fvc::grad(threeKalpha*T);
}
fvConstraints().constrain(DEqn);
initialResidual = DEqn.solve().max().initialResidual();
// For steady-state optionally accelerate the solution
// by over-relaxing the displacement
if (mesh.schemes().steady() && accFac > 1)
{
D += (accFac - 1)*(D - D.oldTime());
}
if (!compactNormalStress)
{
divSigmaExp = fvc::div(DEqn.flux());
}
}
const volTensorField gradD(fvc::grad(D));
sigmaD = mu*twoSymm(gradD) + (lambda*I)*tr(gradD);
if (compactNormalStress)
{
divSigmaExp = fvc::div
(
sigmaD - (2*mu + lambda)*gradD,
"div(sigmaD)"
);
}
else
{
divSigmaExp += fvc::div(sigmaD);
}
} while (initialResidual > convergenceTolerance && ++iCorr < nCorr);
}
void Foam::solvers::solidDisplacement::postCorrector()
{
if (thermo.thermalStress())
{
solid::postCorrector();
}
}
void Foam::solvers::solidDisplacement::postSolve()
{
if (runTime.writeTime())
{
volSymmTensorField sigma
(
IOobject
(
"sigma",
runTime.name(),
mesh
),
sigmaD
);
if (thermo.thermalStress())
{
sigma = sigma - I*(threeKalpha*thermo.T());
}
volScalarField sigmaEq
(
IOobject
(
"sigmaEq",
runTime.name(),
mesh
),
sqrt((3.0/2.0)*magSqr(dev(sigma)))
);
Info<< "Max sigmaEq = " << max(sigmaEq).value()
<< endl;
sigma.write();
sigmaEq.write();
}
}
// ************************************************************************* //

View File

@ -0,0 +1,185 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2023 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/>.
Class
Foam::solvers::solidDisplacement
Description
Solver module for steady or transient segregated finite-volume solution of
linear-elastic, small-strain deformation of a solid body, with optional
thermal diffusion and thermal stresses.
Solves for the displacement vector field D, also generating the stress
tensor field sigma, including the thermal stress contribution if selected.
SourceFiles
solidDisplacement.C
\*---------------------------------------------------------------------------*/
#ifndef solidDisplacement_H
#define solidDisplacement_H
#include "solid.H"
#include "solidDisplacementThermo.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
{
namespace solvers
{
/*---------------------------------------------------------------------------*\
Class solidDisplacement Declaration
\*---------------------------------------------------------------------------*/
class solidDisplacement
:
public solid
{
protected:
// Thermophysical properties
solidDisplacementThermo& thermo;
// Solution algorithm controls
//- Switch for normal stress discretisation (required)
// The compact form uses snGrad (more convergent, less accurate)
// The non-compact form uses grad (less convergent, more accurate)
Switch compactNormalStress;
//- Maximum number of displacement/stress correctors per time-step
// Defaults to 1
int nCorr;
//- Convergence tolerance for the displacement/stress correctors
// Defaults to 0
scalar convergenceTolerance;
//- Acceleration factor for faster steady-state simulations
// Applies over-relaxation to the displacement field after solution
// Typically between 1 and 2, the optimal value is case dependent
// and should be selected to maximise convergence rate while
// maintaining stability.
// Should be set lower for higher Poisson's ratios for stability.
scalar accFac;
// Kinematic properties
//- Displacement field
volVectorField D;
//- Young's modulus
const volScalarField& E;
//- Poisson's ratio
const volScalarField& nu;
//- Lame's coefficient
const volScalarField mu;
//- Lame's coefficient
const volScalarField lambda;
const volScalarField threeK;
const volScalarField threeKalpha;
// Cached temporary fields
//- Stress field
volSymmTensorField sigmaD;
//- Divergence of the explicit part of the stress
volVectorField divSigmaExp;
// Protected Member Functions
//- Read controls
virtual void read();
public:
//- Runtime type information
TypeName("solidDisplacement");
// Constructors
//- Construct from region mesh
solidDisplacement(fvMesh& mesh);
//- Disallow default bitwise copy construction
solidDisplacement(const solidDisplacement&) = delete;
//- Destructor
virtual ~solidDisplacement();
// Member Functions
//- Called at the beginning of the PIMPLE loop
virtual void prePredictor();
//- Construct and solve the energy equation,
// convert to temperature
// and update thermophysical and transport properties
virtual void thermophysicalPredictor();
//- Construct and solve the displacement equation to obtain the stress
virtual void pressureCorrector();
//- Correct the thermophysical transport modelling
virtual void postCorrector();
//- Called after the PIMPLE loop at the end of the time-step
virtual void postSolve();
// Member Operators
//- Disallow default bitwise assignment
void operator=(const solidDisplacement&) = delete;
};
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
} // End namespace solvers
} // End namespace Foam
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
#endif
// ************************************************************************* //

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2019-2022 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2019-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2019-2022 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2019-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License

View File

@ -1,38 +0,0 @@
if (runTime.writeTime())
{
volSymmTensorField sigma
(
IOobject
(
"sigma",
runTime.name(),
mesh,
IOobject::NO_READ,
IOobject::AUTO_WRITE
),
sigmaD
);
if (thermo.thermalStress())
{
sigma = sigma - I*(threeKalpha*thermo.T());
}
volScalarField sigmaEq
(
IOobject
(
"sigmaEq",
runTime.name(),
mesh,
IOobject::NO_READ,
IOobject::AUTO_WRITE
),
sqrt((3.0/2.0)*magSqr(dev(sigma)))
);
Info<< "Max sigmaEq = " << max(sigmaEq).value()
<< endl;
runTime.write();
}

View File

@ -1,4 +0,0 @@
const dictionary& stressControl =
mesh.solution().dict().subDict("stressAnalysis");
Switch compactNormalStress(stressControl.lookup("compactNormalStress"));

View File

@ -1,10 +0,0 @@
#include "createControl.H"
int nCorr = stressControl.lookupOrDefault<int>("nCorrectors", 1);
scalar convergenceTolerance(stressControl.lookupOrDefault<scalar>("D", 0));
scalar accFac
(
stressControl.lookupOrDefault<scalar>("accelerationFactor", 1)
);

View File

@ -1 +0,0 @@
const volScalarField& rho(thermo.rho());

View File

@ -1,57 +0,0 @@
#include "readThermophysicalProperties.H"
Info<< "Reading field D\n" << endl;
volVectorField D
(
IOobject
(
"D",
runTime.name(),
mesh,
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
mesh
);
Info<< "Calculating stress field sigmaD\n" << endl;
volSymmTensorField sigmaD
(
IOobject
(
"sigmaD",
runTime.name(),
mesh,
IOobject::NO_READ,
IOobject::NO_WRITE
),
mu*twoSymm(fvc::grad(D)) + lambda*(I*tr(fvc::grad(D)))
);
Info<< "Calculating explicit part of div(sigma) divSigmaExp\n" << endl;
volVectorField divSigmaExp
(
IOobject
(
"divSigmaExp",
runTime.name(),
mesh,
IOobject::NO_READ,
IOobject::NO_WRITE
),
fvc::div(sigmaD)
);
if (compactNormalStress)
{
divSigmaExp -= fvc::laplacian(2*mu + lambda, D, "laplacian(DD,D)");
}
else
{
divSigmaExp -= fvc::div((2*mu + lambda)*fvc::grad(D), "div(sigmaD)");
}
mesh.schemes().setFluxRequired(D.name());
#include "createFvModels.H"
#include "createFvConstraints.H"

View File

@ -1,10 +0,0 @@
{
const dictionary& stressControl =
mesh.solution().dict().subDict("stressAnalysis");
nCorr = stressControl.lookupOrDefault<int>("nCorrectors", 1);
convergenceTolerance = stressControl.lookupOrDefault<scalar>("D", 0);
stressControl.lookup("compactNormalStress") >> compactNormalStress;
accFac = stressControl.lookupOrDefault<scalar>("accelerationFactor", 1);
}

View File

@ -1,33 +0,0 @@
Info<< "Reading thermophysical properties\n" << endl;
solidDisplacementThermo thermo(mesh);
autoPtr<solidThermophysicalTransportModel> thermophysicalTransport;
if (thermo.thermalStress())
{
thermophysicalTransport = solidThermophysicalTransportModel::New(thermo);
}
const volScalarField& E(thermo.E());
const volScalarField& nu(thermo.nu());
Info<< "Calculating Lame's coefficients\n" << endl;
const volScalarField mu(E/(2*(1 + nu)));
const volScalarField lambda
(
thermo.planeStress()
? nu*E/((1 + nu)*(1 - nu))
: nu*E/((1 + nu)*(1 - 2*nu))
);
const volScalarField threeK
(
thermo.planeStress()
? E/(1 - nu)
: E/(1 - 2*nu)
);
const volScalarField threeKalpha("threeKalpha", threeK*thermo.alphav());

View File

@ -1,162 +0,0 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2023 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
solidDisplacementFoam
Description
Transient and steady-state segregated finite-volume solver of
linear-elastic, small-strain deformation of a solid body, with optional
thermal diffusion and thermal stresses.
Simple linear elasticity structural analysis code.
Solves for the displacement vector field D, also generating the
stress tensor field sigma.
\*---------------------------------------------------------------------------*/
#include "fvCFD.H"
#include "solidDisplacementThermo.H"
#include "solidThermophysicalTransportModel.H"
#include "fvModels.H"
#include "fvConstraints.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
int main(int argc, char *argv[])
{
#include "postProcess.H"
#include "setRootCaseLists.H"
#include "createTime.H"
#include "createMesh.H"
#include "createControls.H"
#include "createFields.H"
#include "createFieldRefs.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
Info<< "\nCalculating displacement field\n" << endl;
while (runTime.loop())
{
Info<< "Iteration: " << runTime.value() << nl << endl;
#include "readSolidDisplacementFoamControls.H"
int iCorr = 0;
scalar initialResidual = 0;
do
{
fvModels.correct();
if (thermo.thermalStress())
{
volScalarField& e = thermo.he();
fvScalarMatrix eEqn
(
fvm::ddt(rho, e)
+ thermophysicalTransport->divq(e)
==
fvModels.source(rho, e)
);
eEqn.relax();
fvConstraints.constrain(eEqn);
eEqn.solve();
fvConstraints.constrain(e);
thermo.correct();
}
{
fvVectorMatrix DEqn
(
fvm::d2dt2(rho, D)
==
fvm::laplacian(2*mu + lambda, D, "laplacian(DD,D)")
+ divSigmaExp
+ rho*fvModels.d2dt2(D)
);
if (thermo.thermalStress())
{
DEqn += fvc::grad(threeKalpha*thermo.T());
}
fvConstraints.constrain(DEqn);
initialResidual = DEqn.solve().max().initialResidual();
// For steady-state optionally accelerate the solution
// by over-relaxing the displacement
if (mesh.schemes().steady() && accFac > 1)
{
D += (accFac - 1)*(D - D.oldTime());
}
if (!compactNormalStress)
{
divSigmaExp = fvc::div(DEqn.flux());
}
}
{
volTensorField gradD(fvc::grad(D));
sigmaD = mu*twoSymm(gradD) + (lambda*I)*tr(gradD);
if (compactNormalStress)
{
divSigmaExp = fvc::div
(
sigmaD - (2*mu + lambda)*gradD,
"div(sigmaD)"
);
}
else
{
divSigmaExp += fvc::div(sigmaD);
}
}
} while (initialResidual > convergenceTolerance && ++iCorr < nCorr);
#include "calculateStress.H"
Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s"
<< " ClockTime = " << runTime.elapsedClockTime() << " s"
<< nl << endl;
}
Info<< "End\n" << endl;
return 0;
}
// ************************************************************************* //

46
bin/solidDisplacementFoam Executable file
View File

@ -0,0 +1,46 @@
#!/bin/sh
#------------------------------------------------------------------------------
# ========= |
# \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
# \\ / O peration | Website: https://openfoam.org
# \\ / A nd | Copyright (C) 2023 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/>.
#
# Script
# solidDisplacementFoam
#
# Description
# Script to inform the user that solidDisplacementFoam has been superseded
# and replaced by the more general solidDisplacement solver module
# executed by the foamRun application.
#
#------------------------------------------------------------------------------
cat <<EOF
solidDisplacementFoam has been superseded and replaced by the more general
solidDisplacement solver module executed by the foamRun application:
foamRun -solver solidDisplacement
EOF
exec env foamRun -solver solidDisplacement "$@"
#------------------------------------------------------------------------------

View File

@ -0,0 +1,46 @@
#!/bin/sh
#------------------------------------------------------------------------------
# ========= |
# \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
# \\ / O peration | Website: https://openfoam.org
# \\ / A nd | Copyright (C) 2023 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/>.
#
# Script
# solidEquilibriumDisplacementFoam
#
# Description
# Script to inform the user that solidEquilibriumDisplacementFoam has been
# superseded and replaced by the more general solidDisplacement solver
# module executed by the foamRun application.
#
#------------------------------------------------------------------------------
cat <<EOF
solidEquilibriumDisplacementFoam has been superseded and replaced by the more
general solidDisplacement solver module executed by the foamRun application:
foamRun -solver solidDisplacement
EOF
exec env foamRun -solver solidDisplacement "$@"
#------------------------------------------------------------------------------

View File

@ -3229,31 +3229,6 @@ _snappyHexMesh_ ()
}
complete -o filenames -o nospace -F _snappyHexMesh_ snappyHexMesh
_solidDisplacementFoam_ ()
{
local cur="${COMP_WORDS[COMP_CWORD]}"
local prev="${COMP_WORDS[COMP_CWORD-1]}"
local line=${COMP_LINE}
local used=$(echo "$line" | grep -oE "\-[a-zA-Z]+ ")
opts="-case -doc -fileHandler -help -hostRoots -libs -listFunctionObjects -listFvConstraints -listFvModels -listScalarBCs -listSwitches -listVectorBCs -noFunctionObjects -parallel -postProcess -roots -srcDoc"
for o in $used ; do opts="${opts/$o/}" ; done
extra=""
[ "$COMP_CWORD" = 1 ] || \
case "$prev" in
-case)
opts="" ; extra="-d" ;;
-fileHandler)
opts="uncollated collated masterUncollated" ; extra="" ;;
-hostRoots|-libs|-roots)
opts="" ; extra="" ;;
*) ;;
esac
COMPREPLY=( $(compgen -W "${opts}" $extra -- ${cur}) )
}
complete -o filenames -o nospace -F _solidDisplacementFoam_ solidDisplacementFoam
_splitBaffles_ ()
{
local cur="${COMP_WORDS[COMP_CWORD]}"
@ -5257,6 +5232,56 @@ _simpleFoam_ ()
}
complete -o filenames -o nospace -F _simpleFoam_ simpleFoam
_solidDisplacementFoam_ ()
{
local cur="${COMP_WORDS[COMP_CWORD]}"
local prev="${COMP_WORDS[COMP_CWORD-1]}"
local line=${COMP_LINE}
local used=$(echo "$line" | grep -oE "\-[a-zA-Z]+ ")
opts="-case -doc -fileHandler -help -hostRoots -libs -noFunctionObjects -parallel -roots -solver -srcDoc"
for o in $used ; do opts="${opts/$o/}" ; done
extra=""
[ "$COMP_CWORD" = 1 ] || \
case "$prev" in
-case)
opts="" ; extra="-d" ;;
-fileHandler)
opts="uncollated collated masterUncollated" ; extra="" ;;
-hostRoots|-libs|-roots|-solver)
opts="" ; extra="" ;;
*) ;;
esac
COMPREPLY=( $(compgen -W "${opts}" $extra -- ${cur}) )
}
complete -o filenames -o nospace -F _solidDisplacementFoam_ solidDisplacementFoam
_solidEquilibriumDisplacementFoam_ ()
{
local cur="${COMP_WORDS[COMP_CWORD]}"
local prev="${COMP_WORDS[COMP_CWORD-1]}"
local line=${COMP_LINE}
local used=$(echo "$line" | grep -oE "\-[a-zA-Z]+ ")
opts="-case -doc -fileHandler -help -hostRoots -libs -noFunctionObjects -parallel -roots -solver -srcDoc"
for o in $used ; do opts="${opts/$o/}" ; done
extra=""
[ "$COMP_CWORD" = 1 ] || \
case "$prev" in
-case)
opts="" ; extra="-d" ;;
-fileHandler)
opts="uncollated collated masterUncollated" ; extra="" ;;
-hostRoots|-libs|-roots|-solver)
opts="" ; extra="" ;;
*) ;;
esac
COMPREPLY=( $(compgen -W "${opts}" $extra -- ${cur}) )
}
complete -o filenames -o nospace -F _solidEquilibriumDisplacementFoam_ solidEquilibriumDisplacementFoam
_XiFoam_ ()
{
local cur="${COMP_WORDS[COMP_CWORD]}"

928
tutorials/log Normal file
View File

@ -0,0 +1,928 @@
Copying cases
Modifying the controlDicts to run only one time step
make[1]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/laplacianFoam'
Running ansysToFoam: converting mesh flange.ans
Running laplacianFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/laplacianFoam/flange
Running foamToEnsight on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/laplacianFoam/flange
Running foamToEnsightParts on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/laplacianFoam/flange
Running foamToVTK on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/laplacianFoam/flange
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/laplacianFoam'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/potentialFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/potentialFoam/cylinder
Running potentialFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/potentialFoam/cylinder
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/potentialFoam/cylinder
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/potentialFoam/pitzDaily
Running potentialFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/potentialFoam/pitzDaily
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/potentialFoam/pitzDaily
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/potentialFoam'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/scalarTransportFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/scalarTransportFoam/pitzDaily
Running scalarTransportFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/scalarTransportFoam/pitzDaily
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic/scalarTransportFoam'
make[1]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/basic'
make[1]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/chemFoam'
Running chemkinToFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/chemFoam/gri
Running chemFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/chemFoam/gri
Running chemkinToFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/chemFoam/h2
Running chemFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/chemFoam/h2
Running chemkinToFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/chemFoam/ic8h18
Running chemFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/chemFoam/ic8h18
Running chemkinToFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/chemFoam/ic8h18_TDAC
Running chemFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/chemFoam/ic8h18_TDAC
Running chemkinToFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/chemFoam/nc7h16
Running chemFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/chemFoam/nc7h16
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/chemFoam'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/PDRFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/PDRFoam/flamePropagationWithObstacles
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/PDRFoam/flamePropagationWithObstacles
Running PDRMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/PDRFoam/flamePropagationWithObstacles
Running PDRFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/PDRFoam/flamePropagationWithObstacles
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion/PDRFoam'
make[1]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/combustion'
make[1]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/biconic25-55Run35
Running datToFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/biconic25-55Run35
Running collapseEdges on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/biconic25-55Run35
Changing patch type to wedge type in boundary file
Running rhoCentralFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/biconic25-55Run35
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/forwardStep
Running rhoCentralFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/forwardStep
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/LadenburgJet60psi
Running rhoCentralFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/LadenburgJet60psi
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/movingCone
Running rhoCentralFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/movingCone
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/obliqueShock
Running rhoCentralFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/obliqueShock
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/shockTube
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/shockTube
Running rhoCentralFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/shockTube
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/shockTube
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/wedge15Ma5
Running rhoCentralFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam/wedge15Ma5
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoCentralFoam'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoPorousSimpleFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoPorousSimpleFoam/angledDuctExplicit
Running rhoPorousSimpleFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoPorousSimpleFoam/angledDuctExplicit
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoPorousSimpleFoam/angledDuctImplicit
Running rhoPorousSimpleFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoPorousSimpleFoam/angledDuctImplicit
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible/rhoPorousSimpleFoam'
make[1]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/compressible'
make[1]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/freeSpacePeriodic
Running dsmcInitialise on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/freeSpacePeriodic
Running dsmcFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/freeSpacePeriodic
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/freeSpaceStream
Running dsmcInitialise on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/freeSpaceStream
Running dsmcFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/freeSpaceStream
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/supersonicCorner
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/supersonicCorner
Running dsmcInitialise in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/supersonicCorner using 4 processes
Running dsmcFoam in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/supersonicCorner using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/supersonicCorner
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/wedge15Ma5
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/wedge15Ma5
Running dsmcInitialise in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/wedge15Ma5 using 4 processes
Running dsmcFoam in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/wedge15Ma5 using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam/wedge15Ma5
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/dsmcFoam'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics'
make[3]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdEquilibrationFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdEquilibrationFoam/periodicCubeArgon
Running mdInitialise on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdEquilibrationFoam/periodicCubeArgon
Running mdEquilibrationFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdEquilibrationFoam/periodicCubeArgon
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdEquilibrationFoam/periodicCubeWater
Running mdInitialise on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdEquilibrationFoam/periodicCubeWater
Running mdEquilibrationFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdEquilibrationFoam/periodicCubeWater
make[3]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdEquilibrationFoam'
make[3]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdFoam/nanoNozzle
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdFoam/nanoNozzle
Running mdInitialise in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdFoam/nanoNozzle using 4 processes
Running mdFoam in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdFoam/nanoNozzle using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdFoam/nanoNozzle
make[3]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics/mdFoam'
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods/molecularDynamics'
make[1]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/discreteMethods'
make[1]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/DNS'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/DNS/dnsFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/DNS/dnsFoam/boxTurb16
Running boxTurb on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/DNS/dnsFoam/boxTurb16
Running dnsFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/DNS/dnsFoam/boxTurb16
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/DNS/dnsFoam/boxTurb16
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/DNS/dnsFoam'
make[1]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/DNS'
make[1]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/electromagnetics'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/electromagnetics/electrostaticFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/electromagnetics/electrostaticFoam/chargedWire
Running electrostaticFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/electromagnetics/electrostaticFoam/chargedWire
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/electromagnetics/electrostaticFoam'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/electromagnetics/mhdFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/electromagnetics/mhdFoam/hartmann
Running mhdFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/electromagnetics/mhdFoam/hartmann
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/electromagnetics/mhdFoam/hartmann
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/electromagnetics/mhdFoam'
make[1]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/electromagnetics'
make[1]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/financial'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/financial/financialFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/financial/financialFoam/europeanCall
Running financialFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/financial/financialFoam/europeanCall
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/financial/financialFoam'
make[1]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/financial'
make[1]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/adjointShapeOptimisationFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/adjointShapeOptimisationFoam/pitzDaily
Running adjointShapeOptimisationFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/adjointShapeOptimisationFoam/pitzDaily
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/adjointShapeOptimisationFoam'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryLaunderSharma
Running boundaryFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryLaunderSharma
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryNonNewtonian
Running boundaryFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryNonNewtonian
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctions
Running boundaryFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctions
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Setting nu to 1e-2
Running boundaryFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Running foamLog on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Setting nu to 1e-3
Running boundaryFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Running foamLog on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Setting nu to 1e-4
Running boundaryFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Running foamLog on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Setting nu to 1e-5
Running boundaryFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Running foamLog on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Setting nu to 1e-6
Running boundaryFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Running foamLog on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Setting nu to 1e-7
Running boundaryFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Running foamLog on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Setting nu to 1e-8
Running boundaryFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Running foamLog on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam/boundaryWallFunctionsProfile
Creating graph of u+ vs y+ to OF_vs_ANALYTICAL.eps
Done
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/boundaryFoam'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/cavity/cavity
Running icoFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/cavity/cavity
Cloning cavityFine case from cavity
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/cavity/cavityFine
Running mapFields from cavity to cavityFine
Running icoFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/cavity/cavityFine
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/cavity/cavityGrade
Running mapFields from cavityFine to cavityGrade
Running icoFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/cavity/cavityGrade
Cloning cavityHighRe case from cavity
Setting cavityHighRe to generate a secondary vortex
Copying cavity/0* directory to cavityHighRe
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/cavity/cavityHighRe
Running icoFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/cavity/cavityHighRe
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/cavity/cavityClipped
Running mapFields from cavity to cavityClipped
Running icoFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/cavity/cavityClipped
Running fluentMeshToFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/elbow
Running icoFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/elbow
Running foamMeshToFluent on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/elbow
Running foamDataToFluent on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam/elbow
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/icoFoam'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/porousSimpleFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/porousSimpleFoam/angledDuctExplicit
Running porousSimpleFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/porousSimpleFoam/angledDuctExplicit
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/porousSimpleFoam/angledDuctImplicit
Running porousSimpleFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/porousSimpleFoam/angledDuctImplicit
Running surfaceFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/porousSimpleFoam/straightDuctImplicit
Running foamyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/porousSimpleFoam/straightDuctImplicit
/home/dm2/henry/OpenFOAM/OpenFOAM-dev/bin/tools/RunFunctions: line 58: 401 Floating point exception(core dumped) $APP_RUN "$@" > log.$LOG_SUFFIX 2>&1
Running collapseEdges on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/porousSimpleFoam/straightDuctImplicit
Running collapseEdges on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/porousSimpleFoam/straightDuctImplicit
Running checkMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/porousSimpleFoam/straightDuctImplicit
mv: cannot stat '/polyMesh': No such file or directory
rm: cannot remove '[1-9]*': No such file or directory
Running porousSimpleFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/porousSimpleFoam/straightDuctImplicit
make[2]: *** [/home/dm2/henry/OpenFOAM/OpenFOAM-dev/bin/tools/MakefileDirs:39: straightDuctImplicit] Error 1
make[2]: Target 'application' not remade because of errors.
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/porousSimpleFoam'
make[1]: *** [/home/dm2/henry/OpenFOAM/OpenFOAM-dev/bin/tools/MakefileDirs:39: porousSimpleFoam] Error 2
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/shallowWaterFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/shallowWaterFoam/squareBump
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/shallowWaterFoam/squareBump
Running shallowWaterFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/shallowWaterFoam/squareBump
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible/shallowWaterFoam'
make[1]: Target 'application' not remade because of errors.
make[1]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/incompressible'
make: *** [/home/dm2/henry/OpenFOAM/OpenFOAM-dev/bin/tools/MakefileDirs:39: incompressible] Error 2
make[1]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/column
Running denseParticleFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/column
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/cyclone
Running snappyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/cyclone
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/cyclone
Running denseParticleFoam in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/cyclone using 12 processes
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/Goldschmidt
Running denseParticleFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/Goldschmidt
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/GoldschmidtMPPIC
Running denseParticleFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/GoldschmidtMPPIC
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/injectionChannel
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/injectionChannel
Running denseParticleFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam/injectionChannel
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/denseParticleFoam'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/hopper/hopperInitialState
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/hopper/hopperInitialState
Running particleFoam in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/hopper/hopperInitialState using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/hopper/hopperInitialState
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/hopper/hopperEmptying
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/hopper/hopperEmptying
Running mapFieldsPar in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/hopper/hopperEmptying using 4 processes
Running particleFoam in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/hopper/hopperEmptying using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/hopper/hopperEmptying
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/mixerVessel2D
Running createBaffles on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/mixerVessel2D
Running splitBaffles on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/mixerVessel2D
Running createNonConformalCouples on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/mixerVessel2D
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/mixerVessel2D
Running particleFoam in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/mixerVessel2D using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam/mixerVessel2D
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian/particleFoam'
make[1]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/lagrangian'
make[1]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/blockMesh'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/blockMesh/pipe
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/blockMesh/sphere
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/blockMesh/sphere7
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/blockMesh/sphere7ProjectedEdges
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/blockMesh'
Running foamyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/blob
/home/dm2/henry/OpenFOAM/OpenFOAM-dev/bin/tools/RunFunctions: line 58: 987 Floating point exception(core dumped) $APP_RUN "$@" > log.$LOG_SUFFIX 2>&1
Running collapseEdges on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/blob
Running collapseEdges on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/blob
Running checkMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/blob
Running foamyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/flange
/home/dm2/henry/OpenFOAM/OpenFOAM-dev/bin/tools/RunFunctions: line 58: 1020 Floating point exception(core dumped) $APP_RUN "$@" > log.$LOG_SUFFIX 2>&1
Running collapseEdges on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/flange
Running collapseEdges on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/flange
Running checkMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/flange
Running surfaceOrient on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/simpleShapes
Running surfaceOrient on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/simpleShapes
Running surfaceBooleanFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/simpleShapes
Running foamyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/simpleShapes
/home/dm2/henry/OpenFOAM/OpenFOAM-dev/bin/tools/RunFunctions: line 58: 1057 Floating point exception(core dumped) $APP_RUN "$@" > log.$LOG_SUFFIX 2>&1
Running collapseEdges on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/simpleShapes
Running collapseEdges on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyHexMesh/simpleShapes
Running surfaceFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyQuadMesh/jaggedBoundary
Running foamyQuadMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyQuadMesh/jaggedBoundary
Running extrude2DMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyQuadMesh/jaggedBoundary
Running checkMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyQuadMesh/jaggedBoundary
Running surfaceFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyQuadMesh/square
Running foamyQuadMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyQuadMesh/square
Running extrude2DMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyQuadMesh/square
Running checkMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/foamyQuadMesh/square
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/moveDynamicMesh'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/moveDynamicMesh/SnakeRiverCanyon
Running moveMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/moveDynamicMesh/SnakeRiverCanyon
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/moveDynamicMesh'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh'
wmake calcRadiusField
make[3]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs/calcRadiusField'
Making dependency list for source file calcRadiusField.C
g++ -std=c++14 -m64 -DLIB_NAME=libNULL.so -Dlinux64 -DWM_ARCH_OPTION=64 -DWM_DP -DWM_LABEL_SIZE=32 -Wall -Wextra -Wold-style-cast -Wnon-virtual-dtor -Wno-unused-parameter -Wno-invalid-offsetof -Wno-attributes -O3 -DNoRepository -ftemplate-depth-100 -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/finiteVolume/lnInclude -IlnInclude -I. -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/OpenFOAM/lnInclude -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/OSspecific/POSIX/lnInclude -fPIC -c calcRadiusField.C -o /home/dm2/henry/OpenFOAM/OpenFOAM-dev/platforms/linux64GccDPInt32Opt/tutorialsTest/mesh/refineMesh/refineFieldDirs/calcRadiusField/calcRadiusField.o
g++ -std=c++14 -m64 -DLIB_NAME=libNULL.so -Dlinux64 -DWM_ARCH_OPTION=64 -DWM_DP -DWM_LABEL_SIZE=32 -Wall -Wextra -Wold-style-cast -Wnon-virtual-dtor -Wno-unused-parameter -Wno-invalid-offsetof -Wno-attributes -O3 -DNoRepository -ftemplate-depth-100 -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/finiteVolume/lnInclude -IlnInclude -I. -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/OpenFOAM/lnInclude -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/OSspecific/POSIX/lnInclude -fPIC -fuse-ld=bfd -Xlinker --add-needed -Xlinker --no-as-needed /home/dm2/henry/OpenFOAM/OpenFOAM-dev/platforms/linux64GccDPInt32Opt/tutorialsTest/mesh/refineMesh/refineFieldDirs/calcRadiusField/calcRadiusField.o -L/home/dm2/henry/OpenFOAM/OpenFOAM-dev/platforms/linux64GccDPInt32Opt/lib \
-lfiniteVolume -lOpenFOAM -ldl \
-lm -o /home/dm2/henry/OpenFOAM/henry-dev/platforms/linux64GccDPInt32Opt/bin/calcRadiusField
make[3]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs/calcRadiusField'
wclean calcRadiusField
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running calcRadiusField on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running calcRadiusField on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running calcRadiusField on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running calcRadiusField on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running calcRadiusField on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running calcRadiusField on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running calcRadiusField on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running calcRadiusField on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running calcRadiusField on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh/refineFieldDirs
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/refineMesh'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/snappyHexMesh/flange
Running surfaceFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/snappyHexMesh/flange
Running snappyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh/snappyHexMesh/flange
make[1]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/mesh'
make[1]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/circuitBoardCooling
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/circuitBoardCooling
Running extrudeToRegionMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/circuitBoardCooling
Running createBaffles on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/circuitBoardCooling
Running foamMultiRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/circuitBoardCooling
Created 'circuitBoardCooling.OpenFOAM'
Created 'circuitBoardCooling{baffle3D}.OpenFOAM'
Created 'circuitBoardCooling{fluid}.OpenFOAM'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/coolingCylinder2D
Running splitMeshRegions on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/coolingCylinder2D
Created 'coolingCylinder2D{fluid}.OpenFOAM'
Created 'coolingCylinder2D{solid}.OpenFOAM'
Running foamMultiRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/coolingCylinder2D
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/coolingSphere
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/coolingSphere
Running transformPoints on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/coolingSphere
Running splitMeshRegions on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/coolingSphere
Running foamSetupCHT on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/coolingSphere
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/coolingSphere
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/coolingSphere
Creating files for paraview post-processing
Created 'coolingSphere.blockMesh'
Created 'coolingSphere.OpenFOAM'
Created 'coolingSphere{fluid}.OpenFOAM'
Created 'coolingSphere{solid}.OpenFOAM'
Running foamMultiRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/coolingSphere using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/coolingSphere
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/heatedDuct
Running snappyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/heatedDuct
Running splitMeshRegions on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/heatedDuct
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/heatedDuct
Running foamMultiRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/heatedDuct using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/heatedDuct
Created 'heatedDuct.blockMesh'
Created 'heatedDuct.OpenFOAM'
Created 'heatedDuct{fluid}.OpenFOAM'
Created 'heatedDuct{heater}.OpenFOAM'
Created 'heatedDuct{metal}.OpenFOAM'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/heatExchanger
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/heatExchanger
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/heatExchanger
Running createBaffles on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/heatExchanger
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/heatExchanger
Created 'heatExchanger{porous}.OpenFOAM'
Created 'heatExchanger{air}.OpenFOAM'
Running foamMultiRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/heatExchanger
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/multiphaseCoolingCylinder2D
Running splitMeshRegions on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/multiphaseCoolingCylinder2D
Created 'multiphaseCoolingCylinder2D{fluid}.OpenFOAM'
Created 'multiphaseCoolingCylinder2D{solid}.OpenFOAM'
Running foamMultiRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/multiphaseCoolingCylinder2D
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/reverseBurner
Running splitMeshRegions on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/reverseBurner
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/reverseBurner
Created 'reverseBurner{gas}.OpenFOAM'
Created 'reverseBurner{solid}.OpenFOAM'
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/reverseBurner
Running setFields in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/reverseBurner using 4 processes
Running foamMultiRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/reverseBurner using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/reverseBurner
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger
Running snappyHexMesh in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger using 8 processes
Running createBaffles in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger using 8 processes
Running splitBaffles in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger using 8 processes
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger
Running snappyHexMesh in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger using 8 processes
Running splitMeshRegions in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger using 8 processes
Running foamMultiRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger using 8 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/shellAndTubeHeatExchanger
Created 'shellAndTubeHeatExchanger.blockMesh'
Created 'shellAndTubeHeatExchanger.OpenFOAM'
Created 'shellAndTubeHeatExchanger{shell}.OpenFOAM'
Created 'shellAndTubeHeatExchanger{solid}.OpenFOAM'
Created 'shellAndTubeHeatExchanger{tube}.OpenFOAM'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/VoFcoolingCylinder2D
Running splitMeshRegions on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/VoFcoolingCylinder2D
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/VoFcoolingCylinder2D
Created 'VoFcoolingCylinder2D{fluid}.OpenFOAM'
Created 'VoFcoolingCylinder2D{solid}.OpenFOAM'
Running foamMultiRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/VoFcoolingCylinder2D
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/wallBoiling
Running extrudeMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/wallBoiling
Running splitMeshRegions on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/wallBoiling
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/wallBoiling
Created 'wallBoiling{fluid}.OpenFOAM'
Created 'wallBoiling{solid}.OpenFOAM'
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/wallBoiling
Running foamMultiRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/wallBoiling using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/wallBoiling
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/wallBoiling
line 0: warning: Skipping data file with no valid points
line 0: warning: Skipping data file with no valid points
line 0: warning: Skipping data file with no valid points
line 0: warning: Skipping data file with no valid points
line 0: warning: Skipping data file with no valid points
line 0: warning: Skipping data file with no valid points
line 0: warning: Skipping data file with no valid points
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT/wallBoiling
Warning: empty x range [0.159769:0.159769], adjusting to [0.158171:0.161366]
Warning: empty x range [441.622:441.622], adjusting to [437.206:446.038]
Warning: empty x range [0:0], adjusting to [-1:1]
Warning: empty x range [1:1], adjusting to [0.99:1.01]
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/CHT'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/ballValve
Running createNonConformalCouples on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/ballValve
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/ballValve
Running potentialFoam in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/ballValve using 4 processes
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/ballValve using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/ballValve
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/climbingRod
Running extrudeMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/climbingRod
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/climbingRod
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/climbingRod
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/cylinder
Running extrudeToRegionMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/cylinder
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/cylinder
Created 'cylinder.OpenFOAM'
Created 'cylinder{wallFilm}.OpenFOAM'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/damBreak
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/damBreak
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/damBreak
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/depthCharge2D
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/depthCharge2D
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/depthCharge2D
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/depthCharge3D
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/depthCharge3D
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/depthCharge3D
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/depthCharge3D using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/depthCharge3D
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/plateFilm
Running extrudeToRegionMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/plateFilm
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/plateFilm
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/plateFilm
Created 'plateFilm.OpenFOAM'
Created 'plateFilm{plate}.OpenFOAM'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/sloshingTank2D
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/sloshingTank2D
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF/sloshingTank2D
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/compressibleVoF'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/aerofoilNACA0012
Running transformPoints on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/aerofoilNACA0012
Running extrudeMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/aerofoilNACA0012
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/aerofoilNACA0012
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/aerofoilNACA0012Steady
Running transformPoints on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/aerofoilNACA0012Steady
Running extrudeMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/aerofoilNACA0012Steady
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/aerofoilNACA0012Steady
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/angledDuct
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/angledDuct
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/angledDuctExplicitFixedCoeff
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/angledDuctExplicitFixedCoeff
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/angledDuctLTS
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/angledDuctLTS
Running surfaceFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/annularThermalMixer
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/annularThermalMixer
Running snappyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/annularThermalMixer
Running createBaffles on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/annularThermalMixer
Running splitBaffles on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/annularThermalMixer
Running createNonConformalCouples on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/annularThermalMixer
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/annularThermalMixer
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/BernardCells
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/BernardCells
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/blockedChannel
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/blockedChannel
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/blockedChannel
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/buoyantCavity
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/buoyantCavity
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/buoyantCavity
Running validation/createGraphs on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/buoyantCavity
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/cavity
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/cavity
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/decompressionTank/decompressionTank
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/decompressionTank/decompressionTank
Cloning decompressionTankFine case from decompressionTank
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/decompressionTank/decompressionTankFine
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/decompressionTank/decompressionTankFine
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/externalCoupledCavity
Running createExternalCoupledPatchGeometry on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/externalCoupledCavity
Executing dummy external solver
External: initialisation: creating comms/data.in
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/externalCoupledCavity
External: found lock file comms/OpenFOAM.lock - waiting
External: step 1
External: lock not present - taking control
External: sleeping for 1 secs to simulate external process
External: creating comms/data.in
External: creating lock file comms/OpenFOAM.lock
External: found lock file comms/OpenFOAM.lock - waiting
External: found lock file comms/OpenFOAM.lock - waiting
External: step 2
External: lock not present - taking control
External: sleeping for 1 secs to simulate external process
External: creating comms/data.in
awk: fatal: cannot open file `comms/data.out' for reading: No such file or directory
External: creating lock file comms/OpenFOAM.lock
External: found lock file comms/OpenFOAM.lock - waiting
External: found lock file comms/OpenFOAM.lock - waiting
External: found lock file comms/OpenFOAM.lock - waiting
External: found lock file comms/OpenFOAM.lock - waiting
External: found lock file comms/OpenFOAM.lock - waiting
External: found lock file comms/OpenFOAM.lock - waiting
External: found lock file comms/OpenFOAM.lock - waiting
External: found lock file comms/OpenFOAM.lock - waiting
External: found lock file comms/OpenFOAM.lock - waiting
External: found lock file comms/OpenFOAM.lock - waiting
External: found lock file comms/OpenFOAM.lock - waiting
External: timeout
External: done
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/forwardStep
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/forwardStep
Cloning resolved case from .
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/helmholtzResonance/resolved
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/helmholtzResonance/resolved
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/helmholtzResonance/resolved using 4 processes
Cloning modelled case from .
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/helmholtzResonance/modelled
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/helmholtzResonance/modelled
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/helmholtzResonance/modelled using 4 processes
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRadiationRoom
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRadiationRoom
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRadiationRoomFvDOM
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRadiationRoomFvDOM
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoom
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoom
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoom
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoomBoussinesq
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoomBoussinesq
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoomBoussinesq
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoomBoussinesqSteady
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoomBoussinesqSteady
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoomBoussinesqSteady
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoomComfort
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoomComfort
Running createPatch on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoomComfort
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/hotRoomComfort
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/iglooWithFridges
Running snappyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/iglooWithFridges
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/iglooWithFridges
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/mixerVessel2DMRF
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/mixerVessel2DMRF
Running star3ToFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/nacaAirfoil
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/nacaAirfoil
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/pitzDaily
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/pitzDaily
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/prism
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/prism
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/shockTube
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/shockTube
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/shockTube
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/shockTube
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/squareBend
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/squareBend
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/squareBendLiq
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/squareBendLiq
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/squareBendLiqSteady
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid/squareBendLiqSteady
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/fluid'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid'
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/airFoil2D
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/ballValve
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/ballValve
Running transformPoints on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/ballValve
Running createNonConformalCouples on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/ballValve
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/ballValve
Running setFields in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/ballValve using 8 processes
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/ballValve using 8 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/ballValve
Warning: empty y range [0.000446505:0.000446505], adjusting to [0.00044204:0.00045097]
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/blockedChannel
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/blockedChannel
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/blockedChannel
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/cavity
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/cavity
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/cavityCoupledU
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/cavityCoupledU
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/channel395
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/channel395
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/channel395 using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/channel395
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/drivaerFastback
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/drivaerFastback
Refining the background mesh
Running refineMesh in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/drivaerFastback using 8 processes
Running snappyHexMesh in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/drivaerFastback using 8 processes
Running checkMesh in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/drivaerFastback using 8 processes
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/drivaerFastback using 8 processes
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/ductSecondaryFlow
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/ductSecondaryFlow
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/elipsekkLOmega
Running transformPoints on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/elipsekkLOmega
Running mirrorMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/elipsekkLOmega
Running mirrorMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/elipsekkLOmega
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/elipsekkLOmega
Running createPatch on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/elipsekkLOmega
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/elipsekkLOmega
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/flowWithOpenBoundary
Running extrudeMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/flowWithOpenBoundary
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/flowWithOpenBoundary
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/impeller
Running createNonConformalCouples on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/impeller
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/impeller
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/mixerSRF
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/mixerSRF
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/mixerVessel2DMRF
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/mixerVessel2DMRF
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBike/motorBike
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBike/motorBike
Running snappyHexMesh in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBike/motorBike using 8 processes
Running renumberMesh in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBike/motorBike using 8 processes
Running potentialFoam in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBike/motorBike using 8 processes
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBike/motorBike using 8 processes
Running surfaceFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBikeSteady
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBikeSteady
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBikeSteady
Running snappyHexMesh in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBikeSteady using 6 processes
Running patchSummary in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBikeSteady using 6 processes
Running potentialFoam in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBikeSteady using 6 processes
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBikeSteady using 6 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/motorBikeSteady
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/movingCone
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/movingCone
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/movingCone
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/movingCone
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/offsetCylinder
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/offsetCylinder
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/oscillatingInlet
Running createNonConformalCouples on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/oscillatingInlet
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/oscillatingInlet
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pipeCyclic
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pipeCyclic
Running refineHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pipeCyclic
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pipeCyclic
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pipeCyclic using 5 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pipeCyclic
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDaily
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDaily
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDailyLES
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDailyLES
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDailyLTS
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDailyLTS
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDailyMapped
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDailyMapped
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDailyPulse
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDailyPulse
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDailySteady
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDailySteady
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDailySteadyExptInlet
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/pitzDailySteadyExptInlet
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/planarContraction
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/planarContraction
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/planarCouette
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/planarCouette
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/planarPoiseuille
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/planarPoiseuille
wmake validation/WatersKing
make[3]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/planarPoiseuille/validation/WatersKing'
Making dependency list for source file WatersKing.C
g++ -std=c++14 -m64 -DLIB_NAME=libNULL.so -Dlinux64 -DWM_ARCH_OPTION=64 -DWM_DP -DWM_LABEL_SIZE=32 -Wall -Wextra -Wold-style-cast -Wnon-virtual-dtor -Wno-unused-parameter -Wno-invalid-offsetof -Wno-attributes -O3 -DNoRepository -ftemplate-depth-100 -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/MomentumTransportModels/momentumTransportModels/lnInclude -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/MomentumTransportModels/incompressible/lnInclude -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/physicalProperties/lnInclude -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/finiteVolume/lnInclude -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/meshTools/lnInclude -IlnInclude -I. -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/OpenFOAM/lnInclude -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/OSspecific/POSIX/lnInclude -fPIC -c WatersKing.C -o /home/dm2/henry/OpenFOAM/OpenFOAM-dev/platforms/linux64GccDPInt32Opt/tutorialsTest/modules/incompressibleFluid/planarPoiseuille/validation/WatersKing/WatersKing.o
g++ -std=c++14 -m64 -DLIB_NAME=libNULL.so -Dlinux64 -DWM_ARCH_OPTION=64 -DWM_DP -DWM_LABEL_SIZE=32 -Wall -Wextra -Wold-style-cast -Wnon-virtual-dtor -Wno-unused-parameter -Wno-invalid-offsetof -Wno-attributes -O3 -DNoRepository -ftemplate-depth-100 -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/MomentumTransportModels/momentumTransportModels/lnInclude -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/MomentumTransportModels/incompressible/lnInclude -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/physicalProperties/lnInclude -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/finiteVolume/lnInclude -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/meshTools/lnInclude -IlnInclude -I. -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/OpenFOAM/lnInclude -I/home/dm2/henry/OpenFOAM/OpenFOAM-dev/src/OSspecific/POSIX/lnInclude -fPIC -fuse-ld=bfd -Xlinker --add-needed -Xlinker --no-as-needed /home/dm2/henry/OpenFOAM/OpenFOAM-dev/platforms/linux64GccDPInt32Opt/tutorialsTest/modules/incompressibleFluid/planarPoiseuille/validation/WatersKing/WatersKing.o -L/home/dm2/henry/OpenFOAM/OpenFOAM-dev/platforms/linux64GccDPInt32Opt/lib \
-lmomentumTransportModels -lincompressibleMomentumTransportModels -lphysicalProperties -lfiniteVolume -lmeshTools -lOpenFOAM -ldl \
-lm -o /home/dm2/henry/OpenFOAM/henry-dev/platforms/linux64GccDPInt32Opt/bin/WatersKing
make[3]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/planarPoiseuille/validation/WatersKing'
Running WatersKing on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/planarPoiseuille
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/porousBlockage
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/porousBlockage
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/porousBlockage
Mesh ../../../../multiphase/interFoam/RAS/propeller/constant/polyMesh does not exist
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/propeller
Running surfaceFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/propeller
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/propeller
Running snappyHexMesh in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/propeller using 8 processes
Running createBaffles in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/propeller using 8 processes
Running splitBaffles in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/propeller using 8 processes
Running renumberMesh in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/propeller using 8 processes
Running createNonConformalCouples in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/propeller using 8 processes
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/propeller
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/propeller using 8 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/propeller
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/roomResidenceTime
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/roomResidenceTime
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/roomResidenceTime
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/roomResidenceTime
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/roomResidenceTime
Running foamPostProcess on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/roomResidenceTime
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/rotor2DRotating
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/rotor2DRotating
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/rotor2DSRF
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/rotor2DSRF
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/rotorDisk
Running surfaceFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/rotorDisk
Running snappyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/rotorDisk
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/rotorDisk
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/T3A
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/T3A
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/TJunction
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/TJunction
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/TJunction
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/TJunctionFan
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/TJunctionFan
Running createBaffles on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/TJunctionFan
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/TJunctionFan
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/turbineSiting
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/turbineSiting
Running snappyHexMesh in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/turbineSiting using 4 processes
Running topoSet in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/turbineSiting using 4 processes
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/turbineSiting using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/turbineSiting
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/waveSubSurface
Running setWaves on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/waveSubSurface
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/waveSubSurface
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/waveSubSurface using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/waveSubSurface
Running surfaceFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/windAroundBuildings
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/windAroundBuildings
Running snappyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/windAroundBuildings
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/windAroundBuildings
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/wingMotion/wingMotion_snappyHexMesh
Running snappyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/wingMotion/wingMotion_snappyHexMesh
Running extrudeMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/wingMotion/wingMotion2D_steady
Running createPatch on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/wingMotion/wingMotion2D_steady
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/wingMotion/wingMotion2D_steady
Running mapFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/wingMotion/wingMotion2D_transient
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/wingMotion/wingMotion2D_transient
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/wingMotion/wingMotion2D_transient using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid/wingMotion/wingMotion2D_transient
make[2]: Leaving directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleFluid'
make[2]: Entering directory '/home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF'
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/angledDuct
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/angledDuct
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/capillaryRise
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/capillaryRise
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/capillaryRise
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/cavitatingBullet
Running snappyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/cavitatingBullet
Running potentialFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/cavitatingBullet
Running interFoam on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/cavitatingBullet
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/climbingRod
Running extrudeMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/climbingRod
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/climbingRod
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/climbingRod
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/containerDischarge2D
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/containerDischarge2D
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/containerDischarge2D
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreak/damBreak
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreak/damBreak
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreak/damBreak
Cloning damBreakFine case from damBreak
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreak/damBreakFine
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreak/damBreakFine
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreak/damBreakFine
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreak/damBreakFine using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreak/damBreakFine
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakLaminar/damBreak
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakLaminar/damBreak
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakLaminar/damBreak
Cloning damBreakFine case from damBreak
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakLaminar/damBreakFine
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakLaminar/damBreakFine
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakLaminar/damBreakFine
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakLaminar/damBreakFine using 4 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakLaminar/damBreakFine
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakPorousBaffle
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakPorousBaffle
Running createBaffles on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakPorousBaffle
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakPorousBaffle
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakWithObstacle
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakWithObstacle
Running subsetMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakWithObstacle
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakWithObstacle
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/damBreakWithObstacle
Mesh ../DTCHullMoving/constant/polyMesh does not exist
Mesh ../DTCHullWave/constant/polyMesh does not exist
Running surfaceFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running snappyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running renumberMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull using 8 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHull
Cloning ./constant/polyMesh mesh from ../DTCHull/constant/polyMesh
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHullMoving
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHullMoving
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHullMoving using 8 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHullMoving
Cloning ./constant/polyMesh mesh from ../DTCHull/constant/polyMesh
Running setWaves on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHullWave
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHullWave
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHullWave using 8 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/DTCHullWave
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/floatingObject
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/floatingObject
Running subsetMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/floatingObject
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/floatingObject
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/floatingObject
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running extrudeMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave using 6 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/forcedUpstreamWave
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel
Running surfaceFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel
Running snappyHexMesh in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel using 8 processes
Running createBaffles in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel using 8 processes
Running splitBaffles in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel using 8 processes
Running createNonConformalCouples in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel using 8 processes
Running decomposePar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel
Running setFields in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel using 8 processes
Running foamRun in parallel on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel using 8 processes
Running reconstructPar on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel2D
Running createBaffles on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel2D
Running splitBaffles on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel2D
Running createNonConformalCouples on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel2D
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel2D
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel2D
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel2DMRF
Running setFields on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel2DMRF
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/mixerVessel2DMRF
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/nozzleFlow2D
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/nozzleFlow2D
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/nozzleFlow2D
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/nozzleFlow2D
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/nozzleFlow2D
Running foamRun on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/nozzleFlow2D
Running surfaceTransformPoints on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running surfaceFeatures on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running blockMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running foamDictionary on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running topoSet on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running refineMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3
Running snappyHexMesh on /home/dm2/henry/OpenFOAM/OpenFOAM-dev/tutorialsTest/modules/incompressibleVoF/planingHullW3

View File

@ -14,7 +14,9 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
application solidDisplacementFoam;
application foamRun;
solver solidDisplacement;
startFrom startTime;

View File

@ -28,7 +28,7 @@ solvers
}
}
stressAnalysis
PIMPLE
{
compactNormalStress no;
accelerationFactor 1.9; // Lower for higher Poisson ratio

View File

@ -14,7 +14,9 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
application solidDisplacementFoam;
application foamRun;
solver solidDisplacement;
startFrom startTime;

View File

@ -26,11 +26,9 @@ solvers
}
}
stressAnalysis
PIMPLE
{
compactNormalStress yes;
nCorrectors 1;
D 1e-06;
}

View File

@ -1,9 +0,0 @@
#!/bin/sh
cd ${0%/*} || exit 1 # Run from this directory
# Source tutorial clean functions
. $WM_PROJECT_DIR/bin/tools/CleanFunctions
cleanCase
#------------------------------------------------------------------------------