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"
--> added this file

View file

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

View file

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

View file

@ -75,7 +75,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
contactFilePtr_(NULL)
{
// create friction law
frictionLawPtr_ = frictionLaw::New(
frictionLawPtr_ = frictionLaw::New
(
frictionContactModelDict_.lookup("frictionLaw"),
frictionContactModelDict_
).ptr();
@ -162,8 +163,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
}
// put local masterDU into globalMasterDU
const label masterPatchStart
= mesh.boundaryMesh()[masterPatchIndex].start();
const label masterPatchStart =
mesh.boundaryMesh()[masterPatchIndex].start();
forAll(masterDU, 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
if(interpolationMethod == "patchToPatch")
{
PatchToPatchInterpolation<
PatchToPatchInterpolation
<
PrimitivePatch<face, List, pointField>, PrimitivePatch<face, List, pointField>
> masterToSlavePatchToPatchInterpolator
(
@ -195,7 +197,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
}
else if(interpolationMethod == "ggi")
{
GGIInterpolation<
GGIInterpolation
<
PrimitivePatch< face, List, pointField >, PrimitivePatch< face, List, pointField >
> masterToSlaveGgiInterpolator
(
@ -224,8 +227,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
}
// now put global back into local
const label slavePatchStart
= mesh.boundaryMesh()[slavePatchIndex].start();
const label slavePatchStart =
mesh.boundaryMesh()[slavePatchIndex].start();
forAll(masterDUInterpToSlave, i)
{
@ -244,8 +247,7 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
slavePatch.lookupPatchField<volTensorField, tensor>("grad("+fieldName+")");
vectorField slaveShearTraction =
(I - sqr(slaveFaceNormals))
&
tractionBoundaryGradient().traction
& tractionBoundaryGradient().traction
(
gradField,
fieldName,
@ -297,8 +299,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
// slip is the difference between the master tangential DU and slave tangential DU
vector slip =
(I - sqr(slaveFaceNormals[faceI])) &
( slaveDU[faceI] - masterDUInterpToSlave[faceI]);
(I - sqr(slaveFaceNormals[faceI]))
& ( slaveDU[faceI] - masterDUInterpToSlave[faceI]);
// if the slip and dir are in the same direction then we will make this a
// sticking face
@ -311,8 +313,7 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
// increment the slave shear displacement
// we add an increment of shear disp to the slave faces until there is no
// more slip
slaveDisp_[faceI] =
-1*relaxationFactor_ * slip;
slaveDisp_[faceI] = -1*relaxationFactor_*slip;
// slaveDisp_[faceI] is the correction to the disp so we
// 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
vector slip =
(I - sqr(slaveFaceNormals[faceI])) &
(slaveDU[faceI] - masterDUInterpToSlave[faceI]);
(I - sqr(slaveFaceNormals[faceI]))
& (slaveDU[faceI] - masterDUInterpToSlave[faceI]);
// increment the slave shear displacement
// we add an increment of shear disp to the slave faces until there is no
@ -451,8 +452,8 @@ Foam::dirichletNeumannFriction::dirichletNeumannFriction
vectorField globalSlaveDisp(slaveFaceZonePatch.size(), vector::zero);
// symmTensorField globalSlaveValueFrac(slaveFaceZonePatch.size(), symmTensor::zero);
scalarField globalStickSlip(slaveFaceZonePatch.size(), 0.0);
const label slavePatchStart
= mesh.boundaryMesh()[slavePatchIndex].start();
const label slavePatchStart =
mesh.boundaryMesh()[slavePatchIndex].start();
forAll(slaveTraction_, i)
{
// globalSlaveTraction[mesh.faceZones()[slaveFaceZoneID()].whichFace(slavePatchStart + i)] =

View file

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

View file

@ -222,7 +222,6 @@ inline Foam::scalar Foam::constantHeatCapacity<equationOfState>::cv
(
const scalar rho,
const scalar T
) const
{
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 T
) const
{
return
@ -293,7 +291,6 @@ inline void Foam::constantHeatCapacity<equationOfState>::operator+=
const constantHeatCapacity<equationOfState>& np
)
{
scalar molr1 = this->nMoles();
equationOfState::operator+=(np);

View file

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

View file

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

View file

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

View file

@ -57,6 +57,7 @@ solvers
tolerance 1e-7;
relTol 0.1;
}
T
{
solver smoothSolver;
@ -65,6 +66,7 @@ solvers
tolerance 1e-7;
relTol 0.1;
}
i
{
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;
relTol 0.1;
}
T
{
solver smoothSolver;
@ -55,6 +56,7 @@ solvers
tolerance 1e-7;
relTol 0.1;
}
i
{
solver smoothSolver;

View file

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

View file

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

View file

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