Removing trailing whitespace, tabs and DOS CR & Fixing some indentation

This commit is contained in:
Henrik Rusche 2016-06-20 16:50:07 +02:00
parent d838b666f6
commit a224c64812
110 changed files with 1957 additions and 2039 deletions

View file

@ -58,6 +58,3 @@ Features
git commit: "add branch ReadMe file" git commit: "add branch ReadMe file"
--> added this file --> added this file

View file

@ -113,14 +113,14 @@ void Foam::fluidSolidInterface::calcFluidToSolidInterpolator() const
} }
std::shared_ptr<RBFFunctionInterface> rbfFunction; std::shared_ptr<RBFFunctionInterface> rbfFunction;
rbfFunction = std::shared_ptr<RBFFunctionInterface>( new TPSFunction() ); rbfFunction = std::shared_ptr<RBFFunctionInterface>(new TPSFunction());
// std::shared_ptr<RBFInterpolation> rbf; // std::shared_ptr<RBFInterpolation> rbf;
fluidToSolidPtr_ = fluidToSolidPtr_ =
std::shared_ptr<RBFInterpolation> std::shared_ptr<RBFInterpolation>
( (
new RBFInterpolation( rbfFunction ) new RBFInterpolation(rbfFunction)
// new RBFInterpolation( rbfFunctionPtr_ ) // new RBFInterpolation(rbfFunctionPtr_)
); );
vectorField solidZoneFaceCentres = vectorField solidZoneFaceCentres =
@ -146,7 +146,7 @@ void Foam::fluidSolidInterface::calcFluidToSolidInterpolator() const
solidX(faceI, 2) = solidZoneFaceCentres[faceI].z(); solidX(faceI, 2) = solidZoneFaceCentres[faceI].z();
} }
fluidToSolidPtr_->compute( fluidX, solidX ); fluidToSolidPtr_->compute(fluidX, solidX);
Info << "Checking fluid-to-solid interpolator" << endl; Info << "Checking fluid-to-solid interpolator" << endl;
{ {
@ -204,8 +204,8 @@ void Foam::fluidSolidInterface::calcFluidToSolidInterpolator() const
// solidX(faceI, 2) = solidPatchFaceCentres[faceI].z(); // solidX(faceI, 2) = solidPatchFaceCentres[faceI].z();
// } // }
// fluidToSolidPtr_->compute( fluidX, solidX ); // fluidToSolidPtr_->compute(fluidX, solidX);
fluidToSolidPtr_->interpolate( fluidX, fluidXsolid ); fluidToSolidPtr_->interpolate(fluidX, fluidXsolid);
vectorField fluidPatchFaceCentresAtSolid vectorField fluidPatchFaceCentresAtSolid
( (
@ -515,14 +515,14 @@ void Foam::fluidSolidInterface::calcSolidToFluidInterpolator() const
} }
std::shared_ptr<RBFFunctionInterface> rbfFunction; std::shared_ptr<RBFFunctionInterface> rbfFunction;
rbfFunction = std::shared_ptr<RBFFunctionInterface>( new TPSFunction() ); rbfFunction = std::shared_ptr<RBFFunctionInterface>(new TPSFunction());
// std::shared_ptr<RBFInterpolation> rbf; // std::shared_ptr<RBFInterpolation> rbf;
solidToFluidPtr_ = solidToFluidPtr_ =
std::shared_ptr<RBFInterpolation> std::shared_ptr<RBFInterpolation>
( (
new RBFInterpolation( rbfFunction ) new RBFInterpolation(rbfFunction)
// new RBFInterpolation( rbfFunctionPtr_ ) // new RBFInterpolation(rbfFunctionPtr_)
); );
vectorField solidZonePoints = vectorField solidZonePoints =
@ -548,7 +548,7 @@ void Foam::fluidSolidInterface::calcSolidToFluidInterpolator() const
solidX(faceI, 2) = solidZonePoints[faceI].z(); solidX(faceI, 2) = solidZonePoints[faceI].z();
} }
solidToFluidPtr_->compute( solidX, fluidX ); solidToFluidPtr_->compute(solidX, fluidX);
Info << "Checking solid-to-fluid interpolator" << endl; Info << "Checking solid-to-fluid interpolator" << endl;
{ {
@ -564,7 +564,7 @@ void Foam::fluidSolidInterface::calcSolidToFluidInterpolator() const
solidPoints(faceI, 2) = solidZonePoints[faceI].z(); solidPoints(faceI, 2) = solidZonePoints[faceI].z();
} }
solidToFluidPtr_->interpolate( solidPoints, fluidPoints ); solidToFluidPtr_->interpolate(solidPoints, fluidPoints);
forAll(fluidZonePoints, faceI) forAll(fluidZonePoints, faceI)
{ {
@ -2036,7 +2036,7 @@ void Foam::fluidSolidInterface::updateForce()
fluidForce(faceI, 2) = fluidZoneTotalTraction[faceI].z(); fluidForce(faceI, 2) = fluidZoneTotalTraction[faceI].z();
} }
fluidToSolid()->interpolate( fluidForce, solidForce ); fluidToSolid()->interpolate(fluidForce, solidForce);
forAll(solidZoneTotalTraction, faceI) forAll(solidZoneTotalTraction, faceI)
{ {
@ -2733,7 +2733,7 @@ Foam::scalar Foam::fluidSolidInterface::updateResidual()
solidDispl(pointI, 2) = solidZonePointsDisplAtSolid[pointI].z(); solidDispl(pointI, 2) = solidZonePointsDisplAtSolid[pointI].z();
} }
solidToFluid()->interpolate( solidDispl, fluidDispl ); solidToFluid()->interpolate(solidDispl, fluidDispl);
forAll(solidZonePointsDispl(), pointI) forAll(solidZonePointsDispl(), pointI)
{ {
@ -2750,7 +2750,7 @@ Foam::scalar Foam::fluidSolidInterface::updateResidual()
solidDispl(pointI, 2) = solidZonePointsTotDisplAtSolid[pointI].z(); solidDispl(pointI, 2) = solidZonePointsTotDisplAtSolid[pointI].z();
} }
solidToFluid()->interpolate( solidDispl, fluidDispl ); solidToFluid()->interpolate(solidDispl, fluidDispl);
forAll(solidZonePointsTotDispl, pointI) forAll(solidZonePointsTotDispl, pointI)
{ {

View file

@ -44,9 +44,7 @@
// // Calc gradient // // Calc gradient
// tensorField gradPhiUp = // tensorField gradPhiUp =
// fvc::grad(phiU)().boundaryField()[aPatchID()] // fvc::grad(phiU)().boundaryField()[aPatchID()].patchInternalField();
// .patchInternalField();
// nGradUn() = 2*nGradUn() - (nA&(gradPhiUp&nA)); // nGradUn() = 2*nGradUn() - (nA&(gradPhiUp&nA));
// } // }
} }

View file

@ -81,7 +81,8 @@ Foam::orthotropicLinearElastic::orthotropicLinearElastic
A44_( 2*Gxy_ ), A44_( 2*Gxy_ ),
A55_( 2*Gyz_ ), A55_( 2*Gyz_ ),
A66_( 2*Gzx_ ), A66_( 2*Gzx_ ),
C_( C_
(
IOobject IOobject
( (
"rheologyLawStoredC", "rheologyLawStoredC",
@ -92,7 +93,9 @@ Foam::orthotropicLinearElastic::orthotropicLinearElastic
), ),
mesh(), mesh(),
dimensionedSymmTensor4thOrder("zero", dimForce/dimArea, dimensionedSymmTensor4thOrder("zero", dimForce/dimArea,
symmTensor4thOrder(A11_.value(), A12_.value(), A31_.value(), symmTensor4thOrder
(
A11_.value(), A12_.value(), A31_.value(),
A22_.value(), A23_.value(), A22_.value(), A23_.value(),
A33_.value(), A33_.value(),
A44_.value(), A44_.value(),
@ -101,7 +104,8 @@ Foam::orthotropicLinearElastic::orthotropicLinearElastic
), ),
zeroGradientFvPatchSymmTensor4thOrderField::typeName zeroGradientFvPatchSymmTensor4thOrderField::typeName
), ),
matDir_( matDir_
(
IOobject IOobject
( (
"materialDirections", "materialDirections",
@ -118,17 +122,23 @@ Foam::orthotropicLinearElastic::orthotropicLinearElastic
Info << "\tChecking physical constraints on the orthotropic material properties" << endl; Info << "\tChecking physical constraints on the orthotropic material properties" << endl;
//- E and G should be greater than zero //- E and G should be greater than zero
if(Ex_.value() < 0.0 || Ey_.value() < 0.0 || Ez_.value() < 0.0 if
|| Gxy_.value() < 0.0 || Gyz_.value() < 0.0 || Gzx_.value() < 0.0) (
Ex_.value() < 0.0 || Ey_.value() < 0.0 || Ez_.value() < 0.0
|| Gxy_.value() < 0.0 || Gyz_.value() < 0.0 || Gzx_.value() < 0.0
)
{ {
FatalError << "Ex, Ey, Ez, Gxy, Gyz, Gzx should all be greater than zero!" FatalError << "Ex, Ey, Ez, Gxy, Gyz, Gzx should all be greater than zero!"
<< exit(FatalError); << exit(FatalError);
} }
//- restriction on Poisson's ratio //- restriction on Poisson's ratio
if(mag(nuxy_.value()) >= sqrt(Ex_.value()/Ey_.value()) if
(
mag(nuxy_.value()) >= sqrt(Ex_.value()/Ey_.value())
|| mag(nuyz_.value()) >= sqrt(Ey_.value()/Ez_.value()) || mag(nuyz_.value()) >= sqrt(Ey_.value()/Ez_.value())
|| mag(nuzx_.value()) >= sqrt(Ez_.value()/Ex_.value())) || mag(nuzx_.value()) >= sqrt(Ez_.value()/Ex_.value())
)
{ {
FatalError << "mag(nuij) should be less sqrt(Ei/Ej)" FatalError << "mag(nuij) should be less sqrt(Ei/Ej)"
<< exit(FatalError); << exit(FatalError);
@ -140,7 +150,6 @@ Foam::orthotropicLinearElastic::orthotropicLinearElastic
<< exit(FatalError); << exit(FatalError);
} }
Info << "\tRotating local material properties to global coordinate system" << endl; Info << "\tRotating local material properties to global coordinate system" << endl;
//- rotate tensors //- rotate tensors
volTensorField R volTensorField R

View file

@ -75,7 +75,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
contactFilePtr_(NULL) contactFilePtr_(NULL)
{ {
// create friction law // create friction law
frictionLawPtr_ = frictionLaw::New( frictionLawPtr_ = frictionLaw::New
(
frictionContactModelDict_.lookup("frictionLaw"), frictionContactModelDict_.lookup("frictionLaw"),
frictionContactModelDict_ frictionContactModelDict_
).ptr(); ).ptr();
@ -105,8 +106,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
void Foam::dirichletNeumannFriction::correct void Foam::dirichletNeumannFriction::correct
( (
const vectorField& slavePressure, const vectorField& slavePressure,
const PrimitivePatch<face, List, pointField>& masterFaceZonePatch, const PrimitivePatch<face, List, pointField>& masterFaceZonePatch,
const PrimitivePatch<face, List, pointField>& slaveFaceZonePatch, const PrimitivePatch<face, List, pointField>& slaveFaceZonePatch,
@ -117,8 +118,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
const Switch orthotropic, const Switch orthotropic,
const word nonLinear, const word nonLinear,
const vectorField& slaveFaceNormals const vectorField& slaveFaceNormals
) )
{ {
const fvMesh& mesh = mesh_; const fvMesh& mesh = mesh_;
const label slavePatchIndex = slavePatchID(); const label slavePatchIndex = slavePatchID();
const label masterPatchIndex = masterPatchID(); const label masterPatchIndex = masterPatchID();
@ -162,8 +163,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
} }
// put local masterDU into globalMasterDU // put local masterDU into globalMasterDU
const label masterPatchStart const label masterPatchStart =
= mesh.boundaryMesh()[masterPatchIndex].start(); mesh.boundaryMesh()[masterPatchIndex].start();
forAll(masterDU, i) forAll(masterDU, i)
{ {
globalMasterDU[mesh.faceZones()[masterFaceZoneID()].whichFace(masterPatchStart + i)] = globalMasterDU[mesh.faceZones()[masterFaceZoneID()].whichFace(masterPatchStart + i)] =
@ -178,7 +179,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
// interpolate DU from master to slave using inverse distance or ggi // interpolate DU from master to slave using inverse distance or ggi
if(interpolationMethod == "patchToPatch") if(interpolationMethod == "patchToPatch")
{ {
PatchToPatchInterpolation< PatchToPatchInterpolation
<
PrimitivePatch<face, List, pointField>, PrimitivePatch<face, List, pointField> PrimitivePatch<face, List, pointField>, PrimitivePatch<face, List, pointField>
> masterToSlavePatchToPatchInterpolator > masterToSlavePatchToPatchInterpolator
( (
@ -195,7 +197,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
} }
else if(interpolationMethod == "ggi") else if(interpolationMethod == "ggi")
{ {
GGIInterpolation< GGIInterpolation
<
PrimitivePatch< face, List, pointField >, PrimitivePatch< face, List, pointField > PrimitivePatch< face, List, pointField >, PrimitivePatch< face, List, pointField >
> masterToSlaveGgiInterpolator > masterToSlaveGgiInterpolator
( (
@ -224,8 +227,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
} }
// now put global back into local // now put global back into local
const label slavePatchStart const label slavePatchStart =
= mesh.boundaryMesh()[slavePatchIndex].start(); mesh.boundaryMesh()[slavePatchIndex].start();
forAll(masterDUInterpToSlave, i) forAll(masterDUInterpToSlave, i)
{ {
@ -244,8 +247,7 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
slavePatch.lookupPatchField<volTensorField, tensor>("grad("+fieldName+")"); slavePatch.lookupPatchField<volTensorField, tensor>("grad("+fieldName+")");
vectorField slaveShearTraction = vectorField slaveShearTraction =
(I - sqr(slaveFaceNormals)) (I - sqr(slaveFaceNormals))
& & tractionBoundaryGradient().traction
tractionBoundaryGradient().traction
( (
gradField, gradField,
fieldName, fieldName,
@ -297,8 +299,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
// slip is the difference between the master tangential DU and slave tangential DU // slip is the difference between the master tangential DU and slave tangential DU
vector slip = vector slip =
(I - sqr(slaveFaceNormals[faceI])) & (I - sqr(slaveFaceNormals[faceI]))
( slaveDU[faceI] - masterDUInterpToSlave[faceI]); & ( slaveDU[faceI] - masterDUInterpToSlave[faceI]);
// if the slip and dir are in the same direction then we will make this a // if the slip and dir are in the same direction then we will make this a
// sticking face // sticking face
@ -311,8 +313,7 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
// increment the slave shear displacement // increment the slave shear displacement
// we add an increment of shear disp to the slave faces until there is no // we add an increment of shear disp to the slave faces until there is no
// more slip // more slip
slaveDisp_[faceI] = slaveDisp_[faceI] = -1*relaxationFactor_*slip;
-1*relaxationFactor_ * slip;
// slaveDisp_[faceI] is the correction to the disp so we // slaveDisp_[faceI] is the correction to the disp so we
// add on the original disp // add on the original disp
@ -358,8 +359,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
// slip is the difference of the tangential DU between the master and slave // slip is the difference of the tangential DU between the master and slave
vector slip = vector slip =
(I - sqr(slaveFaceNormals[faceI])) & (I - sqr(slaveFaceNormals[faceI]))
(slaveDU[faceI] - masterDUInterpToSlave[faceI]); & (slaveDU[faceI] - masterDUInterpToSlave[faceI]);
// increment the slave shear displacement // increment the slave shear displacement
// we add an increment of shear disp to the slave faces until there is no // we add an increment of shear disp to the slave faces until there is no
@ -427,13 +428,13 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
contactFile.width(width); contactFile.width(width);
contactFile << maxMagMasterTraction << endl; contactFile << maxMagMasterTraction << endl;
} }
} }
void Foam::dirichletNeumannFriction::correctOscillations void Foam::dirichletNeumannFriction::correctOscillations
( (
const PrimitivePatch<face, List, pointField>& slaveFaceZonePatch const PrimitivePatch<face, List, pointField>& slaveFaceZonePatch
) )
{ {
// oscillations sometimes appear in contact shear displacements/tractions // oscillations sometimes appear in contact shear displacements/tractions
// so we will try to limit them here // so we will try to limit them here
// we will weight the current face slaveDisp/Traction with the average of the // we will weight the current face slaveDisp/Traction with the average of the
@ -451,8 +452,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
vectorField globalSlaveDisp(slaveFaceZonePatch.size(), vector::zero); vectorField globalSlaveDisp(slaveFaceZonePatch.size(), vector::zero);
// symmTensorField globalSlaveValueFrac(slaveFaceZonePatch.size(), symmTensor::zero); // symmTensorField globalSlaveValueFrac(slaveFaceZonePatch.size(), symmTensor::zero);
scalarField globalStickSlip(slaveFaceZonePatch.size(), 0.0); scalarField globalStickSlip(slaveFaceZonePatch.size(), 0.0);
const label slavePatchStart const label slavePatchStart =
= mesh.boundaryMesh()[slavePatchIndex].start(); mesh.boundaryMesh()[slavePatchIndex].start();
forAll(slaveTraction_, i) forAll(slaveTraction_, i)
{ {
// globalSlaveTraction[mesh.faceZones()[slaveFaceZoneID()].whichFace(slavePatchStart + i)] = // globalSlaveTraction[mesh.faceZones()[slaveFaceZoneID()].whichFace(slavePatchStart + i)] =
@ -532,15 +533,15 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
} }
//Pout << "\tdone" << endl; //Pout << "\tdone" << endl;
} }
void Foam::dirichletNeumannFriction::writeDict(Ostream& os) const void Foam::dirichletNeumannFriction::writeDict(Ostream& os) const
{ {
word keyword(name()+"FrictionModelDict"); word keyword(name()+"FrictionModelDict");
os.writeKeyword(keyword) os.writeKeyword(keyword)
<< frictionContactModelDict_; << frictionContactModelDict_;
} }
// ************************************************************************* // // ************************************************************************* //

View file

@ -137,7 +137,6 @@ void jumpGgiFvPatchField<Type>::initInterfaceMatrixUpdate
} }
else else
{ {
forAll (sField, i) forAll (sField, i)
{ {
sField[i] = psiInternal[sfc[i]]; sField[i] = psiInternal[sfc[i]];

View file

@ -222,7 +222,6 @@ inline Foam::scalar Foam::constantHeatCapacity<equationOfState>::cv
( (
const scalar rho, const scalar rho,
const scalar T const scalar T
) const ) const
{ {
return this->cv0(T) + T*this->integral_d2pdT2_dv(rho, T); return this->cv0(T) + T*this->integral_d2pdT2_dv(rho, T);
@ -273,7 +272,6 @@ inline Foam::scalar Foam::constantHeatCapacity<equationOfState>::s
( (
const scalar rho, const scalar rho,
const scalar T const scalar T
) const ) const
{ {
return return
@ -293,7 +291,6 @@ inline void Foam::constantHeatCapacity<equationOfState>::operator+=
const constantHeatCapacity<equationOfState>& np const constantHeatCapacity<equationOfState>& np
) )
{ {
scalar molr1 = this->nMoles(); scalar molr1 = this->nMoles();
equationOfState::operator+=(np); equationOfState::operator+=(np);

View file

@ -97,7 +97,6 @@ vertices
(1000 210 15) //73 (1000 210 15) //73
(1000 280 15) //74 (1000 280 15) //74
(1000 410 15) //75 (1000 410 15) //75
); );
blocks blocks
@ -159,7 +158,6 @@ edges
arc 13 7 (288.2725 141.3043 0) arc 13 7 (288.2725 141.3043 0)
arc 45 39 (288.2725 141.3043 15) arc 45 39 (288.2725 141.3043 15)
); );
patches patches
@ -268,7 +266,6 @@ patches
(72 46 52 73) (72 46 52 73)
(47 72 73 53) (47 72 73 53)
) )
); );
mergePatchPairs mergePatchPairs

View file

@ -97,7 +97,6 @@ vertices
(1000 210 0.05067) //73 (1000 210 0.05067) //73
(1000 270.7107 0.05067) //74 (1000 270.7107 0.05067) //74
(1000 410 0.05067) //75 (1000 410 0.05067) //75
); );
blocks blocks
@ -159,7 +158,6 @@ edges
arc 13 7 (286.6025 150 0) arc 13 7 (286.6025 150 0)
arc 45 39 (286.6025 150 0.05067) arc 45 39 (286.6025 150 0.05067)
); );
patches patches
@ -268,7 +266,6 @@ patches
(72 46 52 73) (72 46 52 73)
(47 72 73 53) (47 72 73 53)
) )
); );
mergePatchPairs mergePatchPairs

View file

@ -57,7 +57,6 @@ patches
(0 1 2 3) (0 1 2 3)
(7 6 5 4) (7 6 5 4)
) )
); );
mergePatchPairs mergePatchPairs

View file

@ -57,6 +57,7 @@ solvers
tolerance 1e-7; tolerance 1e-7;
relTol 0.1; relTol 0.1;
} }
T T
{ {
solver smoothSolver; solver smoothSolver;
@ -65,6 +66,7 @@ solvers
tolerance 1e-7; tolerance 1e-7;
relTol 0.1; relTol 0.1;
} }
i i
{ {
solver smoothSolver; solver smoothSolver;

View file

@ -1,76 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | foam-extend: Open Source CFD |
| \\ / O peration | Version: 3.2 |
| \\ / A nd | Web: http://www.foam-extend.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
object fvSchemes;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
ddtSchemes
{
default steadyState;
}
gradSchemes
{
default Gauss linear;
grad(p) Gauss linear;
grad(U) Gauss linear;
}
divSchemes
{
default none;
div(phi,U) Gauss limitedLinearV 1;
div(phi,k) Gauss limitedLinear 1;
div(phi,i) Gauss limitedLinear 1;
div(phid,p) Gauss limitedLinear 1;
div(phi,epsilon) Gauss limitedLinear 1;
div((nuEff*dev(grad(U).T()))) Gauss linear;
div((muEff*dev2(grad(U).T()))) Gauss linear;
}
laplacianSchemes
{
default none;
laplacian(nuEff,U) Gauss linear corrected;
laplacian((rho*(1|A(U))),p) Gauss linear corrected;
laplacian(DkEff,k) Gauss linear corrected;
laplacian(DepsilonEff,epsilon) Gauss linear corrected;
laplacian(muEff,U) Gauss linear corrected;
laplacian(alphaEff,i) Gauss linear corrected;
}
interpolationSchemes
{
default linear;
interpolate(U) linear;
}
snGradSchemes
{
default corrected;
}
fluxRequired
{
default no;
p;
}
mixingPlane
{
default areaAveraging;
//U fluxAveragingAdjustMassFlow;
//p zeroGradientAreaAveragingMix;
}
// ************************************************************************* //

View file

@ -47,6 +47,7 @@ solvers
tolerance 1e-7; tolerance 1e-7;
relTol 0.1; relTol 0.1;
} }
T T
{ {
solver smoothSolver; solver smoothSolver;
@ -55,6 +56,7 @@ solvers
tolerance 1e-7; tolerance 1e-7;
relTol 0.1; relTol 0.1;
} }
i i
{ {
solver smoothSolver; solver smoothSolver;

View file

@ -40,7 +40,6 @@ boundaryField
deadCellValue 0; deadCellValue 0;
value uniform 0; value uniform 0;
} }
input input

View file

@ -23,7 +23,6 @@ immersedBoundarySolidBodyMotionFvMeshCoeffs
( (
ibCylinder ibCylinder
{ {
solidBodyMotionFunction rotatingOscillation; solidBodyMotionFunction rotatingOscillation;
rotatingOscillationCoeffs rotatingOscillationCoeffs
{ {

View file

@ -32,7 +32,6 @@ boundaryLayers
patchBoundaryLayers patchBoundaryLayers
{ {
patch7 patch7
{ {
allowDiscontinuity 0; allowDiscontinuity 0;
@ -45,7 +44,6 @@ boundaryLayers
localRefinement localRefinement
{ {
patch15 patch15
{ {
additionalRefinementLevels 1; additionalRefinementLevels 1;