diff --git a/.gitignore b/.gitignore index 6f5bfdd9..1d1ae5ca 100644 --- a/.gitignore +++ b/.gitignore @@ -5,7 +5,7 @@ log_* log.* *~ + **/linux*Gcc*/ lnInclude - diff --git a/applications/solvers/cfdemSolverMultiphase/Allwclean b/applications/solvers/cfdemSolverMultiphase/Allwclean new file mode 100755 index 00000000..1c8a5a68 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/Allwclean @@ -0,0 +1,8 @@ +#!/bin/sh +cd ${0%/*} || exit 1 # Run from this directory +set -x + +wclean libso multiphaseMixture +wclean + +#------------------------------------------------------------------------------ diff --git a/applications/solvers/cfdemSolverMultiphase/Allwmake b/applications/solvers/cfdemSolverMultiphase/Allwmake new file mode 100755 index 00000000..fbe71a59 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/Allwmake @@ -0,0 +1,12 @@ +#!/bin/sh +cd ${0%/*} || exit 1 # Run from this directory + +# Parse arguments for library compilation +targetType=libso +. $WM_PROJECT_DIR/wmake/scripts/AllwmakeParseArguments +set -x + +wmake $targetType multiphaseMixture +wmake + +#------------------------------------------------------------------------------ diff --git a/applications/solvers/cfdemSolverMultiphase/Make/files b/applications/solvers/cfdemSolverMultiphase/Make/files new file mode 100644 index 00000000..2c615be1 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/Make/files @@ -0,0 +1,3 @@ +cfdemSolverMultiphase.C + +EXE = $(CFDEM_APP_DIR)/cfdemSolverMultiphase diff --git a/applications/solvers/cfdemSolverMultiphase/Make/options b/applications/solvers/cfdemSolverMultiphase/Make/options new file mode 100644 index 00000000..78dc7582 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/Make/options @@ -0,0 +1,30 @@ +include $(CFDEM_ADD_LIBS_DIR)/additionalLibs + +EXE_INC = \ + -I$(CFDEM_OFVERSION_DIR) \ + -ImultiphaseMixture/lnInclude \ + -I$(LIB_SRC)/transportModels \ + -I$(LIB_SRC)/transportModels/incompressible/lnInclude \ + -I$(LIB_SRC)/transportModels/interfaceProperties/lnInclude \ + -I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \ + -I$(LIB_SRC)/TurbulenceModels/incompressible/lnInclude \ + -I$(LIB_SRC)/finiteVolume/lnInclude \ + -I$(LIB_SRC)/meshTools/lnInclude \ + -I$(LIB_SRC)/sampling/lnInclude \ + -I$(CFDEM_SRC_DIR)/lagrangian/cfdemParticle/lnInclude \ + -I$(CFDEM_SRC_DIR)/lagrangian/cfdemParticle/cfdTools \ + +EXE_LIBS = \ + -L$(CFDEM_LIB_DIR)\ + -lcfdemMultiphaseInterFoam \ + -linterfaceProperties \ + -lincompressibleTransportModels \ + -lturbulenceModels \ + -lincompressibleTurbulenceModels \ + -lfiniteVolume \ + -lfvOptions \ + -lmeshTools \ + -lsampling \ + -l$(CFDEM_LIB_NAME) \ + $(CFDEM_ADD_LIB_PATHS) \ + $(CFDEM_ADD_LIBS) diff --git a/applications/solvers/cfdemSolverMultiphase/UEqn.H b/applications/solvers/cfdemSolverMultiphase/UEqn.H new file mode 100644 index 00000000..86d12e50 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/UEqn.H @@ -0,0 +1,61 @@ +const surfaceScalarField& rhoPhi(mixture.rhoPhi()); + +volScalarField muEff = rho*(turbulence->nu() + turbulence->nut()); + +if (modelType == "A") + muEff *= voidfraction; + +fvVectorMatrix UEqn +( + fvm::ddt(rhoEps, U) - fvm::Sp(fvc::ddt(rhoEps),U) + + fvm::div(rhoPhi, U) - fvm::Sp(fvc::div(rhoPhi),U) + //+ particleCloud.divVoidfractionTau(U, voidfraction) + - fvm::laplacian(muEff, U) - fvc::div(muEff*dev2(fvc::grad(U)().T())) + == + fvOptions(rho, U) + - fvm::Sp(Ksl,U) +); + +UEqn.relax(); + +fvOptions.constrain(UEqn); + +if (pimple.momentumPredictor() && (modelType=="B" || modelType=="Bfull")) +{ + solve + ( + UEqn + == + fvc::reconstruct + ( + (- ghf*fvc::snGrad(rho) - fvc::snGrad(p_rgh)) * mesh.magSf() + ) + + + fvc::reconstruct + ( + mixture.surfaceTensionForce() * mesh.magSf() + ) * voidfraction + + Ksl*Us + ); + + fvOptions.correct(U); +} +else if (pimple.momentumPredictor()) +{ + solve + ( + UEqn + == + fvc::reconstruct + ( + ( + mixture.surfaceTensionForce() + - ghf*fvc::snGrad(rho) + - fvc::snGrad(p_rgh) + ) * mesh.magSf() + ) * voidfraction + + Ksl*Us + ); + + fvOptions.correct(U); +} diff --git a/applications/solvers/cfdemSolverMultiphase/additionalChecks.H b/applications/solvers/cfdemSolverMultiphase/additionalChecks.H new file mode 100644 index 00000000..6f485462 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/additionalChecks.H @@ -0,0 +1,17 @@ +// Additional solver-specific checks + +// Useful if one wants to e.g. initialize floating particles using the Archimedes model +if (particleCloud.couplingProperties().found("unrestrictedForceModelSelection")) +{ + Warning << "Using unrestrictedForceModelSelection, results may be incorrect!" << endl; +} else +{ + #include "checkModelType.H" +} + +word modelType = particleCloud.modelType(); + +if(!particleCloud.couplingProperties().found("useDDTvoidfraction")) +{ + Warning << "Suppressing ddt(voidfraction) is not recommended with this solver as it may generate incorrect results!" << endl; +} diff --git a/applications/solvers/cfdemSolverMultiphase/alphaCourantNo.H b/applications/solvers/cfdemSolverMultiphase/alphaCourantNo.H new file mode 100644 index 00000000..61dafb14 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/alphaCourantNo.H @@ -0,0 +1,21 @@ +scalar alphaCoNum = 0.0; +scalar meanAlphaCoNum = 0.0; + +if (mesh.nInternalFaces()) +{ + scalarField sumPhi + ( + mixture.nearInterface()().primitiveField() + *fvc::surfaceSum(mag(phi))().primitiveField() + ); + + alphaCoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaTValue(); + + meanAlphaCoNum = + 0.5*(gSum(sumPhi)/gSum(mesh.V().field()))*runTime.deltaTValue(); +} + +Info<< "Interface Courant Number mean: " << meanAlphaCoNum + << " max: " << alphaCoNum << endl; + +// ************************************************************************* // diff --git a/applications/solvers/cfdemSolverMultiphase/cfdemSolverMultiphase.C b/applications/solvers/cfdemSolverMultiphase/cfdemSolverMultiphase.C new file mode 100644 index 00000000..c37c3fcb --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/cfdemSolverMultiphase.C @@ -0,0 +1,147 @@ +/*---------------------------------------------------------------------------*\ +License + + This 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. + + This code 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 this code. If not, see . + + Copyright (C) 2018- Mathias Vångö, JKU Linz, Austria + +Application + cfdemSolverMultiphase + +Description + CFD-DEM solver for n incompressible fluids which captures the interfaces and + includes surface-tension and contact-angle effects for each phase. It is based + on the OpenFOAM(R)-4.x solver multiphaseInterFoam but extended to incorporate + DEM functionalities from the open-source DEM code LIGGGHTS. + + Turbulence modelling is generic, i.e. laminar, RAS or LES may be selected. + +\*---------------------------------------------------------------------------*/ + +#include "fvCFD.H" +#include "multiphaseMixture.H" +#include "turbulentTransportModel.H" +#include "pimpleControl.H" +#include "fvOptions.H" +#include "CorrectPhi.H" + +#include "cfdemCloud.H" +#include "implicitCouple.H" +#include "clockModel.H" +#include "smoothingModel.H" +#include "forceModel.H" +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +int main(int argc, char *argv[]) +{ + #include "postProcess.H" + #include "setRootCase.H" + #include "createTime.H" + #include "createMesh.H" + #include "createControl.H" + #include "initContinuityErrs.H" + #include "createFields.H" + #include "createFvOptions.H" + #include "correctPhi.H" + #include "CourantNo.H" + + turbulence->validate(); + + // create cfdemCloud + cfdemCloud particleCloud(mesh); + + #include "additionalChecks.H" + + // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + + Info<< "\nStarting time loop\n" << endl; + + while (runTime.loop()) + { + #include "CourantNo.H" + #include "alphaCourantNo.H" + + particleCloud.clockM().start(1,"Global"); + + Info<< "Time = " << runTime.timeName() << nl << endl; + + particleCloud.clockM().start(2,"Coupling"); + bool hasEvolved = particleCloud.evolve(voidfraction,Us,U); + + if(hasEvolved) + { + particleCloud.smoothingM().smoothen(particleCloud.forceM(0).impParticleForces()); + } + + Info << "update Ksl.internalField()" << endl; + Ksl = particleCloud.momCoupleM(0).impMomSource(); + Ksl.correctBoundaryConditions(); + + //Force Checks + vector fTotal(0,0,0); + vector fImpTotal = sum(mesh.V()*Ksl.internalField()*(Us.internalField()-U.internalField())).value(); + reduce(fImpTotal, sumOp()); + Info << "TotalForceExp: " << fTotal << endl; + Info << "TotalForceImp: " << fImpTotal << endl; + + #include "solverDebugInfo.H" + particleCloud.clockM().stop("Coupling"); + + particleCloud.clockM().start(26,"Flow"); + + if(particleCloud.solveFlow()) + { + mixture.solve(); + rho = mixture.rho(); + rhoEps = rho * voidfraction; + + // --- Pressure-velocity PIMPLE corrector loop + while (pimple.loop()) + { + #include "UEqn.H" + + // --- Pressure corrector loop + while (pimple.correct()) + { + #include "pEqn.H" + } + + if (pimple.turbCorr()) + { + turbulence->correct(); + } + } + } + else + { + Info << "skipping flow solution." << endl; + } + + runTime.write(); + + Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s" + << " ClockTime = " << runTime.elapsedClockTime() << " s" + << nl << endl; + + particleCloud.clockM().stop("Flow"); + particleCloud.clockM().stop("Global"); + } + + Info<< "End\n" << endl; + + return 0; +} + + +// ************************************************************************* // diff --git a/applications/solvers/cfdemSolverMultiphase/correctPhi.H b/applications/solvers/cfdemSolverMultiphase/correctPhi.H new file mode 100644 index 00000000..9afcd58a --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/correctPhi.H @@ -0,0 +1,11 @@ +CorrectPhi +( + U, + phi, + p_rgh, + dimensionedScalar("rAUf", dimTime/rho.dimensions(), 1), + geometricZeroField(), + pimple +); + +#include "continuityErrs.H" diff --git a/applications/solvers/cfdemSolverMultiphase/createFields.H b/applications/solvers/cfdemSolverMultiphase/createFields.H new file mode 100644 index 00000000..c56fafb9 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/createFields.H @@ -0,0 +1,156 @@ +//=============================== +// particle interaction modelling +//=============================== + +Info<< "\nReading momentum exchange field Ksl\n" << endl; +volScalarField Ksl +( + IOobject + ( + "Ksl", + runTime.timeName(), + mesh, + IOobject::MUST_READ, + IOobject::AUTO_WRITE + ), + mesh + //dimensionedScalar("0", dimensionSet(1, -3, -1, 0, 0), 1.0) +); + +Info<< "\nReading voidfraction field voidfraction = (Vgas/Vparticle)\n" << endl; +volScalarField voidfraction +( + IOobject + ( + "voidfraction", + runTime.timeName(), + mesh, + IOobject::MUST_READ, + IOobject::AUTO_WRITE + ), + mesh +); +voidfraction.oldTime(); + +Info<< "Reading particle velocity field Us\n" << endl; +volVectorField Us +( + IOobject + ( + "Us", + runTime.timeName(), + mesh, + IOobject::MUST_READ, + IOobject::AUTO_WRITE + ), + mesh +); + +Info<< "Reading field p_rgh\n" << endl; +volScalarField p_rgh +( + IOobject + ( + "p_rgh", + runTime.timeName(), + mesh, + IOobject::MUST_READ, + IOobject::AUTO_WRITE + ), + mesh +); + +Info<< "Reading field U\n" << endl; +volVectorField U +( + IOobject + ( + "U", + runTime.timeName(), + mesh, + IOobject::MUST_READ, + IOobject::AUTO_WRITE + ), + mesh +); + +Info<< "Reading/calculating face flux field phi\n" << endl; +surfaceScalarField phi + ( + IOobject + ( + "phi", + runTime.timeName(), + mesh, + IOobject::READ_IF_PRESENT, + IOobject::AUTO_WRITE + ), + linearInterpolate(U*voidfraction) & mesh.Sf() + ); + +multiphaseMixture mixture(U, phi, voidfraction); + +// Need to store rho for ddt(rho, U) +volScalarField rho +( + IOobject + ( + "rho", + runTime.timeName(), + mesh, + IOobject::READ_IF_PRESENT, + IOobject::AUTO_WRITE + ), + mixture.rho() +); +rho.oldTime(); + +volScalarField rhoEps ("rhoEps", rho * voidfraction); + +// Construct incompressible turbulence model +autoPtr turbulence +( + incompressible::turbulenceModel::New(U, phi, mixture) +); + + +#include "readGravitationalAcceleration.H" +#include "readhRef.H" +#include "gh.H" + + +volScalarField p +( + IOobject + ( + "p", + runTime.timeName(), + mesh, + IOobject::NO_READ, + IOobject::AUTO_WRITE + ), + p_rgh + rho*gh +); + +label pRefCell = 0; +scalar pRefValue = 0.0; +setRefCell +( + p, + p_rgh, + pimple.dict(), + pRefCell, + pRefValue +); + +if (p_rgh.needReference()) +{ + p += dimensionedScalar + ( + "p", + p.dimensions(), + pRefValue - getRefCellValue(p, pRefCell) + ); +} + +mesh.setFluxRequired(p_rgh.name()); diff --git a/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/Make/files b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/Make/files new file mode 100644 index 00000000..572171ec --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/Make/files @@ -0,0 +1,5 @@ +phase/phase.C +alphaContactAngle/alphaContactAngleFvPatchScalarField.C +multiphaseMixture.C + +LIB = $(CFDEM_LIB_DIR)/libcfdemMultiphaseInterFoam diff --git a/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/Make/options b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/Make/options new file mode 100644 index 00000000..f8ffa1cf --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/Make/options @@ -0,0 +1,13 @@ +EXE_INC = \ + -IalphaContactAngle \ + -I$(LIB_SRC)/transportModels \ + -I$(LIB_SRC)/transportModels/incompressible/lnInclude \ + -I$(LIB_SRC)/transportModels/interfaceProperties/lnInclude \ + -I$(LIB_SRC)/finiteVolume/lnInclude \ + -I$(LIB_SRC)/meshTools/lnInclude + +LIB_LIBS = \ + -linterfaceProperties \ + -lincompressibleTransportModels \ + -lfiniteVolume \ + -lmeshTools diff --git a/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/alphaContactAngle/alphaContactAngleFvPatchScalarField.C b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/alphaContactAngle/alphaContactAngleFvPatchScalarField.C new file mode 100644 index 00000000..a0d433f4 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/alphaContactAngle/alphaContactAngleFvPatchScalarField.C @@ -0,0 +1,146 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2011 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 . + +\*---------------------------------------------------------------------------*/ + +#include "alphaContactAngleFvPatchScalarField.H" +#include "addToRunTimeSelectionTable.H" +#include "fvPatchFieldMapper.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + +alphaContactAngleFvPatchScalarField::interfaceThetaProps::interfaceThetaProps +( + Istream& is +) +: + theta0_(readScalar(is)), + uTheta_(readScalar(is)), + thetaA_(readScalar(is)), + thetaR_(readScalar(is)) +{} + + +Istream& operator>> +( + Istream& is, + alphaContactAngleFvPatchScalarField::interfaceThetaProps& tp +) +{ + is >> tp.theta0_ >> tp.uTheta_ >> tp.thetaA_ >> tp.thetaR_; + return is; +} + + +Ostream& operator<< +( + Ostream& os, + const alphaContactAngleFvPatchScalarField::interfaceThetaProps& tp +) +{ + os << tp.theta0_ << token::SPACE + << tp.uTheta_ << token::SPACE + << tp.thetaA_ << token::SPACE + << tp.thetaR_; + + return os; +} + + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField +( + const fvPatch& p, + const DimensionedField& iF +) +: + zeroGradientFvPatchScalarField(p, iF) +{} + + +alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField +( + const alphaContactAngleFvPatchScalarField& gcpsf, + const fvPatch& p, + const DimensionedField& iF, + const fvPatchFieldMapper& mapper +) +: + zeroGradientFvPatchScalarField(gcpsf, p, iF, mapper), + thetaProps_(gcpsf.thetaProps_) +{} + + +alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField +( + const fvPatch& p, + const DimensionedField& iF, + const dictionary& dict +) +: + zeroGradientFvPatchScalarField(p, iF), + thetaProps_(dict.lookup("thetaProperties")) +{ + evaluate(); +} + + +alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField +( + const alphaContactAngleFvPatchScalarField& gcpsf, + const DimensionedField& iF +) +: + zeroGradientFvPatchScalarField(gcpsf, iF), + thetaProps_(gcpsf.thetaProps_) +{} + + +// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // + +void alphaContactAngleFvPatchScalarField::write(Ostream& os) const +{ + fvPatchScalarField::write(os); + os.writeKeyword("thetaProperties") + << thetaProps_ << token::END_STATEMENT << nl; + writeEntry("value", os); +} + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +makePatchTypeField +( + fvPatchScalarField, + alphaContactAngleFvPatchScalarField +); + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// ************************************************************************* // diff --git a/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/alphaContactAngle/alphaContactAngleFvPatchScalarField.H b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/alphaContactAngle/alphaContactAngleFvPatchScalarField.H new file mode 100644 index 00000000..09249c72 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/alphaContactAngle/alphaContactAngleFvPatchScalarField.H @@ -0,0 +1,215 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2011 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 . + +Class + Foam::alphaContactAngleFvPatchScalarField + +Description + Contact-angle boundary condition for multi-phase interface-capturing + simulations. Used in conjuction with multiphaseMixture. + +SourceFiles + alphaContactAngleFvPatchScalarField.C + +\*---------------------------------------------------------------------------*/ + +#ifndef alphaContactAngleFvPatchScalarField_H +#define alphaContactAngleFvPatchScalarField_H + +#include "zeroGradientFvPatchFields.H" +#include "multiphaseMixture.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + +/*---------------------------------------------------------------------------*\ + Class alphaContactAngleFvPatch Declaration +\*---------------------------------------------------------------------------*/ + +class alphaContactAngleFvPatchScalarField +: + public zeroGradientFvPatchScalarField +{ +public: + + class interfaceThetaProps + { + //- Equilibrium contact angle + scalar theta0_; + + //- Dynamic contact angle velocity scale + scalar uTheta_; + + //- Limiting advancing contact angle + scalar thetaA_; + + //- Limiting receeding contact angle + scalar thetaR_; + + + public: + + // Constructors + interfaceThetaProps() + {} + + interfaceThetaProps(Istream&); + + + // Member functions + + //- Return the equilibrium contact angle theta0 + scalar theta0(bool matched=true) const + { + if (matched) return theta0_; + else return 180.0 - theta0_; + } + + //- Return the dynamic contact angle velocity scale + scalar uTheta() const + { + return uTheta_; + } + + //- Return the limiting advancing contact angle + scalar thetaA(bool matched=true) const + { + if (matched) return thetaA_; + else return 180.0 - thetaA_; + } + + //- Return the limiting receeding contact angle + scalar thetaR(bool matched=true) const + { + if (matched) return thetaR_; + else return 180.0 - thetaR_; + } + + + // IO functions + + friend Istream& operator>>(Istream&, interfaceThetaProps&); + friend Ostream& operator<<(Ostream&, const interfaceThetaProps&); + }; + + typedef HashTable + < + interfaceThetaProps, + multiphaseMixture::interfacePair, + multiphaseMixture::interfacePair::hash + > thetaPropsTable; + + +private: + + // Private data + + thetaPropsTable thetaProps_; + + +public: + + //- Runtime type information + TypeName("alphaContactAngle"); + + + // Constructors + + //- Construct from patch and internal field + alphaContactAngleFvPatchScalarField + ( + const fvPatch&, + const DimensionedField& + ); + + //- Construct from patch, internal field and dictionary + alphaContactAngleFvPatchScalarField + ( + const fvPatch&, + const DimensionedField&, + const dictionary& + ); + + //- Construct by mapping given alphaContactAngleFvPatchScalarField + // onto a new patch + alphaContactAngleFvPatchScalarField + ( + const alphaContactAngleFvPatchScalarField&, + const fvPatch&, + const DimensionedField&, + const fvPatchFieldMapper& + ); + + //- Construct and return a clone + virtual tmp clone() const + { + return tmp + ( + new alphaContactAngleFvPatchScalarField(*this) + ); + } + + //- Construct as copy setting internal field reference + alphaContactAngleFvPatchScalarField + ( + const alphaContactAngleFvPatchScalarField&, + const DimensionedField& + ); + + //- Construct and return a clone setting internal field reference + virtual tmp clone + ( + const DimensionedField& iF + ) const + { + return tmp + ( + new alphaContactAngleFvPatchScalarField(*this, iF) + ); + } + + + // Member functions + + //- Return the contact angle properties + const thetaPropsTable& thetaProps() const + { + return thetaProps_; + } + + //- Write + virtual void write(Ostream&) const; +}; + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#endif + +// ************************************************************************* // diff --git a/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/multiphaseMixture.C b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/multiphaseMixture.C new file mode 100644 index 00000000..49cee681 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/multiphaseMixture.C @@ -0,0 +1,772 @@ +/*---------------------------------------------------------------------------*\ +License + + This 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. + + This code 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 this code. If not, see . + + Copyright (C) 2018- Mathias Vångö, JKU Linz, Austria + +\*---------------------------------------------------------------------------*/ + +#include "multiphaseMixture.H" +#include "alphaContactAngleFvPatchScalarField.H" +#include "Time.H" +#include "subCycle.H" +#include "MULES.H" +#include "surfaceInterpolate.H" +#include "fvcGrad.H" +#include "fvcSnGrad.H" +#include "fvcDiv.H" +#include "fvcFlux.H" + +// * * * * * * * * * * * * * * * Static Member Data * * * * * * * * * * * * // + +const Foam::scalar Foam::multiphaseMixture::convertToRad = + Foam::constant::mathematical::pi/180.0; + + +// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * // + +void Foam::multiphaseMixture::calcAlphas() +{ + scalar level = 0.0; + alphas_ == 0.0; + + forAllIter(PtrDictionary, phases_, iter) + { + alphas_ += level*iter(); + level += 1.0; + } +} + + +Foam::tmp +Foam::multiphaseMixture::calcNu() const +{ + PtrDictionary::const_iterator iter = phases_.begin(); + + tmp tnu = iter()*iter().nu(); + volScalarField& nu = tnu.ref(); + + for (++iter; iter != phases_.end(); ++iter) + { + nu += iter()*iter().nu(); + } + + return tnu; +} + +Foam::tmp +Foam::multiphaseMixture::calcStf() const +{ + tmp tstf + ( + new surfaceScalarField + ( + IOobject + ( + "stf", + mesh_.time().timeName(), + mesh_ + ), + mesh_, + dimensionedScalar + ( + "stf", + dimensionSet(1, -2, -2, 0, 0), + 0.0 + ) + ) + ); + + surfaceScalarField& stf = tstf.ref(); + + forAllConstIter(PtrDictionary, phases_, iter1) + { + const phase& alpha1 = iter1(); + + PtrDictionary::const_iterator iter2 = iter1; + ++iter2; + + for (; iter2 != phases_.end(); ++iter2) + { + const phase& alpha2 = iter2(); + + sigmaTable::const_iterator sigma = + sigmas_.find(interfacePair(alpha1, alpha2)); + + if (sigma == sigmas_.end()) + { + FatalErrorInFunction + << "Cannot find interface " << interfacePair(alpha1, alpha2) + << " in list of sigma values" + << exit(FatalError); + } + + stf += dimensionedScalar("sigma", dimSigma_, sigma()) + *fvc::interpolate(K(alpha1, alpha2))* + ( + fvc::interpolate(alpha2)*fvc::snGrad(alpha1) + - fvc::interpolate(alpha1)*fvc::snGrad(alpha2) + ); + } + } + + return tstf; +} + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +Foam::multiphaseMixture::multiphaseMixture +( + const volVectorField& U, + const surfaceScalarField& phi, + const volScalarField& voidfraction +) +: + IOdictionary + ( + IOobject + ( + "transportProperties", + U.time().constant(), + U.db(), + IOobject::MUST_READ_IF_MODIFIED, + IOobject::NO_WRITE + ) + ), + + phases_(lookup("phases"), phase::iNew(U, phi)), + + mesh_(U.mesh()), + U_(U), + phi_(phi), + voidfraction_(voidfraction), + rhoPhi_ + ( + IOobject + ( + "rhoPhi", + mesh_.time().timeName(), + mesh_, + IOobject::NO_READ, + IOobject::NO_WRITE + ), + mesh_, + dimensionedScalar("rhoPhi", dimMass/dimTime, 0.0) + ), + surfaceTensionForce_ + ( + IOobject + ( + "surfaceTensionForce", + mesh_.time().timeName(), + mesh_, + IOobject::NO_READ, + IOobject::AUTO_WRITE + ), + mesh_, + dimensionedScalar("surfaceTensionForce", dimensionSet(1, -2, -2, 0, 0), 0.0) + ), + alphas_ + ( + IOobject + ( + "alphas", + mesh_.time().timeName(), + mesh_, + IOobject::NO_READ, + IOobject::AUTO_WRITE + ), + mesh_, + dimensionedScalar("alphas", dimless, 0.0) + ), + + nu_ + ( + IOobject + ( + "nu", + mesh_.time().timeName(), + mesh_, + IOobject::NO_READ, + IOobject::AUTO_WRITE + ), + calcNu() + ), + + sigmas_(lookup("sigmas")), + dimSigma_(1, 0, -2, 0, 0), + deltaN_ + ( + "deltaN", + 1e-8/pow(average(mesh_.V()), 1.0/3.0) + ) +{ + calcAlphas(); + alphas_.write(); + surfaceTensionForce_ = calcStf(); + +} + + +// * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * * // + +Foam::tmp +Foam::multiphaseMixture::rho() const +{ + PtrDictionary::const_iterator iter = phases_.begin(); + + tmp trho = iter()*iter().rho(); + volScalarField& rho = trho.ref(); + + for (++iter; iter != phases_.end(); ++iter) + { + rho += iter()*iter().rho(); + } + + return trho; +} + + +Foam::tmp +Foam::multiphaseMixture::rho(const label patchi) const +{ + PtrDictionary::const_iterator iter = phases_.begin(); + + tmp trho = iter().boundaryField()[patchi]*iter().rho().value(); + scalarField& rho = trho.ref(); + + for (++iter; iter != phases_.end(); ++iter) + { + rho += iter().boundaryField()[patchi]*iter().rho().value(); + } + + return trho; +} + + +Foam::tmp +Foam::multiphaseMixture::mu() const +{ + return rho()*nu(); +// PtrDictionary::const_iterator iter = phases_.begin(); + +// tmp tmu = iter()*iter().rho()*iter().nu(); +// volScalarField& mu = tmu.ref(); + +// for (++iter; iter != phases_.end(); ++iter) +// { +// mu += iter()*iter().rho()*iter().nu(); +// } + +// return tmu; +} + + +Foam::tmp +Foam::multiphaseMixture::mu(const label patchi) const +{ + PtrDictionary::const_iterator iter = phases_.begin(); + + tmp tmu = + iter().boundaryField()[patchi] + *iter().rho().value() + *iter().nu(patchi); + scalarField& mu = tmu.ref(); + + for (++iter; iter != phases_.end(); ++iter) + { + mu += + iter().boundaryField()[patchi] + *iter().rho().value() + *iter().nu(patchi); + } + + return tmu; +} + + +Foam::tmp +Foam::multiphaseMixture::muf() const +{ + + return nuf()*fvc::interpolate(rho()); +// PtrDictionary::const_iterator iter = phases_.begin(); + +// tmp tmuf = +// fvc::interpolate(iter())*iter().rho()*fvc::interpolate(iter().nu()); +// surfaceScalarField& muf = tmuf.ref(); + +// for (++iter; iter != phases_.end(); ++iter) +// { +// muf += +// fvc::interpolate(iter())*iter().rho()*fvc::interpolate(iter().nu()); +// } + +// return tmuf; +} + + +Foam::tmp +Foam::multiphaseMixture::nu() const +{ + return nu_; +} + + +Foam::tmp +Foam::multiphaseMixture::nu(const label patchi) const +{ + //return nu_.boundaryField()[patchi]; + PtrDictionary::const_iterator iter = phases_.begin(); + + tmp tnu = + iter().boundaryField()[patchi] + *iter().nu(patchi); + scalarField& nu = tnu.ref(); + + for (++iter; iter != phases_.end(); ++iter) + { + nu += + iter().boundaryField()[patchi] + *iter().nu(patchi); + } + + return tnu; +} + + +Foam::tmp +Foam::multiphaseMixture::nuf() const +{ + //return muf()/fvc::interpolate(rho()); + PtrDictionary::const_iterator iter = phases_.begin(); + + tmp tnuf = + fvc::interpolate(iter())*fvc::interpolate(iter().nu()); + surfaceScalarField& nuf = tnuf.ref(); + + for (++iter; iter != phases_.end(); ++iter) + { + nuf += + fvc::interpolate(iter())*fvc::interpolate(iter().nu()); + } + + return tnuf; +} + +void Foam::multiphaseMixture::solve() +{ + correct(); + + const Time& runTime = mesh_.time(); + + volScalarField& alpha = phases_.first(); + + const dictionary& alphaControls = mesh_.solverDict("alpha"); + label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles"))); + scalar cAlpha(readScalar(alphaControls.lookup("cAlpha"))); + + if (nAlphaSubCycles > 1) + { + surfaceScalarField rhoPhiSum + ( + IOobject + ( + "rhoPhiSum", + runTime.timeName(), + mesh_ + ), + mesh_, + dimensionedScalar("0", rhoPhi_.dimensions(), 0) + ); + + dimensionedScalar totalDeltaT = runTime.deltaT(); + + for + ( + subCycle alphaSubCycle(alpha, nAlphaSubCycles); + !(++alphaSubCycle).end(); + ) + { + FatalError << "Sub-cycling of the alpha equation not yet implemented!!" << abort(FatalError); + solveAlphas(cAlpha); + rhoPhiSum += (runTime.deltaT()/totalDeltaT)*rhoPhi_; + } + + rhoPhi_ = rhoPhiSum; + } + else + { + solveAlphas(cAlpha); + } + + // Update the mixture kinematic viscosity + nu_ = calcNu(); + surfaceTensionForce_ = calcStf(); +} + + +void Foam::multiphaseMixture::correct() +{ + forAllIter(PtrDictionary, phases_, iter) + { + iter().correct(); + } +} + + +Foam::tmp Foam::multiphaseMixture::nHatfv +( + const volScalarField& alpha1, + const volScalarField& alpha2 +) const +{ + /* + // Cell gradient of alpha + volVectorField gradAlpha = + alpha2*fvc::grad(alpha1) - alpha1*fvc::grad(alpha2); + + // Interpolated face-gradient of alpha + surfaceVectorField gradAlphaf = fvc::interpolate(gradAlpha); + */ + + surfaceVectorField gradAlphaf + ( + fvc::interpolate(alpha2)*fvc::interpolate(fvc::grad(alpha1)) + - fvc::interpolate(alpha1)*fvc::interpolate(fvc::grad(alpha2)) + ); + + // Face unit interface normal + return gradAlphaf/(mag(gradAlphaf) + deltaN_); +} + + +Foam::tmp Foam::multiphaseMixture::nHatf +( + const volScalarField& alpha1, + const volScalarField& alpha2 +) const +{ + // Face unit interface normal flux + return nHatfv(alpha1, alpha2) & mesh_.Sf(); +} + + +// Correction for the boundary condition on the unit normal nHat on +// walls to produce the correct contact angle. + +// The dynamic contact angle is calculated from the component of the +// velocity on the direction of the interface, parallel to the wall. + +void Foam::multiphaseMixture::correctContactAngle +( + const phase& alpha1, + const phase& alpha2, + surfaceVectorField::Boundary& nHatb +) const +{ + const volScalarField::Boundary& gbf + = alpha1.boundaryField(); + + const fvBoundaryMesh& boundary = mesh_.boundary(); + + forAll(boundary, patchi) + { + if (isA(gbf[patchi])) + { + const alphaContactAngleFvPatchScalarField& acap = + refCast(gbf[patchi]); + + vectorField& nHatPatch = nHatb[patchi]; + + vectorField AfHatPatch + ( + mesh_.Sf().boundaryField()[patchi] + /mesh_.magSf().boundaryField()[patchi] + ); + + alphaContactAngleFvPatchScalarField::thetaPropsTable:: + const_iterator tp = + acap.thetaProps().find(interfacePair(alpha1, alpha2)); + + if (tp == acap.thetaProps().end()) + { + FatalErrorInFunction + << "Cannot find interface " << interfacePair(alpha1, alpha2) + << "\n in table of theta properties for patch " + << acap.patch().name() + << exit(FatalError); + } + + bool matched = (tp.key().first() == alpha1.name()); + + scalar theta0 = convertToRad*tp().theta0(matched); + scalarField theta(boundary[patchi].size(), theta0); + + scalar uTheta = tp().uTheta(); + + // Calculate the dynamic contact angle if required + if (uTheta > SMALL) + { + scalar thetaA = convertToRad*tp().thetaA(matched); + scalar thetaR = convertToRad*tp().thetaR(matched); + + // Calculated the component of the velocity parallel to the wall + vectorField Uwall + ( + U_.boundaryField()[patchi].patchInternalField() + - U_.boundaryField()[patchi] + ); + Uwall -= (AfHatPatch & Uwall)*AfHatPatch; + + // Find the direction of the interface parallel to the wall + vectorField nWall + ( + nHatPatch - (AfHatPatch & nHatPatch)*AfHatPatch + ); + + // Normalise nWall + nWall /= (mag(nWall) + SMALL); + + // Calculate Uwall resolved normal to the interface parallel to + // the interface + scalarField uwall(nWall & Uwall); + + theta += (thetaA - thetaR)*tanh(uwall/uTheta); + } + + + // Reset nHatPatch to correspond to the contact angle + + scalarField a12(nHatPatch & AfHatPatch); + + scalarField b1(cos(theta)); + + scalarField b2(nHatPatch.size()); + + forAll(b2, facei) + { + b2[facei] = cos(acos(a12[facei]) - theta[facei]); + } + + scalarField det(1.0 - a12*a12); + + scalarField a((b1 - a12*b2)/det); + scalarField b((b2 - a12*b1)/det); + + nHatPatch = a*AfHatPatch + b*nHatPatch; + + nHatPatch /= (mag(nHatPatch) + deltaN_.value()); + } + } +} + + +Foam::tmp Foam::multiphaseMixture::K +( + const phase& alpha1, + const phase& alpha2 +) const +{ + tmp tnHatfv = nHatfv(alpha1, alpha2); + + correctContactAngle(alpha1, alpha2, tnHatfv.ref().boundaryFieldRef()); + + // Simple expression for curvature + return -fvc::div(tnHatfv & mesh_.Sf()); +} + + +Foam::tmp +Foam::multiphaseMixture::nearInterface() const +{ + tmp tnearInt + ( + new volScalarField + ( + IOobject + ( + "nearInterface", + mesh_.time().timeName(), + mesh_ + ), + mesh_, + dimensionedScalar("nearInterface", dimless, 0.0) + ) + ); + + forAllConstIter(PtrDictionary, phases_, iter) + { + tnearInt.ref() = max(tnearInt(), pos(iter() - 0.01)*pos(0.99 - iter())); + } + + return tnearInt; +} + + +void Foam::multiphaseMixture::solveAlphas +( + const scalar cAlpha +) +{ + static label nSolves=-1; + nSolves++; + + word alphaScheme("div(phi,alpha)"); + word alpharScheme("div(phirb,alpha)"); + + surfaceScalarField phic(mag(phi_/mesh_.magSf())); + phic = min(cAlpha*phic, max(phic)); + + PtrList alphaPhiCorrs(phases_.size()); + int phasei = 0; + + forAllIter(PtrDictionary, phases_, iter) + { + phase& alpha = iter(); + + alphaPhiCorrs.set + ( + phasei, + new surfaceScalarField + ( + "phi" + alpha.name() + "Corr", + fvc::flux + ( + phi_, + alpha, + alphaScheme + ) + ) + ); + + surfaceScalarField& alphaPhiCorr = alphaPhiCorrs[phasei]; + + forAllIter(PtrDictionary, phases_, iter2) + { + phase& alpha2 = iter2(); + + if (&alpha2 == &alpha) continue; + + surfaceScalarField phir(phic*nHatf(alpha, alpha2)); + + alphaPhiCorr += fvc::flux + ( + -fvc::flux(-phir, alpha2, alpharScheme), + alpha, + alpharScheme + ); + } + + MULES::limit + ( + 1.0/mesh_.time().deltaT().value(), + voidfraction_, + alpha, + phi_, + alphaPhiCorr, + zeroField(), + zeroField(), + 1, + 0, + true + ); + + phasei++; + } + + MULES::limitSum(alphaPhiCorrs); + + rhoPhi_ = dimensionedScalar("0", dimensionSet(1, 0, -1, 0, 0), 0); + + volScalarField sumAlpha + ( + IOobject + ( + "sumAlpha", + mesh_.time().timeName(), + mesh_ + ), + mesh_, + dimensionedScalar("sumAlpha", dimless, 0) + ); + + phasei = 0; + + forAllIter(PtrDictionary, phases_, iter) + { + phase& alpha = iter(); + + surfaceScalarField& alphaPhi = alphaPhiCorrs[phasei]; + alphaPhi += upwind(mesh_, phi_).flux(alpha); + + MULES::explicitSolve + ( + voidfraction_, + alpha, + alphaPhi, + zeroField(), + zeroField() + ); + + rhoPhi_ += alphaPhi*alpha.rho(); + + Info<< alpha.name() << " volume fraction, min, max = " + << alpha.weightedAverage(mesh_.V()).value() + << ' ' << min(alpha).value() + << ' ' << max(alpha).value() + << endl; + + sumAlpha += alpha; + + phasei++; + } + + Info<< "Phase-sum volume fraction, min, max = " + << sumAlpha.weightedAverage(mesh_.V()).value() + << ' ' << min(sumAlpha).value() + << ' ' << max(sumAlpha).value() + << endl; + + calcAlphas(); +} + + +bool Foam::multiphaseMixture::read() +{ + if (transportModel::read()) + { + bool readOK = true; + + PtrList phaseData(lookup("phases")); + label phasei = 0; + + forAllIter(PtrDictionary, phases_, iter) + { + readOK &= iter().read(phaseData[phasei++].dict()); + } + + lookup("sigmas") >> sigmas_; + + return readOK; + } + else + { + return false; + } +} + + +// ************************************************************************* // diff --git a/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/multiphaseMixture.H b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/multiphaseMixture.H new file mode 100644 index 00000000..2ae6d903 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/multiphaseMixture.H @@ -0,0 +1,284 @@ +/*---------------------------------------------------------------------------*\ +License + + This 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. + + This code 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 this code. If not, see . + + Copyright (C) 2018- Mathias Vångö, JKU Linz, Austria + +Class + multiphaseMixture + +Description + This class is based on the OpenFOAM(R) Foam::multiphaseMixture class, + which is an incompressible multi-phase mixture with built in solution + for the phase fractions with interface compression for interface-capturing. + It has been extended to include the void fraction in the volume fraction + transport equations. + + Derived from transportModel so that it can be unsed in conjunction with + the incompressible turbulence models. + + Surface tension and contact-angle is handled for the interface + between each phase-pair. + +SourceFiles + multiphaseMixture.C +\*---------------------------------------------------------------------------*/ + +#ifndef multiphaseMixture_H +#define multiphaseMixture_H + +#include "incompressible/transportModel/transportModel.H" +#include "IOdictionary.H" +#include "phase.H" +#include "PtrDictionary.H" +#include "volFields.H" +#include "surfaceFields.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + +/*---------------------------------------------------------------------------*\ + Class multiphaseMixture Declaration +\*---------------------------------------------------------------------------*/ + +class multiphaseMixture +: + public IOdictionary, + public transportModel +{ +public: + + class interfacePair + : + public Pair + { + public: + + class hash + : + public Hash + { + public: + + hash() + {} + + label operator()(const interfacePair& key) const + { + return word::hash()(key.first()) + word::hash()(key.second()); + } + }; + + + // Constructors + + interfacePair() + {} + + interfacePair(const word& alpha1Name, const word& alpha2Name) + : + Pair(alpha1Name, alpha2Name) + {} + + interfacePair(const phase& alpha1, const phase& alpha2) + : + Pair(alpha1.name(), alpha2.name()) + {} + + + // Friend Operators + + friend bool operator== + ( + const interfacePair& a, + const interfacePair& b + ) + { + return + ( + ((a.first() == b.first()) && (a.second() == b.second())) + || ((a.first() == b.second()) && (a.second() == b.first())) + ); + } + + friend bool operator!= + ( + const interfacePair& a, + const interfacePair& b + ) + { + return (!(a == b)); + } + }; + + +private: + + // Private data + + //- Dictionary of phases + PtrDictionary phases_; + + const fvMesh& mesh_; + const volVectorField& U_; + const surfaceScalarField& phi_; + const volScalarField& voidfraction_; + surfaceScalarField rhoPhi_; + surfaceScalarField surfaceTensionForce_; + volScalarField alphas_; + + volScalarField nu_; + + typedef HashTable + sigmaTable; + + sigmaTable sigmas_; + dimensionSet dimSigma_; + + //- Stabilisation for normalisation of the interface normal + const dimensionedScalar deltaN_; + + //- Conversion factor for degrees into radians + static const scalar convertToRad; + + + // Private member functions + + void calcAlphas(); + + tmp calcNu() const; + + void solveAlphas(const scalar cAlpha); + + tmp nHatfv + ( + const volScalarField& alpha1, + const volScalarField& alpha2 + ) const; + + tmp nHatf + ( + const volScalarField& alpha1, + const volScalarField& alpha2 + ) const; + + void correctContactAngle + ( + const phase& alpha1, + const phase& alpha2, + surfaceVectorField::Boundary& nHatb + ) const; + + tmp K(const phase& alpha1, const phase& alpha2) const; + tmp calcStf() const; + +public: + + // Constructors + + //- Construct from components + multiphaseMixture + ( + const volVectorField& U, + const surfaceScalarField& phi, + const volScalarField& voidfraction + ); + + + //- Destructor + virtual ~multiphaseMixture() + {} + + + // Member Functions + + //- Return the phases + const PtrDictionary& phases() const + { + return phases_; + } + + //- Return the velocity + const volVectorField& U() const + { + return U_; + } + + //- Return the volumetric flux + const surfaceScalarField& phi() const + { + return phi_; + } + + const surfaceScalarField& rhoPhi() const + { + return rhoPhi_; + } + + //- Return the mixture density + tmp rho() const; + + //- Return the mixture density for patch + tmp rho(const label patchi) const; + + //- Return the dynamic laminar viscosity + tmp mu() const; + + //- Return the dynamic laminar viscosity for patch + tmp mu(const label patchi) const; + + //- Return the face-interpolated dynamic laminar viscosity + tmp muf() const; + + //- Return the kinematic laminar viscosity + tmp nu() const; + + //- Return the laminar viscosity for patch + tmp nu(const label patchi) const; + + //- Return the face-interpolated dynamic laminar viscosity + tmp nuf() const; + + tmp surfaceTensionForce() const + { + return surfaceTensionForce_; + } + + //- Indicator of the proximity of the interface + // Field values are 1 near and 0 away for the interface. + tmp nearInterface() const; + + //- Solve for the mixture phase-fractions + void solve(); + + //- Correct the mixture properties + void correct(); + + //- Read base transportProperties dictionary + bool read(); +}; + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#endif + +// ************************************************************************* // diff --git a/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/phase/phase.C b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/phase/phase.C new file mode 100644 index 00000000..ae68ff16 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/phase/phase.C @@ -0,0 +1,98 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\/ M anipulation | +------------------------------------------------------------------------------- +License + This file is part of OpenFOAM. + + OpenFOAM is free software: you can redistribute it and/or modify it + under the terms of the GNU General Public License as published by + the Free Software Foundation, either version 3 of the License, or + (at your option) any later version. + + OpenFOAM is distributed in the hope that it will be useful, but WITHOUT + ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or + FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License + for more details. + + You should have received a copy of the GNU General Public License + along with OpenFOAM. If not, see . + +\*---------------------------------------------------------------------------*/ + +#include "phase.H" + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +Foam::phase::phase +( + const word& phaseName, + const dictionary& phaseDict, + const volVectorField& U, + const surfaceScalarField& phi +) +: + volScalarField + ( + IOobject + ( + IOobject::groupName("alpha", phaseName), + U.mesh().time().timeName(), + U.mesh(), + IOobject::MUST_READ, + IOobject::AUTO_WRITE + ), + U.mesh() + ), + name_(phaseName), + phaseDict_(phaseDict), + nuModel_ + ( + viscosityModel::New + ( + IOobject::groupName("nu", phaseName), + phaseDict_, + U, + phi + ) + ), + rho_("rho", dimDensity, phaseDict_) +{} + + +// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // + +Foam::autoPtr Foam::phase::clone() const +{ + NotImplemented; + return autoPtr(NULL); +} + + +void Foam::phase::correct() +{ + nuModel_->correct(); +} + + +bool Foam::phase::read(const dictionary& phaseDict) +{ + phaseDict_ = phaseDict; + + if (nuModel_->read(phaseDict_)) + { + phaseDict_.lookup("rho") >> rho_; + + return true; + } + else + { + return false; + } +} + + +// ************************************************************************* // diff --git a/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/phase/phase.H b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/phase/phase.H new file mode 100644 index 00000000..91341fcf --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/multiphaseMixture/phase/phase.H @@ -0,0 +1,163 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\/ M anipulation | +------------------------------------------------------------------------------- +License + This file is part of OpenFOAM. + + OpenFOAM is free software: you can redistribute it and/or modify it + under the terms of the GNU General Public License as published by + the Free Software Foundation, either version 3 of the License, or + (at your option) any later version. + + OpenFOAM is distributed in the hope that it will be useful, but WITHOUT + ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or + FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License + for more details. + + You should have received a copy of the GNU General Public License + along with OpenFOAM. If not, see . + +Class + Foam::phase + +Description + Single incompressible phase derived from the phase-fraction. + Used as part of the multiPhaseMixture for interface-capturing multi-phase + simulations. + +SourceFiles + phase.C + +\*---------------------------------------------------------------------------*/ + +#ifndef phase_H +#define phase_H + +#include "volFields.H" +#include "dictionaryEntry.H" +#include "incompressible/viscosityModels/viscosityModel/viscosityModel.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + +/*---------------------------------------------------------------------------*\ + Class phase Declaration +\*---------------------------------------------------------------------------*/ + +class phase +: + public volScalarField +{ + // Private data + + word name_; + dictionary phaseDict_; + autoPtr nuModel_; + dimensionedScalar rho_; + + +public: + + // Constructors + + //- Construct from components + phase + ( + const word& name, + const dictionary& phaseDict, + const volVectorField& U, + const surfaceScalarField& phi + ); + + //- Return clone + autoPtr clone() const; + + //- Return a pointer to a new phase created on freestore + // from Istream + class iNew + { + const volVectorField& U_; + const surfaceScalarField& phi_; + + public: + + iNew + ( + const volVectorField& U, + const surfaceScalarField& phi + ) + : + U_(U), + phi_(phi) + {} + + autoPtr operator()(Istream& is) const + { + dictionaryEntry ent(dictionary::null, is); + return autoPtr(new phase(ent.keyword(), ent, U_, phi_)); + } + }; + + + // Member Functions + + const word& name() const + { + return name_; + } + + const word& keyword() const + { + return name(); + } + + //- Return const-access to phase1 viscosityModel + const viscosityModel& nuModel() const + { + return nuModel_(); + } + + //- Return the kinematic laminar viscosity + tmp nu() const + { + return nuModel_->nu(); + } + + //- Return the laminar viscosity for patch + tmp nu(const label patchi) const + { + return nuModel_->nu(patchi); + } + + //- Return const-access to phase1 density + const dimensionedScalar& rho() const + { + return rho_; + } + + //- Correct the phase properties + void correct(); + + //-Inherit read from volScalarField + using volScalarField::read; + + //- Read base transportProperties dictionary + bool read(const dictionary& phaseDict); +}; + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#endif + +// ************************************************************************* // diff --git a/applications/solvers/cfdemSolverMultiphase/pEqn.H b/applications/solvers/cfdemSolverMultiphase/pEqn.H new file mode 100644 index 00000000..e5a374f0 --- /dev/null +++ b/applications/solvers/cfdemSolverMultiphase/pEqn.H @@ -0,0 +1,73 @@ +{ + volScalarField rAU("rAU", 1.0/UEqn.A()); + surfaceScalarField rAUepsf("rAUepsf", fvc::interpolate(rAU*voidfraction)); + surfaceScalarField rAUepsSqf("rAUepsSqf", fvc::interpolate(rAU*voidfraction*voidfraction)); + volVectorField Ueps("Ueps", U * voidfraction); + + volVectorField HbyA(constrainHbyA(rAU*UEqn.H(), U, p_rgh)); + + surfaceScalarField phiHbyA + ( + "phiHbyA", + fvc::flux(HbyA*voidfraction) + + fvc::interpolate(voidfraction*rho*rAU)*fvc::ddtCorr(U, phi) + ); + + adjustPhi(phiHbyA, U, p_rgh); + + if (modelType == "A") + rAUepsf = rAUepsSqf; + + surfaceScalarField phig (-ghf*fvc::snGrad(rho)*rAUepsf*mesh.magSf()); + + surfaceScalarField phiSt (mixture.surfaceTensionForce()*rAUepsSqf*mesh.magSf()); + + surfaceScalarField phiS (fvc::flux(voidfraction*Us*Ksl*rAU)); + + phiHbyA += phig + phiSt + phiS; + + // Update the pressure BCs to ensure flux consistency + constrainPressure(p_rgh, Ueps, phiHbyA, rAUepsf); + + while (pimple.correctNonOrthogonal()) + { + fvScalarMatrix p_rghEqn + ( + fvm::laplacian(rAUepsf, p_rgh) == particleCloud.ddtVoidfraction() + fvc::div(phiHbyA) + ); + + p_rghEqn.setReference(pRefCell, getRefCellValue(p_rgh, pRefCell)); + + p_rghEqn.solve(mesh.solver(p_rgh.select(pimple.finalInnerIter()))); + + if (pimple.finalNonOrthogonalIter()) + { + phi = phiHbyA - p_rghEqn.flux(); + + p_rgh.relax(); + + if (modelType == "A") + U = HbyA + voidfraction*rAU*fvc::reconstruct((phig-p_rghEqn.flux()+phiSt)/rAUepsf) + rAU*Us*Ksl; + else + U = HbyA + rAU*fvc::reconstruct((phig-p_rghEqn.flux()+phiSt)/rAUepsf) + rAU*Us*Ksl; + + U.correctBoundaryConditions(); + fvOptions.correct(U); + } + } + + #include "continuityErrs.H" + + p == p_rgh + rho*gh; + + if (p_rgh.needReference()) + { + p += dimensionedScalar + ( + "p", + p.dimensions(), + pRefValue - getRefCellValue(p, pRefCell) + ); + p_rgh = p - rho*gh; + } +} diff --git a/applications/solvers/cfdemSolverPiso/Make/options b/applications/solvers/cfdemSolverPiso/Make/options index 22cdcc2b..6c0806b0 100644 --- a/applications/solvers/cfdemSolverPiso/Make/options +++ b/applications/solvers/cfdemSolverPiso/Make/options @@ -18,6 +18,7 @@ EXE_LIBS = \ -lincompressibleTransportModels \ -lfiniteVolume \ -lmeshTools \ + -lfvOptions \ -l$(CFDEM_LIB_NAME) \ $(CFDEM_ADD_LIB_PATHS) \ $(CFDEM_ADD_LIBS) diff --git a/applications/solvers/cfdemSolverPiso/UEqn.H b/applications/solvers/cfdemSolverPiso/UEqn.H index ad5699aa..bfc3121d 100644 --- a/applications/solvers/cfdemSolverPiso/UEqn.H +++ b/applications/solvers/cfdemSolverPiso/UEqn.H @@ -4,6 +4,7 @@ fvVectorMatrix UEqn + fvm::div(phi,U) - fvm::Sp(fvc::div(phi),U) + particleCloud.divVoidfractionTau(U, voidfraction) == + fvOptions(U) - fvm::Sp(Ksl/rho,U) ); diff --git a/doc/.gitignore b/doc/.gitignore index 44599544..9bbc53b6 100644 --- a/doc/.gitignore +++ b/doc/.gitignore @@ -1,7 +1,12 @@ -*.o -*.d -*.a -*.dep -log_* -log.* +# ignore generated files and folders +*.html +*.rst +*.inv *~ +searchindex.js + +_build +_sources +_static +_images + diff --git a/doc/CFDEMcoupling_Manual.html b/doc/CFDEMcoupling_Manual.html deleted file mode 100644 index eb31ac01..00000000 --- a/doc/CFDEMcoupling_Manual.html +++ /dev/null @@ -1,244 +0,0 @@ - -
CFDEMproject WWW Site -
- - - - - - - - -
- -

CFDEMcoupling Documentation -

-
- -
-
-
- -

1. Contents -

-

The CFDEMcoupling documentation is organized into the following sections. If you find any errors or omissions in this manual or have suggestions for useful information to add, please send an email to the developers so the CFDEMcoupling documentation can be improved. -

-1.1 About CFDEMcoupling
-1.2 Installation
-1.3 Tutorials
-1.4 couplingProperties dictionary
-1.5 liggghtsCommands dictionary
-1.6 Models and solvers
- -
- -

1.1 About CFDEMcoupling -

-

CFDEM coupling provides an open source parallel coupled CFD-DEM framework combining the strengths of LIGGGHTS DEM code and the Open Source CFD package OpenFOAM(R)(*). The CFDEMcoupling toolbox allows to expand standard CFD solvers of OpenFOAM(R)(*) to include a coupling to the DEM code LIGGGHTS. In this toolbox the particle representation within the CFD solver is organized by "cloud" classes. Key functionalities are organised in sub-models (e.g. force models, data exchange models, etc.) which can easily be selected and combined by dictionary settings. -

-

The coupled solvers run fully parallel on distributed-memory clusters. Features are: -

-
  • its modular approach allows users to easily implement new models - -
  • its MPI parallelization enables to use it for large scale problems - -
  • the forum on CFD-DEM gives the possibility to exchange with other users / developers - -
  • the use of GIT allows to easily update to the latest version - -
  • basic documentation is provided - - -
-

The file structure: -

-
  • src directory including the source files of the coupling toolbox and models - -
  • applications directory including the solver files for coupled CFD-DEM simulations - -
  • doc directory including the documentation of CFDEMcoupling - -
  • tutorials directory including basic tutorial cases showing the functionality - - -
-

Details on installation are given on the CFDEMproject WWW Site . -The functionality of this CFD-DEM framework is described via tutorial cases showing how to use different solvers and models. -

-

CFDEMcoupling stands for Computational Fluid Dynamics (CFD) -Discrete Element Method (DEM) coupling. -

-

CFDEMcoupling is an open-source code, distributed freely under the terms of the GNU Public License (GPL). -

-

Core development of CFDEMcoupling is done by Christoph Goniva and Christoph Kloss, both at DCS Computing GmbH, 2012 -

-

This documentation was written by Christoph Goniva, DCS Computing GmbH, 2012 -

-
- -

(*) This offering is not approved or endorsed by OpenCFD Limited, the producer of the OpenFOAM software and owner of the OPENFOAM® and OpenCFD® trade marks. OPENFOAM® is a registered trade mark of OpenCFD Limited, a wholly owned subsidiary of the ESI Group. -

-
- -

1.2 Installation -

-

Please follow the installation routine provided at www.cfdem.com. -In order to get the latest code version, please use the git repository at http://github.com (githubAccess). -

-
- -

1.3 Tutorials -

-

General: -

-

Each solver of the CFDEMcoupling comes with at least one tutorial example, showing its functionality and correct usage. Provided that the installation is correct, the tutorials can be run via "Allrun.sh" shell scripts. These scripts perform all necessary steps (preprocessing, run, postprocessing, visualization). -

-

Location: -

-

The tutorials can be found in the directory $CFDEM_PROJECT_DIR/tutorials, which can be reached by typing "cfdemTut" -

-

Structure: -

-

Each case is structured in a directory called "CFD" covering the CFD relevant settings and data, and a dirctory called "DEM" covering the DEM relevant settings and data. This allows to easily expand a pure CFD or DEM simulation case to a coupled case. -

-

Usage: -

-

Provided that the installation is correct, the tutorials can be run via "Allrun.sh" shell script, executed by typing "./Allrun.sh". The successful run of the script might need some third party software (e.g. octave, evince, etc.). -

-

Settings: -

-

The main settings of a simulation are done via dictionaries: -

-

The DEM setup of each case is defined by a LIGGGHTS input file located in $caseDir/DEM (e.g. in.liggghts_init). For details on the LIGGGHTS setup, please have a look at the LIGGGHTS manual. -

-

Standard CFD settings are defined in $caseDir/CFD/constant (e.g. transportProperties, RASproperties, etc.) and $caseDir/CFD/system (e.g. fvSchemes, controlDict). You can find more information on that in OpenFOAM(R)(*) documentations (www.openFoam.com)(*). -

-

Settings of the coupling routines are defined in $caseDir/CFD/constant/couplingProperies (e.g. force models, data exchange model, etc.) and $caseDir/CFD/constant/liggghtsCommands (allows to execute a LIGGGHTS command during a coupled simulation). -

-
- -

1.4 "couplingProperties" dictionary -

-

General: -

-

In the "couplingProperties" dictionary the setup of the coupling routines of the CFD-DEM simulation are defined. -

-

Location: $caseDir/CFD/constant -

-

Structure: -

-

The dictionary is divided into two parts, "sub-models & settings" and "sub-model properties". -

-

In "sub-models & settings" the following routines must be specified: -

-
  • modelType - -
  • couplingInterval - -
  • voidFractionModel - -
  • locateModel - -
  • meshMotionModel - -
  • regionModel - -
  • IOModel - -
  • dataExchangeModel - -
  • averagingModel - -
  • forceModels - -
  • momCoupleModels - -
  • turbulenceModelType - - -
-

In "sub-model properties" sub-dictionaries might be defined to specify model specific parameters. -

-

Settings: -

-

Reasonable example settings for the "couplingProperties" dictionary are given in the tutorial cases. -

-
modelType 
-
-

"modelType" refers to the formulation of the equations to be solved. Choose "A", "B" or "Bfull", according to Zhou et al. (2010): "Discrete particle simulation of particle-fluid flow: model formulations and their applicability", JFM. "A" requires the use of the force models gradPForce and viscForce, whereas "B" requires the force model "Archimedes". "Bfull" refers to model type I. -

-
couplingInterval 
-
-

The coupling interval determines the time passing between two CFD-DEM data exchanges. -

-

A useful procedure would be: -1) Set the DEM timestep in the in.xxx file according to the needs of the pure DEM problem. -2) Set the "couplingInterval", which refers to the DEM timesteps. Depending on the problem you will need to have a close (small couplingInterval) or loose coupling. -3) Choose the CFD timestep in the controlDict. It must be equal to or smaller than the coupling time, otherwise you will get the error: "Error - TS bigger than coupling interval!". -

-

Example: DEMts=0.00001s, couplingInterval=10 exchange data (=couple) will happen every 0.0001s. -

-
- -

1.5 "liggghtsCommands" dictionary -

-

General: -

-

In the "liggghtsCommands" dictionary liggghts commands being executed during a coupled CFD-DEM simulation are specified. -

-

Location: $caseDir/CFD/constant -

-

Structure: -

-

The dictionary is divided into two parts, first a list of "liggghtsCommandModels" is defined, then the settings for each model must be specified. -

-

Settings: -

-

Reasonable example settings for the "liggghtsCommands" dictionary are given in the tutorial cases. -

-
- -

1.6 Models/Solvers -

-

This section lists all CFDEMcoupling sub-models and solvers alphabetically, with a separate -listing below of styles within certain commands. -

-
- - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -
IOModelIOModel_basicIO
IOModel_noIOIOModel_sophIO
IOModel_trackIOaveragingModel
averagingModel_denseaveragingModel_dilute
cfdemSolverIBcfdemSolverPiso
cfdemSolverPisoScalarclockModel
clockModel_noClockclockModel_standardClock
dataExchangeModeldataExchangeModel_noDataExchange
dataExchangeModel_oneWayVTKdataExchangeModel_twoWayFiles
dataExchangeModel_twoWayMPIdataExchangeModel_twoWayMany2Many
forceModelforceModel_Archimedes
forceModel_ArchimedesIBforceModel_DiFeliceDrag
forceModel_dSauterforceModel_GidaspowDrag
forceModel_KochHillDragforceModel_LaEuScalarTemp
forceModel_MeiLiftforceModel_SchillerNaumannDrag
forceModel_ShirgaonkarIBforceModel_fieldStore
forceModel_pdCorrelationforceModel_gradPForce
forceModel_noDragforceModel_particleCellVolume
forceModel_virtualMassForceforceModel_viscForce
forceSubModelforceSubModel_ImEx
forceSubModel_ImExCorrliggghtsCommandModel
liggghtsCommandModel_executeliggghtsCommandModel_readLiggghtsData
liggghtsCommandModel_runLiggghtsliggghtsCommandModel_writeLiggghts
locateModellocateModel_engineSearch
locateModel_engineSearchIBlocateModel_engineSearchMany2Many
locateModel_standardSearchlocateModel_turboEngineSearch
meshMotionModelmeshMotionModel_noMeshMotion
momCoupleModelmomCoupleModel_explicitCouple
momCoupleModel_implicitCouplemomCoupleModel_noCouple
probeModelprobeModel_noProbe
regionModelregionModel_allRegion
smoothingModelsmoothingModel_constDiffSmoothing
smoothingModel_noSmoothingvoidfractionModel
voidfractionModel_GaussVoidFractionvoidfractionModel_IBVoidFraction
voidfractionModel_bigParticleVoidFractionvoidfractionModel_centreVoidFraction
voidfractionModel_dividedVoidFraction -
- - diff --git a/doc/CFDEMcoupling_Manual.pdf b/doc/CFDEMcoupling_Manual.pdf deleted file mode 100644 index 1ba7d809..00000000 Binary files a/doc/CFDEMcoupling_Manual.pdf and /dev/null differ diff --git a/doc/CFDEMcoupling_Manual.txt b/doc/CFDEMcoupling_Manual.txt index 5a004c21..a48f1708 100644 --- a/doc/CFDEMcoupling_Manual.txt +++ b/doc/CFDEMcoupling_Manual.txt @@ -1,309 +1,93 @@ -"CFDEMproject WWW Site"_lws :c - -:link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) -:link(of,http://www.openfoam.com) -:link(lig,http://www.cfdem.com) +"CFDEMproject Website"_lig :c :line -CFDEMcoupling Documentation :h2,c +CFDEMcoupling Documentation :h1,c + +Academic version :c + + + + :line :c,image(Portfolio_CFDEMcoupling.png) :line + + +NOTE: + +This is an academic adaptation of the CFDEMcoupling software package, released by +the Department of Particulate Flow Modelling at "Johannes Kepler University +Linz"_http://www.jku.at, Austria. +This offering is not approved or endorsed by DCS Computing GmbH, the producer of +the LIGGGHTS® and CFDEM®coupling software and owner of the LIGGGHTS +and CFDEM® trade marks. + + + + + 1. Contents :h3 + -The CFDEMcoupling documentation is organized into the following sections. If you find any errors or omissions in this manual or have suggestions for useful information to add, please send an email to the developers so the CFDEMcoupling documentation can be improved. +The CFDEMcoupling documentation is organized into the following sections. If you +find any errors or omissions in this manual or have suggestions for useful +information to add, please send an email to the developers so the CFDEMcoupling +documentation can be improved. -1.1 "About CFDEMcoupling"_#1_1 -1.2 "Installation"_#1_2 -1.3 "Tutorials"_#1_3 -1.4 "couplingProperties dictionary"_#1_4 -1.5 "liggghtsCommands dictionary"_#1_5 -1.6 "Models and solvers"_#cmd_5 :all(b) + +"About CFDEMcoupling"_CFDEMcoupling_about.html :olb,l +"Installation"_CFDEMcoupling_install.html :l +"Tutorials"_CFDEMcoupling_tutorials.html :l +"Dictionaries"_CFDEMcoupling_dicts.html :l + 4.1 "couplingProperties dictionary"_CFDEMcoupling_dicts.html#couplingProperties :ulb,b + 4.2 "liggghtsCommands dictionary"_CFDEMcoupling_dicts.html#liggghtsCommands :ule,b +"Solvers"_CFDEMcoupling_solvers.html :l +"Models"_CFDEMcoupling_models.html :l +:ole + -:line + -{src} directory including the source files of the coupling toolbox and models :ulb,l -{applications} directory including the solver files for coupled CFD-DEM simulations :l -{doc} directory including the documentation of CFDEMcoupling :l -{tutorials} directory including basic tutorial cases showing the functionality :l -:ule +:link(of,http://www.openfoam.org) +:link(lig,http://www.cfdem.com) -Details on installation are given on the "CFDEMproject WWW Site"_lws . -The functionality of this CFD-DEM framework is described via "tutorial cases"_#_1_2 showing how to use different solvers and models. -CFDEMcoupling stands for Computational Fluid Dynamics (CFD) -Discrete Element Method (DEM) coupling. - -CFDEMcoupling is an open-source code, distributed freely under the terms of the GNU Public License (GPL). - -Core development of CFDEMcoupling is done by Christoph Goniva and Christoph Kloss, both at DCS Computing GmbH, 2012 - -This documentation was written by Christoph Goniva, DCS Computing GmbH, 2012 - -:line -(*) This offering is not approved or endorsed by OpenCFD Limited, the producer of the OpenFOAM software and owner of the OPENFOAM® and OpenCFD® trade marks. OPENFOAM® is a registered trade mark of OpenCFD Limited, a wholly owned subsidiary of the ESI Group. - -:line - -1.2 Installation :link(1_2),h4 - -Please follow the installation routine provided at www.cfdem.com. -In order to get the latest code version, please use the git repository at http://github.com ("githubAccess"_githubAccess_public.html). - -:line - -1.3 Tutorials :link(1_3),h4 - -[General:] - -Each solver of the CFDEMcoupling comes with at least one tutorial example, showing its functionality and correct usage. Provided that the installation is correct, the tutorials can be run via "Allrun.sh" shell scripts. These scripts perform all necessary steps (preprocessing, run, postprocessing, visualization). - -[Location:] - -The tutorials can be found in the directory $CFDEM_PROJECT_DIR/tutorials, which can be reached by typing "cfdemTut" - -[Structure:] - -Each case is structured in a directory called "CFD" covering the CFD relevant settings and data, and a dirctory called "DEM" covering the DEM relevant settings and data. This allows to easily expand a pure CFD or DEM simulation case to a coupled case. - -[Usage:] - -Provided that the installation is correct, the tutorials can be run via "Allrun.sh" shell script, executed by typing "./Allrun.sh". The successful run of the script might need some third party software (e.g. octave, evince, etc.). - -[Settings:] - -The main settings of a simulation are done via dictionaries: - -The DEM setup of each case is defined by a "LIGGGHTS"_lig input file located in $caseDir/DEM (e.g. in.liggghts_init). For details on the "LIGGGHTS"_lig setup, please have a look at the "LIGGGHTS"_lig manual. - -Standard CFD settings are defined in $caseDir/CFD/constant (e.g. transportProperties, RASproperties, etc.) and $caseDir/CFD/system (e.g. fvSchemes, controlDict). You can find more information on that in "OpenFOAM(R)(*)"_of documentations (www.openFoam.com)(*). - -Settings of the coupling routines are defined in $caseDir/CFD/constant/"couplingProperies"_#1_3 (e.g. force models, data exchange model, etc.) and $caseDir/CFD/constant/"liggghtsCommands"_#1_3 (allows to execute a LIGGGHTS command during a coupled simulation). - -:line - -1.4 "couplingProperties" dictionary :link(1_4),h4 - -[General:] - -In the "couplingProperties" dictionary the setup of the coupling routines of the CFD-DEM simulation are defined. - -[Location:] $caseDir/CFD/constant - -[Structure:] - -The dictionary is divided into two parts, "sub-models & settings" and "sub-model properties". - -In "sub-models & settings" the following routines must be specified: - -modelType :ulb,l -couplingInterval :l -voidFractionModel :l -locateModel :l -meshMotionModel :l -regionModel :l -IOModel :l -dataExchangeModel :l -averagingModel :l -forceModels :l -momCoupleModels :l -turbulenceModelType :l -:ule - -In "sub-model properties" sub-dictionaries might be defined to specify model specific parameters. - -[Settings:] - -Reasonable example settings for the "couplingProperties" dictionary are given in the tutorial cases. - -modelType :pre - -"modelType" refers to the formulation of the equations to be solved. Choose "A", "B" or "Bfull", according to Zhou et al. (2010): "Discrete particle simulation of particle-fluid flow: model formulations and their applicability", JFM. "A" requires the use of the force models gradPForce and viscForce, whereas "B" requires the force model "Archimedes". "Bfull" refers to model type I. - -couplingInterval :pre - -The coupling interval determines the time passing between two CFD-DEM data exchanges. - -A useful procedure would be: -1) Set the DEM timestep in the in.xxx file according to the needs of the pure DEM problem. -2) Set the "couplingInterval", which refers to the DEM timesteps. Depending on the problem you will need to have a close (small couplingInterval) or loose coupling. -3) Choose the CFD timestep in the controlDict. It must be equal to or smaller than the coupling time, otherwise you will get the error: "Error - TS bigger than coupling interval!". - -Example: DEMts=0.00001s, couplingInterval=10 exchange data (=couple) will happen every 0.0001s. - -:line - -1.5 "liggghtsCommands" dictionary :h4,link(1_5) - -[General:] - -In the "liggghtsCommands" dictionary liggghts commands being executed during a coupled CFD-DEM simulation are specified. - -[Location:] $caseDir/CFD/constant - -[Structure:] - -The dictionary is divided into two parts, first a list of "liggghtsCommandModels" is defined, then the settings for each model must be specified. - -[Settings:] - -Reasonable example settings for the "liggghtsCommands" dictionary are given in the tutorial cases. - -:line - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -1.6 Models/Solvers :h4,link(cmd_5),link(comm) - -This section lists all CFDEMcoupling sub-models and solvers alphabetically, with a separate -listing below of styles within certain commands. - - -"IOModel"_IOModel.html, -"IOModel_basicIO"_IOModel_basicIO.html, -"IOModel_noIO"_IOModel_noIO.html, -"IOModel_sophIO"_IOModel_sophIO.html, -"IOModel_trackIO"_IOModel_trackIO.html, -"averagingModel"_averagingModel.html, -"averagingModel_dense"_averagingModel_dense.html, -"averagingModel_dilute"_averagingModel_dilute.html, -"cfdemSolverIB"_cfdemSolverIB.html, -"cfdemSolverPiso"_cfdemSolverPiso.html, -"cfdemSolverPisoScalar"_cfdemSolverPisoScalar.html, -"clockModel"_clockModel.html, -"clockModel_noClock"_clockModel_noClock.html, -"clockModel_standardClock"_clockModel_standardClock.html, -"dataExchangeModel"_dataExchangeModel.html, -"dataExchangeModel_noDataExchange"_dataExchangeModel_noDataExchange.html, -"dataExchangeModel_oneWayVTK"_dataExchangeModel_oneWayVTK.html, -"dataExchangeModel_twoWayFiles"_dataExchangeModel_twoWayFiles.html, -"dataExchangeModel_twoWayMPI"_dataExchangeModel_twoWayMPI.html, -"dataExchangeModel_twoWayMany2Many"_dataExchangeModel_twoWayMany2Many.html, -"forceModel"_forceModel.html, -"forceModel_Archimedes"_forceModel_Archimedes.html, -"forceModel_ArchimedesIB"_forceModel_ArchimedesIB.html, -"forceModel_DiFeliceDrag"_forceModel_DiFeliceDrag.html, -"forceModel_dSauter"_forceModel_dSauter.html, -"forceModel_GidaspowDrag"_forceModel_GidaspowDrag.html, -"forceModel_KochHillDrag"_forceModel_KochHillDrag.html, -"forceModel_LaEuScalarTemp"_forceModel_LaEuScalarTemp.html, -"forceModel_MeiLift"_forceModel_MeiLift.html, -"forceModel_SchillerNaumannDrag"_forceModel_SchillerNaumannDrag.html, -"forceModel_ShirgaonkarIB"_forceModel_ShirgaonkarIB.html, -"forceModel_fieldStore"_forceModel_fieldStore.html, -"forceModel_pdCorrelation"_forceModel_pdCorrelation.html, -"forceModel_gradPForce"_forceModel_gradPForce.html, -"forceModel_noDrag"_forceModel_noDrag.html, -"forceModel_particleCellVolume"_forceModel_particleCellVolume.html, -"forceModel_virtualMassForce"_forceModel_virtualMassForce.html, -"forceModel_viscForce"_forceModel_viscForce.html, -"forceSubModel"_forceSubModel.html, -"forceSubModel_ImEx"_forceSubModel_ImEx.html, -"forceSubModel_ImExCorr"_forceSubModel_ImExCorr.html, -"liggghtsCommandModel"_liggghtsCommandModel.html, -"liggghtsCommandModel_execute"_liggghtsCommandModel_execute.html, -"liggghtsCommandModel_readLiggghtsData"_liggghtsCommandModel_readLiggghtsData.html, -"liggghtsCommandModel_runLiggghts"_liggghtsCommandModel_runLiggghts.html, -"liggghtsCommandModel_writeLiggghts"_liggghtsCommandModel_writeLiggghts.html, -"locateModel"_locateModel.html, -"locateModel_engineSearch"_locateModel_engineSearch.html, -"locateModel_engineSearchIB"_locateModel_engineSearchIB.html, -"locateModel_engineSearchMany2Many"_locateModel_engineSearchMany2Many.html, -"locateModel_standardSearch"_locateModel_standardSearch.html, -"locateModel_turboEngineSearch"_locateModel_turboEngineSearch.html, -"meshMotionModel"_meshMotionModel.html, -"meshMotionModel_noMeshMotion"_meshMotionModel_noMeshMotion.html, -"momCoupleModel"_momCoupleModel.html, -"momCoupleModel_explicitCouple"_momCoupleModel_explicitCouple.html, -"momCoupleModel_implicitCouple"_momCoupleModel_implicitCouple.html, -"momCoupleModel_noCouple"_momCoupleModel_noCouple.html, -"probeModel"_probeModel.html, -"probeModel_noProbe"_probeModel_noProbe.html, -"regionModel"_regionModel.html, -"regionModel_allRegion"_regionModel_allRegion.html, -"smoothingModel"_smoothingModel.html, -"smoothingModel_constDiffSmoothing"_smoothingModel_constDiffSmoothing.html, -"smoothingModel_noSmoothing"_smoothingModel_noSmoothing.html, -"voidfractionModel"_voidFractionModel.html, -"voidfractionModel_GaussVoidFraction"_voidFractionModel_GaussVoidFraction.html, -"voidfractionModel_IBVoidFraction"_voidFractionModel_IBVoidFraction.html, -"voidfractionModel_bigParticleVoidFraction"_voidFractionModel_bigParticleVoidFraction.html, -"voidfractionModel_centreVoidFraction"_voidFractionModel_centreVoidFraction.html, -"voidfractionModel_dividedVoidFraction"_voidFractionModel_dividedVoidFraction.html :tb(c=2,ea=c) diff --git a/doc/CFDEMcoupling_about.txt b/doc/CFDEMcoupling_about.txt new file mode 100644 index 00000000..1071471e --- /dev/null +++ b/doc/CFDEMcoupling_about.txt @@ -0,0 +1,99 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +1. About CFDEMcoupling :link(1_1),h3 + + +CFDEMcoupling provides an open-source parallel coupled CFD-DEM framework +combining the strengths of the "LIGGGHTS"_lig DEM code and the open-source CFD +package "OpenFOAM®"_of (*). The CFDEMcoupling toolbox allows to expand standard +CFD solvers of "OpenFOAM®"_of (*) to include a coupling to the DEM code +"LIGGGHTS"_lig. + + + + + +In this toolbox the particle representation within the CFD +solver is organized by "cloud" classes. Key functionalities are organized in +sub-models (e.g. force models, data exchange models, etc.) which can easily be +selected and combined by dictionary settings. + +The coupled solvers run fully parallel on distributed-memory clusters. Features +are: + +its modular approach allows users to easily implement new models :ulb,l +its MPI parallelization enables to use it for large scale problems :l +the "forum"_lig on CFD-DEM gives the possibility to exchange with other users / developers :l +the use of Git allows to easily update to the latest version :l +basic documentation is provided :l +:ule + +The file structure: + +{src} directory including the source files of the coupling toolbox and models :ulb,l +{applications} directory including the solver files for coupled CFD-DEM simulations :l +{doc} directory including the documentation of CFDEMcoupling :l +{tutorials} directory including basic tutorial cases showing the functionality :l +:ule + +Details on installation are given on the "CFDEMproject Website"_lig . +The functionality of this CFD-DEM framework is described via "tutorial +cases"_CFDEMcoupling_tutorials.html showing how to use different solvers and +models. + +CFDEMcoupling stands for Computational Fluid Dynamics (CFD) - Discrete Element +Method (DEM) coupling. + +CFDEMcoupling is an open-source code, distributed freely under the terms of the +"GNU Public License (GPL)"_https://www.gnu.org/licenses/gpl-3.0.en.html. + +Core development of the public version of CFDEMcoupling is done by Christoph +Goniva and Christoph Kloss, both at DCS Computing GmbH. + +The original version of this documentation was written by Christoph Goniva, DCS +Computing GmbH, 2012. + +:line + + +NOTE: +(*) This offering is not approved or endorsed by OpenCFD Limited, producer and +distributor of the OpenFOAM software via www.openfoam.com, and owner of the +OPENFOAM® and OpenCFD® trade marks. +OPENFOAM® is a registered trade mark of OpenCFD Limited, producer and +distributor of the OpenFOAM software via www.openfoam.com. + + + + +:link(of,http://www.openfoam.org) +:link(lig,http://www.cfdem.com) + diff --git a/doc/CFDEMcoupling_dicts.txt b/doc/CFDEMcoupling_dicts.txt new file mode 100644 index 00000000..3c70bf4b --- /dev/null +++ b/doc/CFDEMcoupling_dicts.txt @@ -0,0 +1,105 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +4. Dictionaries :link(1_4),h3 + +4.1 couplingProperties dictionary :link(couplingProperties),h4 + +[General:] + +In the {couplingProperties} dictionary the setup of the coupling routines of the +CFD-DEM simulation are defined. + +[Location:] $caseDir/CFD/constant + +[Structure:] + +The dictionary is divided into two parts, "sub-models & settings" and "sub-model +properties". + +In "sub-models & settings" the following routines must be specified: + +modelType :ulb,l +couplingInterval :l +voidFractionModel :l +locateModel :l +meshMotionModel :l +regionModel :l +IOModel :l +dataExchangeModel :l +averagingModel :l +forceModels :l +momCoupleModels :l +turbulenceModelType :l +:ule + +In "sub-model properties" sub-dictionaries might be defined to specify model +specific parameters. + +[Settings:] + +Reasonable example settings for the {couplingProperties} dictionary are given in +the tutorial cases. + +modelType :pre + +{modelType} refers to the formulation of the equations to be solved. Choose "A", +"B" or "Bfull", according to "Zhou et al. (2010)"_#Zhou2010. Model "A" requires +the use of the force models gradPForce and viscForce, whereas "B" requires the +force model "Archimedes". "Bfull" refers to model type I. + +couplingInterval :pre + +The coupling interval determines the time passing between two CFD-DEM data +exchanges. + +A useful procedure would be: + +Set the DEM time step in the LIGGGHTS input file according to the needs of the +pure DEM problem. :olb,l +Set the {couplingInterval}, which refers to the DEM time steps. Depending on the +problem you will need to have a close (small couplingInterval) or loose +coupling. :l +Choose the CFD time step in the controlDict. It must be equal to or smaller than +the coupling time, otherwise you will get the error: "Error - TS bigger than +coupling interval!". :l,ole + +[Example:] + +Choosing DEMts=0.00001s and couplingInterval=10 means that an exchange of data +(=coupling) will happen every 0.0001s. + +:line + +4.2 liggghtsCommands dictionary :link(liggghtsCommands),h4 + +[General:] + +In the {liggghtsCommands} dictionary LIGGGHTS commands which are to be executed +during a coupled CFD-DEM simulation are specified. + +[Location:] $caseDir/CFD/constant + +[Structure:] + +The dictionary is divided into two parts, first a list of +"liggghtsCommandModels"_CFDEMcoupling_models.html#lcm is defined, then the +settings for each model must be specified. + +[Settings:] + +Reasonable example settings for the {liggghtsCommands} dictionary are given in +the tutorial cases. + +:line + +:link(Zhou2010) +[(Zhou, 2010)] +"Discrete particle simulation of particle-fluid flow: model formulations and their applicability", +Zhou, Z. Y., Kuang, S. B., Chu, K. W. and Yu, A. B., J. Fluid Mech., 661, pp. 482-510 (2010) + + diff --git a/doc/CFDEMcoupling_install.txt b/doc/CFDEMcoupling_install.txt new file mode 100644 index 00000000..7878649b --- /dev/null +++ b/doc/CFDEMcoupling_install.txt @@ -0,0 +1,220 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +2. Installation :link(1_2),h3 + +In order to get the latest code version, please use the git repository at +"http://github.com"_https://github.com/ParticulateFlow. + + +2.1 Installing OpenFOAM :h4 + +2.1.1 Obtain a copy of the source code :h5 + +In the CFDEMcoupling repository take a look at the file + +src/lagrangian/cfdemParticle/cfdTools/versionInfo.H :pre + +to find out the latest tested version of LIGGGHTS and OpenFOAM that work with +CFDEMcoupling. As of this writing the version of OpenFOAM to be used is 4.x. + +You can then basically follow the instructions at +"openfoam.org"_https://openfoam.org/download/source/, cloning OpenFOAM from the +git repository. + +cd $HOME +mkdir OpenFOAM +cd OpenFOAM +git clone https://github.com/OpenFOAM/OpenFOAM-4.x.git :pre + +Clone the corresponding third party packages to the OpenFOAM folder. + +git clone https://github.com/OpenFOAM/ThirdParty-4.x.git :pre + +Switch to root user with sudo + +sudo su - :pre + +Install dependent packages required for OpenFOAM on Ubuntu by executing the +following commands: + +apt-get install build-essential flex bison cmake zlib1g-dev libboost-system-dev libboost-thread-dev libopenmpi-dev openmpi-bin gnuplot libreadline-dev libncurses-dev libxt-dev +apt-get install qt4-dev-tools libqt4-dev libqt4-opengl-dev freeglut3-dev libqtwebkit-dev +apt-get install libcgal-dev :pre + +2.1.2 Setup the environment :h5 + +Open your bash startup file + +NOTE: Don't forget the dot before the file name of {.bashrc} + +gedit ~/.bashrc :pre + +and add the following lines: + +source $HOME/OpenFOAM/OpenFOAM-4.x/etc/bashrc +export WM_NCOMPPROCS=4 :pre + +Save the file and reload it: + +source ~/.bashrc :pre + +:line + +[Additional check] + +Open ~/OpenFOAM/OpenFOAM-4.x/etc/bashrc and make sure that {WM_MPLIB} is set +correctly: + +export WM_MPLIB=SYSTEMOPENMPI :pre + +This should be the default setting but if you encounter some problems regarding +MPI you might have to download the openmpi-1.10.2 source package to the third +party folder and change the setting to {OPENMPI} + +:line + + +2.1.3 Compile ThirdParty packages :h5 + +cd $WM_THIRD_PARTY_DIR +./Allwmake :pre + + +[Compiling Paraview and the Paraview Reader Module] + +Paraview is a third-party software provided for graphical post-processing in +OpenFOAM. Its compilation is automated using a script called makeParaView in the +ThirdParty-4.x directory. + +Before installing Paraview, check the version of cmake that is installed on the +system. This can be done by typing + +cmake --version :pre + +If the system cmake is older than version 2.8.8, clone a newer version to the +Third Party folder and compile it by executing the following: + +cd $WM_THIRD_PARTY_DIR +git clone https://github.com/Kitware/CMake.git cmake-3.2.1 +cd cmake-3.2.1 +git checkout tags/v3.2.1 +cd .. +./makeCmake :pre + +In makeParaView set the path to cmake: + +CMAKE_PATH="$WM_THIRD_PARTY_DIR/platforms/linux64Gcc/cmake-3.2.1/bin" :pre + +To install Paraview, execute the following + +cd $WM_THIRD_PARTY_DIR +./makeParaView :pre + +If you get the following error + + +VTK/ThirdParty/hdf5/vtkhdf5/src/H5detect.c:158:1: error: unknown type name ‘sigjmp_buf’ +static H5JMP_BUF jbuf_g; :pre + +in VTK/ThirdParty/hdf5/vtkhdf5/config/cmake/ConfigureChecks.cmake around line 445 change + +set (HDF5_EXTRA_FLAGS -D_DEFAULT_SOURCE -D_BSD_SOURCE) :pre + +to + +set (HDF5_EXTRA_FLAGS -D_GNU_SOURCE -D_DEFAULT_SOURCE -D_BSD_SOURCE) :pre + + +2.1.4 Compile OpenFOAM :h5 + +[Compiling the source code] + +cd $WM_PROJECT_DIR +./Allwmake :pre + + +[Testing the installation] + +Create a project directory within the $HOME/OpenFOAM directory + +mkdir -p $FOAM_RUN :pre + +Copy the tutorial examples directory in the OpenFOAM distribution to the run +directory. If the OpenFOAM environment variables are set correctly, then the +following command will be correct: + +cp -r $FOAM_TUTORIALS $FOAM_RUN :pre + +Run the first example case of incompressible laminar flow in a cavity: + +cd $FOAM_RUN/tutorials/incompressible/icoFoam/cavity/cavity +blockMesh +icoFoam +paraFoam :pre + + +2.2 Installing CFDEMcoupling :h4 + +Make sure OpenFOAM is set up correctly and LIGGGHTS is installed as well. Clone +the CFDEMcoupling source from the repository: + +cd $HOME +mkdir CFDEM +cd CFDEM +git clone https://github.com/ParticulateFlow/CFDEMcoupling.git :pre + +Open the bashrc file of CFDEMcoupling + +gedit ~/CFDEM/CFDEMcoupling/etc/bashrc & :pre + +Edit the lines marked as {USER EDITABLE PART} to reflect your installation paths +correctly. Save the bashrc file and reload it: + +source ~/CFDEM/CFDEMcoupling/etc/bashrc :pre + +Entering $CFDEM_PROJECT_DIR in a the terminal should now give "... is a directory" + +Check if everything is set up correctly: + +cfdemSysTest :pre + +Compile LIGGGHTS (as a library) + +cfdemCompLIG :pre + +If the compilation fails with a message like + +No rule to make target `/usr/lib/libpython2.7.so' :pre + +you probably need to create a symbolic link to the library in question. + +Compile CFDEMcoupling (library, solvers and utilities) in one go + +cfdemCompCFDEM :pre + +or alternatively step by step + +cfdemCompCFDEMsrc +cfdemCompCFDEMsol +cfdemCompCFDEMuti :pre + +Find the log files of the compile process + +cd ~/CFDEM/CFDEMcoupling/etc/log +ls :pre + +If the file [log_compile_results_success] is present, compilation was successful. + +Install Octave for post-processing some of the tutorial output. + +sudo apt-get install octave :pre + +To run all tutorial cases type in a terminal: + +cfdemTestTUT :pre + diff --git a/doc/CFDEMcoupling_models.txt b/doc/CFDEMcoupling_models.txt new file mode 100644 index 00000000..6da09c76 --- /dev/null +++ b/doc/CFDEMcoupling_models.txt @@ -0,0 +1,217 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +6. Models :h3,link(1_6),link(comm) + +This section lists all CFDEMcoupling sub-models alphabetically, with +a separate listing below of styles within certain commands. + +6.1 I/O models :h4 + +The "IOModel"_IOModel.html keyword entry specifies the model for writing output +data. + +"basicIO"_IOModel_basicIO.html, +"off"_IOModel_noIO.html, +"sophIO"_IOModel_sophIO.html, +"trackIO"_IOModel_trackIO.html :tb(c=2,ea=c) + + +6.2 Averaging models :h4 + +The "averagingModel"_averagingModel.html keyword entry defines the model used to +map the Lagrangian data to Eulerian values. + +"dense"_averagingModel_dense.html, +"dilute"_averagingModel_dilute.html :tb(c=2,ea=c) + + +6.3 Chemistry models :h4 + +The "chemistryModels"_chemistryModel.html keyword is used to specify a list of +models used for chemical reaction calculations. + +"diffusionCoefficients"_chemistryModel_diffusionCoefficients.html, +"massTransferCoeff"_chemistryModel_massTransferCoeff.html, +"off"_chemistryModel_noChemistry.html, +reactantPerParticle, +"species"_chemistryModel_species.html :tb(c=2,ea=c) + + +6.4 Clock models :h4 + +The "clockModel"_clockModel.html keyword entry specifies the model used to +examine the CFDEMcoupling code with respect to runtime. + +"off"_clockModel_noClock.html, +"standardClock"_clockModel_standardClock.html :tb(c=2,ea=c) + + +6.5 Data exchange models :h4 + +The "dataExchangeModel"_dataExchangeModel.html keyword entry specifies the model +that performs the data exchange between the DEM code and the CFD code. + +"noDataExchange"_dataExchangeModel_noDataExchange.html, +"oneWayVTK"_dataExchangeModel_oneWayVTK.html, +"twoWayFiles"_dataExchangeModel_twoWayFiles.html, +"twoWayMPI"_dataExchangeModel_twoWayMPI.html, +"twoWayMany2Many"_dataExchangeModel_twoWayMany2Many.html :tb(c=2,ea=c) + + +6.6 Energy models :h4 + +The {energyModels} keyword specifies a list of energy models used for e.g. +compressible, reacting flows. + +heatTransferGunn, +heatTransferGunnPartField, +reactionHeat :tb(c=2,ea=c) + + +6.7 Force models :h4 + +The "forceModels"_forceModel.html keyword specifies a list of models that exert +a force on each DEM particle. + +"Archimedes"_forceModel_Archimedes.html, +"ArchimedesIB"_forceModel_ArchimedesIB.html, +"BeetstraDrag"_forceModel_BeetstraDrag.html, +BeetstraDragPoly, +"DiFeliceDrag"_forceModel_DiFeliceDrag.html, +"dSauter"_forceModel_dSauter.html, +Fines, +"GidaspowDrag"_forceModel_GidaspowDrag.html, +"KochHillDrag"_forceModel_KochHillDrag.html, +"LaEuScalarTemp"_forceModel_LaEuScalarTemp.html, +"MeiLift"_forceModel_MeiLift.html, +"SchillerNaumannDrag"_forceModel_SchillerNaumannDrag.html, +"ShirgaonkarIB"_forceModel_ShirgaonkarIB.html, +"fieldStore"_forceModel_fieldStore.html, +"fieldTimeAverage"_forceModel_fieldTimeAverage.html, +"gradPForce"_forceModel_gradPForce.html, +"gradPForceSmooth"_forceModel_gradPForceSmooth.html, +granKineticEnergy, +"interface"_forceModel_interface.html, +"noDrag"_forceModel_noDrag.html, +"particleCellVolume"_forceModel_particleCellVolume.html, +"pdCorrelation"_forceModel_pdCorrelation.html, +"surfaceTensionForce"_forceModel_surfaceTensionForce.html, +"virtualMassForce"_forceModel_virtualMassForce.html, +"viscForce"_forceModel_viscForce.html, +"volWeightedAverage"_forceModel_volWeightedAverage.html :tb(c=2,ea=c) + + +6.7.1 Force sub-models :h5 + +The "forceSubModels"_forceSubModel.html keyword specifies a list +of models that hold settings for a force model. + +"ImEx"_forceSubModel_ImEx.html, +ScaleForce, +scaleForceBoundary :tb(c=2,ea=c) + + +6.8 LIGGGHTS command models :h4,link(lcm) + +The "liggghtsCommandModels"_liggghtsCommandModel.html keyword specifies a list +of models that execute LIGGGHTS commands within a CFD run. + +"execute"_liggghtsCommandModel_execute.html, +"readLiggghtsData"_liggghtsCommandModel_readLiggghtsData.html, +"runLiggghts"_liggghtsCommandModel_runLiggghts.html, +"writeLiggghts"_liggghtsCommandModel_writeLiggghts.html :tb(c=2,ea=c) + + +6.9 Locate models :h4 + +The "locateModel"_locateModel.html keyword entry specifies the model used to +search the CFD mesh for the CFD cell corresponding to a given position. + +"engine"_locateModel_engineSearch.html, +"engineIB"_locateModel_engineSearchIB.html, +"engineSearchMany2Many"_locateModel_engineSearchMany2Many.html, +"standard"_locateModel_standardSearch.html, +"turboEngine"_locateModel_turboEngineSearch.html :tb(c=2,ea=c) + + +6.10 Mesh motion models :h4 + +The "meshMotionModel"_meshMotionModel.html keyword entry specifies the model +used to manipulate the CFD mesh according to the DEM mesh motion. + +"noMeshMotion"_meshMotionModel_noMeshMotion.html :tb(c=2,ea=c) + + +6.11 Momentum coupling models :h4 + +The "momCoupleModels"_momCoupleModel.html keyword specifies a list of models +used for momentum exchange between DEM and CFD simulation + +"explicitCouple"_momCoupleModel_explicitCouple.html, +"implicitCouple"_momCoupleModel_implicitCouple.html, +"off"_momCoupleModel_noCouple.html :tb(c=2,ea=c) + + +6.12 Other force models :h4 + +The {otherForceModels} keyword specifies a list of models that exert a force on +each DEM particle. + +expParticleForces, +gravity, +weightSecondaryPhase :tb(c=2,ea=c) + + +6.13 Probe models :h4 + +The "probeModel"_probeModel.html keyword entry specifies the probing features in +CFDEMcoupling simulations. + +"off"_probeModel_noProbe.html, +"particleProbe"_probeModel_particleProbe.html :tb(c=2,ea=c) + + +6.14 Region models :h4 + +The "regionModel"_regionModel.html keyword entry specifies the model used to +select a certain region for coupled simulations. + +"allRegion"_regionModel_allRegion.html :tb(c=2,ea=c) + + +6.15 Smoothing models :h4 + +The "smoothingModel"_smoothingModel.html keyword entry specifies the model for +smoothing the exchange fields. + +"constDiffSmoothing"_smoothingModel_constDiffSmoothing.html, +"off"_smoothingModel_noSmoothing.html, +"temporalSmoothing"_smoothingModel_temporalSmoothing.html :tb(c=2,ea=c) + + +6.16 Thermal conductivity models :h4 + +The {thermCondModel} keyword entry specifies the model for the thermal +conductivity of the fluid phase in the presence of particles. + +SyamlalThermCond, +ZehnerSchluenderThermCond, +off :tb(c=2,ea=c) + + +6.17 Void fraction models :h4 + +The "voidFractionModel"_voidFractionModel.html keyword entry specifies the model +accounting for the volume of the particles in the CFD domain. + +"Gauss"_voidFractionModel_GaussVoidFraction.html, +"IB"_voidFractionModel_IBVoidFraction.html, +"bigParticle"_voidFractionModel_bigParticleVoidFraction.html, +"centre"_voidFractionModel_centreVoidFraction.html, +"divided"_voidFractionModel_dividedVoidFraction.html :tb(c=2,ea=c) + diff --git a/doc/CFDEMcoupling_solvers.txt b/doc/CFDEMcoupling_solvers.txt new file mode 100644 index 00000000..323e566e --- /dev/null +++ b/doc/CFDEMcoupling_solvers.txt @@ -0,0 +1,19 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +5. Solvers :h3,link(1_5) + +This section lists all CFDEMcoupling solvers alphabetically. + +"cfdemSolverIB"_cfdemSolverIB.html, +"cfdemSolverMultiphase"_cfdemSolverMultiphase.html, +"cfdemSolverPiso"_cfdemSolverPiso.html, +"cfdemSolverPisoScalar"_cfdemSolverPisoScalar.html, +cfdemSolverRhoPimple, +cfdemSolverRhoPimpleChem, +cfdemSolverRhoSimple :tb(c=2,ea=c) + diff --git a/doc/CFDEMcoupling_tutorials.txt b/doc/CFDEMcoupling_tutorials.txt new file mode 100644 index 00000000..a29301ea --- /dev/null +++ b/doc/CFDEMcoupling_tutorials.txt @@ -0,0 +1,95 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +3. Tutorials :link(1_3),h3 + +[General:] + +Each solver of CFDEMcoupling comes with at least one tutorial example, showing +its functionality and correct usage. Provided that the installation is correct, +the tutorials can be run via "Allrun.sh" shell scripts. These scripts perform +all necessary steps (pre-processing, run, post-processing, visualization). + +[Location:] + +The tutorials can be found in the directory $CFDEM_PROJECT_DIR/tutorials, +which can be reached by typing {cfdemTut} in a CLI terminal. + +[Structure:] + +Each case is structured in a directory called "CFD" covering the CFD relevant +settings and data, and a directory called "DEM" covering the DEM relevant +settings and data. This allows to easily expand a pure CFD or DEM simulation +case to a coupled case. + +[Usage:] + +Provided that the installation is correct, the tutorials can be run via +"Allrun.sh" shell script, executed by typing "./Allrun.sh". The successful run +of the script might need some third party software (e.g. octave, evince, etc.). + +[Settings:] + +The main settings of a simulation are done via dictionaries: + +The DEM setup of each case is defined by a "LIGGGHTS"_lig input file located in +$caseDir/DEM (e.g. in.liggghts_init). For details on the LIGGGHTS setup, +please have a look at the LIGGGHTS manual. + + +Standard CFD settings are defined in $caseDir/CFD/constant (e.g. +transportProperties, RASproperties, etc.) and $caseDir/CFD/system (e.g. +fvSchemes, controlDict). You can find more information on that in +"OpenFOAM®"_of (*) documentations. + +:link(of,http://www.openfoam.org) + + + +. + +Settings of the coupling routines are defined in +$caseDir/CFD/constant/"couplingProperies"_CFDEMcoupling_dicts.html#couplingProperties +(e.g. force models, data exchange model, etc.) and +$caseDir/CFD/constant/"liggghtsCommands"_CFDEMcoupling_dicts.html#liggghtsCommands +(allows to execute a LIGGGHTS command during a coupled simulation). + + +NOTE: +(*) This offering is not approved or endorsed by OpenCFD Limited, producer and +distributor of the OpenFOAM software via www.openfoam.com, and owner of the +OPENFOAM® and OpenCFD® trade marks. +OPENFOAM® is a registered trade mark of OpenCFD Limited, producer and +distributor of the OpenFOAM software via www.openfoam.com. + + + + +:link(lig,http://www.cfdem.com) + + diff --git a/doc/Eqs/voidfractionModel_divided_pic1.png b/doc/Eqs/voidfractionModel_divided_pic1.png new file mode 100755 index 00000000..b455f067 Binary files /dev/null and b/doc/Eqs/voidfractionModel_divided_pic1.png differ diff --git a/doc/Eqs/voidfractionModel_divided_pic2.png b/doc/Eqs/voidfractionModel_divided_pic2.png new file mode 100755 index 00000000..9b331fb5 Binary files /dev/null and b/doc/Eqs/voidfractionModel_divided_pic2.png differ diff --git a/doc/Eqs/voidfractionModel_divided_pic3.png b/doc/Eqs/voidfractionModel_divided_pic3.png new file mode 100755 index 00000000..5430f275 Binary files /dev/null and b/doc/Eqs/voidfractionModel_divided_pic3.png differ diff --git a/doc/Eqs/voidfractionModel_divided_pic4.png b/doc/Eqs/voidfractionModel_divided_pic4.png new file mode 100755 index 00000000..c3520b5c Binary files /dev/null and b/doc/Eqs/voidfractionModel_divided_pic4.png differ diff --git a/doc/Eqs/voidfractionModel_divided_pic5.png b/doc/Eqs/voidfractionModel_divided_pic5.png new file mode 100755 index 00000000..acd4ad8d Binary files /dev/null and b/doc/Eqs/voidfractionModel_divided_pic5.png differ diff --git a/doc/Eqs/voidfractionModel_divided_pic6.png b/doc/Eqs/voidfractionModel_divided_pic6.png new file mode 100755 index 00000000..4c051abb Binary files /dev/null and b/doc/Eqs/voidfractionModel_divided_pic6.png differ diff --git a/doc/IOModel.html b/doc/IOModel.html deleted file mode 100644 index 516fa6ed..00000000 --- a/doc/IOModel.html +++ /dev/null @@ -1,40 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

IOModel command -

-

Syntax: -

-

Defined in couplingProperties dictionary. -

-
IOModel "model"; 
-
-
  • model = name of IO-model to be applied -
-

Examples: -

-

IOModel "off"; -

-

Note: This examples list might not be complete - please look for other models (IOModel_XY) in this documentation. -

-

Description: -

-

The IO-model is the base class to write data (e.g. particle properties) to files. -

-

Restrictions: -

-

none. -

-

Related commands: -

-

Note: This examples list may be incomplete - please look for other models (IOModel_XY) in this documentation. -

-

Default: none. -

- diff --git a/doc/IOModel.txt b/doc/IOModel.txt index 77014da2..bc82cc1c 100644 --- a/doc/IOModel.txt +++ b/doc/IOModel.txt @@ -1,7 +1,7 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,28 +9,34 @@ IOModel command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -IOModel "model"; :pre +IOModel model; :pre model = name of IO-model to be applied :ul [Examples:] -IOModel "off"; +IOModel off; :pre -Note: This examples list might not be complete - please look for other models (IOModel_XY) in this documentation. +NOTE: This examples list might not be complete - please look for other IO models +in this documentation. [Description:] -The IO-model is the base class to write data (e.g. particle properties) to files. +{IOModel} is the base class to write data (e.g. particle properties) to files. [Restrictions:] -none. +none [Related commands:] -Note: This examples list may be incomplete - please look for other models (IOModel_XY) in this documentation. +"IOModel basicIO"_IOModel_basicIO.html, "IOModel off"_IOModel_noIO.html, +"IOModel sophIO"_IOModel_sophIO.html, "IOModel trackIO"_IOModel_trackIO.html + +[Default:] + +none -[Default:] none. diff --git a/doc/IOModel_basicIO.html b/doc/IOModel_basicIO.html deleted file mode 100644 index 8152c9e9..00000000 --- a/doc/IOModel_basicIO.html +++ /dev/null @@ -1,32 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

IOModel_basicIO command -

-

Syntax: -

-

Defined in couplingProperties dictionary. -

-
IOModel "basicIO"; 
-
-

Examples: -

-
IOModel "basicIO"; 
-
-

Description: -

-

The basic IO-model writes particle positions velocities and radii to files. The default output directory ($casePath/CFD/proc*/time/lagrangian). Using the keyword "serialOutput;" in couplingProperties the IO is serial to the directory ($casePath/CFD/lagrangian). In the latter case only the data on processor 0 is written! Data is written every write time of the CFD simulation. -

-

Restrictions: None. -

-

Related commands: -

-

IOModel -

- diff --git a/doc/IOModel_basicIO.txt b/doc/IOModel_basicIO.txt index 98daa37a..32115308 100644 --- a/doc/IOModel_basicIO.txt +++ b/doc/IOModel_basicIO.txt @@ -1,27 +1,39 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -IOModel_basicIO command :h3 +IOModel basicIO command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -IOModel "basicIO"; :pre +IOModel basicIO; :pre [Examples:] -IOModel "basicIO"; :pre +IOModel basicIO; +serialOutput; :pre [Description:] -The basic IO-model writes particle positions velocities and radii to files. The default output directory ($casePath/CFD/proc*/time/lagrangian). Using the keyword "serialOutput;" in couplingProperties the IO is serial to the directory ($casePath/CFD/lagrangian). In the latter case only the data on processor 0 is written! Data is written every write time of the CFD simulation. +The {basicIO} model writes particle positions, velocities and radii to files. +The default output directory is {$casePath/CFD/proc*/time/lagrangian}. -[Restrictions:] None. +Using the keyword {serialOutput;} in the +"couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties dictionary, +the IO is serial to the directory {$casePath/CFD/lagrangian}. In this case +only the data on processor 0 is written! + +Data is written every write time of the CFD simulation. + +[Restrictions:] + +none [Related commands:] diff --git a/doc/IOModel_noIO.html b/doc/IOModel_noIO.html deleted file mode 100644 index 0fb2343c..00000000 --- a/doc/IOModel_noIO.html +++ /dev/null @@ -1,32 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

IOModel_noIO command -

-

Syntax: -

-

Defined in couplingProperties dictionary. -

-
IOModel "off"; 
-
-

Examples: -

-
IOModel "off"; 
-
-

Description: -

-

The noIO-model is a dummy IO model. -

-

Restrictions: None. -

-

Related commands: -

-

IOModel -

- diff --git a/doc/IOModel_noIO.txt b/doc/IOModel_noIO.txt index d90d77cf..92c47159 100644 --- a/doc/IOModel_noIO.txt +++ b/doc/IOModel_noIO.txt @@ -1,27 +1,30 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -IOModel_noIO command :h3 +IOModel off command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -IOModel "off"; :pre +IOModel off; :pre [Examples:] -IOModel "off"; :pre +IOModel off; :pre [Description:] -The noIO-model is a dummy IO model. +This IOModel produces no output. -[Restrictions:] None. +[Restrictions:] + +none [Related commands:] diff --git a/doc/IOModel_sophIO.html b/doc/IOModel_sophIO.html deleted file mode 100644 index 2bbf56ce..00000000 --- a/doc/IOModel_sophIO.html +++ /dev/null @@ -1,32 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

IOModel_sophIO command -

-

Syntax: -

-

Defined in couplingProperties dictionary. -

-
IOModel "sophIO"; 
-
-

Examples: -

-
IOModel "sophIO"; 
-
-

Description: -

-

The sophIO-model is based on basicIO model and additionally writes voidfraction, implicit forces, explicit forces. Data is written every write time of the CFD simulation. -

-

Restrictions: None. -

-

Related commands: -

-

IOModel -

- diff --git a/doc/IOModel_sophIO.txt b/doc/IOModel_sophIO.txt index 09dcd3e6..98a5a0f5 100644 --- a/doc/IOModel_sophIO.txt +++ b/doc/IOModel_sophIO.txt @@ -1,29 +1,35 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -IOModel_sophIO command :h3 +IOModel sophIO command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -IOModel "sophIO"; :pre +IOModel sophIO; :pre [Examples:] -IOModel "sophIO"; :pre +IOModel sophIO; :pre [Description:] -The sophIO-model is based on basicIO model and additionally writes voidfraction, implicit forces, explicit forces. Data is written every write time of the CFD simulation. +The {sophIO} model is based on the "basicIO"_IOModel_basicIO.html model and +additionally writes void fraction, implicit forces and explicit forces. -[Restrictions:] None. +Data is written every write time of the CFD simulation. + +[Restrictions:] + +none [Related commands:] -"IOModel"_IOModel.html +"IOModel"_IOModel.html, "IOModel basicIO"_IOModel_basicIO.html diff --git a/doc/IOModel_trackIO.html b/doc/IOModel_trackIO.html deleted file mode 100644 index 28d1e861..00000000 --- a/doc/IOModel_trackIO.html +++ /dev/null @@ -1,32 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

IOModel_trackIO command -

-

Syntax: -

-

Defined in couplingProperties dictionary. -

-
IOModel "trackIO"; 
-
-

Examples: -

-
IOModel "trackIO"; 
-
-

Description: -

-

The trackIO-model is based on sophIO model and additionally writes fields necessary to use the particleTracks utility (which needs a particleTrackProperties file in the constant dir). The particleTracks utility generates tracks of the particles and writes them to a vtk file. -

-

Restrictions: None. -

-

Related commands: -

-

IOModel -

- diff --git a/doc/IOModel_trackIO.txt b/doc/IOModel_trackIO.txt index dff7906e..fcef4a94 100644 --- a/doc/IOModel_trackIO.txt +++ b/doc/IOModel_trackIO.txt @@ -1,29 +1,35 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -IOModel_trackIO command :h3 +IOModel trackIO command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -IOModel "trackIO"; :pre +IOModel trackIO; :pre [Examples:] -IOModel "trackIO"; :pre +IOModel trackIO; :pre [Description:] -The trackIO-model is based on sophIO model and additionally writes fields necessary to use the particleTracks utility (which needs a particleTrackProperties file in the constant dir). The particleTracks utility generates tracks of the particles and writes them to a vtk file. +The {trackIO} model is based on the "sophIO"_IOModel_sophIO.html model and +additionally writes fields necessary to use the particleTracks utility (which +needs a particleTrackProperties file in the constant dir). The particleTracks +utility generates tracks of the particles and writes them to a VTK file. -[Restrictions:] None. +[Restrictions:] + +none [Related commands:] -"IOModel"_IOModel.html +"IOModel"_IOModel.html, "IOModel sophIO"_IOModel_sophIO.html diff --git a/doc/Makefile b/doc/Makefile new file mode 100644 index 00000000..f20ac01d --- /dev/null +++ b/doc/Makefile @@ -0,0 +1,189 @@ +# Makefile for Sphinx documentation +# + +# You can set these variables from the command line. +SPHINXOPTS = +SPHINXBUILD = sphinx-build +#SPHINXBUILD = /usr/share/sphinx/scripts/python3/sphinx-build +PAPER = +BUILDDIR = _build +TXT2RST = txt2rst + +SOURCES=$(wildcard *.txt) +OBJECTS=$(SOURCES:%.txt=%.rst) + +# User-friendly check for sphinx-build +ifeq ($(shell which $(SPHINXBUILD) >/dev/null 2>&1; echo $$?), 1) +$(error The '$(SPHINXBUILD)' command was not found. Make sure you have Sphinx installed, then set the SPHINXBUILD environment variable to point to the full path of the '$(SPHINXBUILD)' executable. Alternatively you can add the directory with the executable to your PATH. If you don't have Sphinx installed, grab it from http://sphinx-doc.org/) +endif + +# Internal variables. +PAPEROPT_a4 = -D latex_paper_size=a4 +PAPEROPT_letter = -D latex_paper_size=letter +ALLSPHINXOPTS = -d $(BUILDDIR)/doctrees $(PAPEROPT_$(PAPER)) $(SPHINXOPTS) . +# the i18n builder cannot share the environment and doctrees with the others +I18NSPHINXOPTS = $(PAPEROPT_$(PAPER)) $(SPHINXOPTS) . + +.PHONY: help clean html dirhtml singlehtml pickle json htmlhelp qthelp devhelp epub latex latexpdf text man changes linkcheck doctest gettext + +help: + @echo "Please use \`make ' where is one of" + @echo " html to make standalone HTML files" + @echo " dirhtml to make HTML files named index.html in directories" + @echo " singlehtml to make a single large HTML file" + @echo " pickle to make pickle files" + @echo " json to make JSON files" + @echo " htmlhelp to make HTML files and a HTML help project" + @echo " qthelp to make HTML files and a qthelp project" + @echo " devhelp to make HTML files and a Devhelp project" + @echo " epub to make an epub" + @echo " latex to make LaTeX files, you can set PAPER=a4 or PAPER=letter" + @echo " latexpdf to make LaTeX files and run them through pdflatex" + @echo " latexpdfja to make LaTeX files and run them through platex/dvipdfmx" + @echo " text to make text files" + @echo " man to make manual pages" + @echo " texinfo to make Texinfo files" + @echo " info to make Texinfo files and run them through makeinfo" + @echo " gettext to make PO message catalogs" + @echo " changes to make an overview of all changed/added/deprecated items" + @echo " xml to make Docutils-native XML files" + @echo " pseudoxml to make pseudoxml-XML files for display purposes" + @echo " linkcheck to check all external links for integrity" + @echo " doctest to run all doctests embedded in the documentation (if enabled)" + +clean: + rm -rf $(BUILDDIR)/* + +html: $(OBJECTS) + $(SPHINXBUILD) -b html $(ALLSPHINXOPTS) $(BUILDDIR)/html + @echo + @echo "Build finished. The HTML pages are in $(BUILDDIR)/html." + cp -r $(BUILDDIR)/html/* . + @echo "Copied files back to current folder" + +dirhtml: + $(SPHINXBUILD) -b dirhtml $(ALLSPHINXOPTS) $(BUILDDIR)/dirhtml + @echo + @echo "Build finished. The HTML pages are in $(BUILDDIR)/dirhtml." + +singlehtml: + $(SPHINXBUILD) -b singlehtml $(ALLSPHINXOPTS) $(BUILDDIR)/singlehtml + @echo + @echo "Build finished. The HTML page is in $(BUILDDIR)/singlehtml." + +pickle: + $(SPHINXBUILD) -b pickle $(ALLSPHINXOPTS) $(BUILDDIR)/pickle + @echo + @echo "Build finished; now you can process the pickle files." + +json: + $(SPHINXBUILD) -b json $(ALLSPHINXOPTS) $(BUILDDIR)/json + @echo + @echo "Build finished; now you can process the JSON files." + +htmlhelp: + $(SPHINXBUILD) -b htmlhelp $(ALLSPHINXOPTS) $(BUILDDIR)/htmlhelp + @echo + @echo "Build finished; now you can run HTML Help Workshop with the" \ + ".hhp project file in $(BUILDDIR)/htmlhelp." + +qthelp: + $(SPHINXBUILD) -b qthelp $(ALLSPHINXOPTS) $(BUILDDIR)/qthelp + @echo + @echo "Build finished; now you can run "qcollectiongenerator" with the" \ + ".qhcp project file in $(BUILDDIR)/qthelp, like this:" + @echo "# qcollectiongenerator $(BUILDDIR)/qthelp/LIGGGHTS.qhcp" + @echo "To view the help file:" + @echo "# assistant -collectionFile $(BUILDDIR)/qthelp/LIGGGHTS.qhc" + +devhelp: + $(SPHINXBUILD) -b devhelp $(ALLSPHINXOPTS) $(BUILDDIR)/devhelp + @echo + @echo "Build finished." + @echo "To view the help file:" + @echo "# mkdir -p $$HOME/.local/share/devhelp/LIGGGHTS" + @echo "# ln -s $(BUILDDIR)/devhelp $$HOME/.local/share/devhelp/LIGGGHTS" + @echo "# devhelp" + +epub: + $(SPHINXBUILD) -b epub $(ALLSPHINXOPTS) $(BUILDDIR)/epub + @echo + @echo "Build finished. The epub file is in $(BUILDDIR)/epub." + +latex: + $(SPHINXBUILD) -b latex $(ALLSPHINXOPTS) $(BUILDDIR)/latex + @echo + @echo "Build finished; the LaTeX files are in $(BUILDDIR)/latex." + @echo "Run \`make' in that directory to run these through (pdf)latex" \ + "(use \`make latexpdf' here to do that automatically)." + +latexpdf: + $(SPHINXBUILD) -b latex $(ALLSPHINXOPTS) $(BUILDDIR)/latex + @echo "Running LaTeX files through pdflatex..." + $(MAKE) -C $(BUILDDIR)/latex all-pdf + @echo "pdflatex finished; the PDF files are in $(BUILDDIR)/latex." + +latexpdfja: + $(SPHINXBUILD) -b latex $(ALLSPHINXOPTS) $(BUILDDIR)/latex + @echo "Running LaTeX files through platex and dvipdfmx..." + $(MAKE) -C $(BUILDDIR)/latex all-pdf-ja + @echo "pdflatex finished; the PDF files are in $(BUILDDIR)/latex." + +text: + $(SPHINXBUILD) -b text $(ALLSPHINXOPTS) $(BUILDDIR)/text + @echo + @echo "Build finished. The text files are in $(BUILDDIR)/text." + +man: + $(SPHINXBUILD) -b man $(ALLSPHINXOPTS) $(BUILDDIR)/man + @echo + @echo "Build finished. The manual pages are in $(BUILDDIR)/man." + +texinfo: + $(SPHINXBUILD) -b texinfo $(ALLSPHINXOPTS) $(BUILDDIR)/texinfo + @echo + @echo "Build finished. The Texinfo files are in $(BUILDDIR)/texinfo." + @echo "Run \`make' in that directory to run these through makeinfo" \ + "(use \`make info' here to do that automatically)." + +info: + $(SPHINXBUILD) -b texinfo $(ALLSPHINXOPTS) $(BUILDDIR)/texinfo + @echo "Running Texinfo files through makeinfo..." + make -C $(BUILDDIR)/texinfo info + @echo "makeinfo finished; the Info files are in $(BUILDDIR)/texinfo." + +gettext: + $(SPHINXBUILD) -b gettext $(I18NSPHINXOPTS) $(BUILDDIR)/locale + @echo + @echo "Build finished. The message catalogs are in $(BUILDDIR)/locale." + +changes: + $(SPHINXBUILD) -b changes $(ALLSPHINXOPTS) $(BUILDDIR)/changes + @echo + @echo "The overview file is in $(BUILDDIR)/changes." + +linkcheck: + $(SPHINXBUILD) -b linkcheck $(ALLSPHINXOPTS) $(BUILDDIR)/linkcheck + @echo + @echo "Link check complete; look for any errors in the above output " \ + "or in $(BUILDDIR)/linkcheck/output.txt." + +doctest: + $(SPHINXBUILD) -b doctest $(ALLSPHINXOPTS) $(BUILDDIR)/doctest + @echo "Testing of doctests in the sources finished, look at the " \ + "results in $(BUILDDIR)/doctest/output.txt." + +xml: + $(SPHINXBUILD) -b xml $(ALLSPHINXOPTS) $(BUILDDIR)/xml + @echo + @echo "Build finished. The XML files are in $(BUILDDIR)/xml." + +pseudoxml: + $(SPHINXBUILD) -b pseudoxml $(ALLSPHINXOPTS) $(BUILDDIR)/pseudoxml + @echo + @echo "Build finished. The pseudo-XML files are in $(BUILDDIR)/pseudoxml." + +%.rst : %.txt + $(TXT2RST) $< > $@ + +rst: $(OBJECTS) ; diff --git a/doc/SCcontent/individual_commands.txt b/doc/SCcontent/individual_commands.txt deleted file mode 100644 index f9512e78..00000000 --- a/doc/SCcontent/individual_commands.txt +++ /dev/null @@ -1,4 +0,0 @@ -1.6 Models/Solvers :h4,link(cmd_5),link(comm) - -This section lists all CFDEMcoupling sub-models and solvers alphabetically, with a separate -listing below of styles within certain commands. diff --git a/doc/_themes/lammps_theme/LICENSE b/doc/_themes/lammps_theme/LICENSE new file mode 100644 index 00000000..921f0738 --- /dev/null +++ b/doc/_themes/lammps_theme/LICENSE @@ -0,0 +1,20 @@ +The MIT License (MIT) + +Copyright (c) 2013 Dave Snider + +Permission is hereby granted, free of charge, to any person obtaining a copy of +this software and associated documentation files (the "Software"), to deal in +the Software without restriction, including without limitation the rights to +use, copy, modify, merge, publish, distribute, sublicense, and/or sell copies of +the Software, and to permit persons to whom the Software is furnished to do so, +subject to the following conditions: + +The above copyright notice and this permission notice shall be included in all +copies or substantial portions of the Software. + +THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, FITNESS +FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE AUTHORS OR +COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER +IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN +CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. diff --git a/doc/_themes/lammps_theme/README b/doc/_themes/lammps_theme/README new file mode 100644 index 00000000..4eda2c4c --- /dev/null +++ b/doc/_themes/lammps_theme/README @@ -0,0 +1,3 @@ +This theme is derived from Dave Snider's Read-The-Docs theme for Sphinx. +https://github.com/snide/sphinx_rtd_theme +It contains minor modifications for the LAMMPS documentation. diff --git a/doc/_themes/lammps_theme/__init__.py b/doc/_themes/lammps_theme/__init__.py new file mode 100644 index 00000000..95ddc52a --- /dev/null +++ b/doc/_themes/lammps_theme/__init__.py @@ -0,0 +1,17 @@ +"""Sphinx ReadTheDocs theme. + +From https://github.com/ryan-roemer/sphinx-bootstrap-theme. + +""" +import os + +VERSION = (0, 1, 8) + +__version__ = ".".join(str(v) for v in VERSION) +__version_full__ = __version__ + + +def get_html_theme_path(): + """Return list of HTML theme paths.""" + cur_dir = os.path.abspath(os.path.dirname(os.path.dirname(__file__))) + return cur_dir diff --git a/doc/_themes/lammps_theme/static/css/badge_only.css b/doc/_themes/lammps_theme/static/css/badge_only.css new file mode 100644 index 00000000..51d180e4 --- /dev/null +++ b/doc/_themes/lammps_theme/static/css/badge_only.css @@ -0,0 +1,226 @@ +@charset "UTF-8"; +.fa:before { + -webkit-font-smoothing: antialiased; +} + +.clearfix { + *zoom: 1; +} +.clearfix:before, .clearfix:after { + display: table; + content: ""; +} +.clearfix:after { + clear: both; +} + +@font-face { + font-family: FontAwesome; + font-weight: normal; + font-style: normal; + src: url("../font/fontawesome_webfont.eot"); + src: url("../font/fontawesome_webfont.eot?#iefix") format("embedded-opentype"), url("../font/fontawesome_webfont.woff") format("woff"), url("../font/fontawesome_webfont.ttf") format("truetype"), url("../font/fontawesome_webfont.svg#FontAwesome") format("svg"); +} +.fa:before { + display: inline-block; + font-family: FontAwesome; + font-style: normal; + font-weight: normal; + line-height: 1; + text-decoration: inherit; +} + +a .fa { + display: inline-block; + text-decoration: inherit; +} + +li .fa { + display: inline-block; +} +li .fa-large:before, +li .fa-large:before { + /* 1.5 increased font size for fa-large * 1.25 width */ + width: 1.875em; +} + +ul.fas { + list-style-type: none; + margin-left: 2em; + text-indent: -0.8em; +} +ul.fas li .fa { + width: 0.8em; +} +ul.fas li .fa-large:before, +ul.fas li .fa-large:before { + /* 1.5 increased font size for fa-large * 1.25 width */ + vertical-align: baseline; +} + +.fa-book:before { + content: ""; +} + +.icon-book:before { + content: ""; +} + +.fa-caret-down:before { + content: ""; +} + +.icon-caret-down:before { + content: ""; +} + +.fa-caret-up:before { + content: ""; +} + +.icon-caret-up:before { + content: ""; +} + +.fa-caret-left:before { + content: ""; +} + +.icon-caret-left:before { + content: ""; +} + +.fa-caret-right:before { + content: ""; +} + +.icon-caret-right:before { + content: ""; +} + +.rst-versions { + position: fixed; + bottom: 0; + left: 0; + width: 300px; + color: #fcfcfc; + background: #1f1d1d; + border-top: solid 10px #343131; + font-family: "Lato", "proxima-nova", "Helvetica Neue", Arial, sans-serif; + z-index: 400; +} +.rst-versions a { + color: #2980B9; + text-decoration: none; +} +.rst-versions .rst-badge-small { + display: none; +} +.rst-versions .rst-current-version { + padding: 12px; + background-color: #272525; + display: block; + text-align: right; + font-size: 90%; + cursor: pointer; + color: #27AE60; + *zoom: 1; +} +.rst-versions .rst-current-version:before, .rst-versions .rst-current-version:after { + display: table; + content: ""; +} +.rst-versions .rst-current-version:after { + clear: both; +} +.rst-versions .rst-current-version .fa { + color: #fcfcfc; +} +.rst-versions .rst-current-version .fa-book { + float: left; +} +.rst-versions .rst-current-version .icon-book { + float: left; +} +.rst-versions .rst-current-version.rst-out-of-date { + background-color: #E74C3C; + color: #fff; +} +.rst-versions .rst-current-version.rst-active-old-version { + background-color: #F1C40F; + color: #000; +} +.rst-versions.shift-up .rst-other-versions { + display: block; +} +.rst-versions .rst-other-versions { + font-size: 90%; + padding: 12px; + color: gray; + display: none; +} +.rst-versions .rst-other-versions hr { + display: block; + height: 1px; + border: 0; + margin: 20px 0; + padding: 0; + border-top: solid 1px #413d3d; +} +.rst-versions .rst-other-versions dd { + display: inline-block; + margin: 0; +} +.rst-versions .rst-other-versions dd a { + display: inline-block; + padding: 6px; + color: #fcfcfc; +} +.rst-versions.rst-badge { + width: auto; + bottom: 20px; + right: 20px; + left: auto; + border: none; + max-width: 300px; +} +.rst-versions.rst-badge .icon-book { + float: none; +} +.rst-versions.rst-badge .fa-book { + float: none; +} +.rst-versions.rst-badge.shift-up .rst-current-version { + text-align: right; +} +.rst-versions.rst-badge.shift-up .rst-current-version .fa-book { + float: left; +} +.rst-versions.rst-badge.shift-up .rst-current-version .icon-book { + float: left; +} +.rst-versions.rst-badge .rst-current-version { + width: auto; + height: 30px; + line-height: 30px; + padding: 0 6px; + display: block; + text-align: center; +} + +@media screen and (max-width: 768px) { + .rst-versions { + width: 85%; + display: none; + } + .rst-versions.shift { + display: block; + } + + img { + width: 100%; + height: auto; + } +} + +/*# sourceMappingURL=badge_only.css.map */ diff --git a/doc/_themes/lammps_theme/static/css/badge_only.css.map b/doc/_themes/lammps_theme/static/css/badge_only.css.map new file mode 100644 index 00000000..aeb56ddb --- /dev/null +++ b/doc/_themes/lammps_theme/static/css/badge_only.css.map @@ -0,0 +1,7 @@ +{ +"version": 3, +"mappings": ";AAyDA,UAAY;EACV,sBAAsB,EAAE,WAAW;;;AAqDrC,SAAS;EARP,KAAK,EAAE,CAAC;;AACR,iCAAS;EAEP,OAAO,EAAE,KAAK;EACd,OAAO,EAAE,EAAE;;AACb,eAAO;EACL,KAAK,EAAE,IAAI;;;AC1Gb,UAkBC;EAjBC,WAAW,ECFJ,WAAW;EDGlB,WAAW,EAHqC,MAAM;EAItD,UAAU,EAJsD,MAAM;EAapE,GAAG,EAAE,sCAAwB;EAC7B,GAAG,EAAE,8PAAyE;;ACZpF,UAAU;EACR,OAAO,EAAE,YAAY;EACrB,WAAW,EAAE,WAAW;EACxB,UAAU,EAAE,MAAM;EAClB,WAAW,EAAE,MAAM;EACnB,WAAW,EAAE,CAAC;EACd,eAAe,EAAE,OAAO;;;AAG1B,KAAK;EACH,OAAO,EAAE,YAAY;EACrB,eAAe,EAAE,OAAO;;;AAIxB,MAAG;EACD,OAAO,EAAE,YAAY;;AACvB;mBAAiB;;EAGf,KAAK,EAAE,OAAY;;;AAEvB,MAAM;EACJ,eAAe,EAAE,IAAI;EACrB,WAAW,EAAE,GAAG;EAChB,WAAW,EAAE,MAAM;;AAEjB,aAAG;EACD,KAAK,EAAE,KAAI;;AACb;0BAAiB;;EAGf,cAAc,EAAE,QAAQ;;;AAG9B,eAAe;EACb,OAAO,EAAE,GAAO;;;AAElB,iBAAiB;EACf,OAAO,EAAE,GAAO;;;AAElB,qBAAqB;EACnB,OAAO,EAAE,GAAO;;;AAElB,uBAAuB;EACrB,OAAO,EAAE,GAAO;;;AAElB,mBAAmB;EACjB,OAAO,EAAE,GAAO;;;AAElB,qBAAqB;EACnB,OAAO,EAAE,GAAO;;;AAElB,qBAAqB;EACnB,OAAO,EAAE,GAAO;;;AAElB,uBAAuB;EACrB,OAAO,EAAE,GAAO;;;AAElB,sBAAsB;EACpB,OAAO,EAAE,GAAO;;;AAElB,wBAAwB;EACtB,OAAO,EAAE,GAAO;;;ACnElB,aAAa;EACX,QAAQ,EAAE,KAAK;EACf,MAAM,EAAE,CAAC;EACT,IAAI,EAAE,CAAC;EACP,KAAK,EC6E+B,KAAK;ED5EzC,KAAK,ECE+B,OAAyB;EDD7D,UAAU,EAAE,OAAkC;EAC9C,UAAU,EAAE,kBAAiC;EAC7C,WAAW,EEAyB,2DAAM;EFC1C,OAAO,EC+E6B,GAAG;;AD9EvC,eAAC;EACC,KAAK,ECqE6B,OAAW;EDpE7C,eAAe,EAAE,IAAI;;AACvB,8BAAgB;EACd,OAAO,EAAE,IAAI;;AACf,kCAAoB;EAClB,OAAO,EAAE,IAAqB;EAC9B,gBAAgB,EAAE,OAAkC;EACpD,OAAO,EAAE,KAAK;EACd,UAAU,EAAE,KAAK;EACjB,SAAS,EAAE,GAAG;EACd,MAAM,EAAE,OAAO;EACf,KAAK,ECiD6B,OAAM;EJgC1C,KAAK,EAAE,CAAC;;AACR,mFAAS;EAEP,OAAO,EAAE,KAAK;EACd,OAAO,EAAE,EAAE;;AACb,wCAAO;EACL,KAAK,EAAE,IAAI;;AGrFX,sCAAG;EACD,KAAK,EClB2B,OAAyB;;ADmB3D,2CAAQ;EACN,KAAK,EAAE,IAAI;;AACb,6CAAU;EACR,KAAK,EAAE,IAAI;;AACb,kDAAiB;EACf,gBAAgB,ECQgB,OAAI;EDPpC,KAAK,EC0B2B,IAAM;;ADzBxC,yDAAwB;EACtB,gBAAgB,ECXgB,OAAO;EDYvC,KAAK,ECzB2B,IAAI;;AD0BxC,0CAA8B;EAC5B,OAAO,EAAE,KAAK;;AAChB,iCAAmB;EACjB,SAAS,EAAE,GAAG;EACd,OAAO,EAAE,IAAqB;EAC9B,KAAK,ECE6B,IAAwB;EDD1D,OAAO,EAAE,IAAI;;AACb,oCAAE;EACA,OAAO,EAAE,KAAK;EACd,MAAM,EAAE,GAAG;EACX,MAAM,EAAE,CAAC;EACT,MAAM,EAAE,MAAM;EACd,OAAO,EAAE,CAAC;EACV,UAAU,EAAE,iBAA6C;;AAC3D,oCAAE;EACA,OAAO,EAAE,YAAY;EACrB,MAAM,EAAE,CAAC;;AACT,sCAAC;EACC,OAAO,EAAE,YAAY;EACrB,OAAO,EAAE,GAAqB;EAC9B,KAAK,ECjDyB,OAAyB;;ADkD7D,uBAAW;EACT,KAAK,EAAE,IAAI;EACX,MAAM,EAAE,IAAI;EACZ,KAAK,EAAE,IAAI;EACX,IAAI,EAAE,IAAI;EACV,MAAM,EAAE,IAAI;EACZ,SAAS,ECkByB,KAAK;;ADjBvC,kCAAU;EACR,KAAK,EAAE,IAAI;;AACb,gCAAQ;EACN,KAAK,EAAE,IAAI;;AACb,qDAA+B;EAC7B,UAAU,EAAE,KAAK;;AACjB,8DAAQ;EACN,KAAK,EAAE,IAAI;;AACb,gEAAU;EACR,KAAK,EAAE,IAAI;;AACf,4CAAoB;EAClB,KAAK,EAAE,IAAI;EACX,MAAM,EAAE,IAAI;EACZ,WAAW,EAAE,IAAI;EACjB,OAAO,EAAE,KAAuB;EAChC,OAAO,EAAE,KAAK;EACd,UAAU,EAAE,MAAM;;;AGhDpB,oCAAsB;EHmDxB,aAAa;IACX,KAAK,EAAE,GAAG;IACV,OAAO,EAAE,IAAI;;EACb,mBAAO;IACL,OAAO,EAAE,KAAK;;;EAClB,GAAG;IACD,KAAK,EAAE,IAAI;IACX,MAAM,EAAE,IAAI", +"sources": ["../../../bower_components/wyrm/sass/wyrm_core/_mixin.sass","../../../bower_components/bourbon/dist/css3/_font-face.scss","../../../sass/_theme_badge_fa.sass","../../../sass/_theme_badge.sass","../../../bower_components/wyrm/sass/wyrm_core/_wy_variables.sass","../../../sass/_theme_variables.sass","../../../bower_components/neat/app/assets/stylesheets/grid/_media.scss"], +"names": [], +"file": "badge_only.css" +} diff --git a/doc/_themes/lammps_theme/static/css/theme.css b/doc/_themes/lammps_theme/static/css/theme.css new file mode 100644 index 00000000..909adec4 --- /dev/null +++ b/doc/_themes/lammps_theme/static/css/theme.css @@ -0,0 +1,5096 @@ +@charset "UTF-8"; +* { + -webkit-box-sizing: border-box; + -moz-box-sizing: border-box; + box-sizing: border-box; +} + +article, aside, details, figcaption, figure, footer, header, hgroup, nav, section { + display: block; +} + +audio, canvas, video { + display: inline-block; + *display: inline; + *zoom: 1; +} + +audio:not([controls]) { + display: none; +} + +[hidden] { + display: none; +} + +* { + -webkit-box-sizing: border-box; + -moz-box-sizing: border-box; + box-sizing: border-box; +} + +html { + font-size: 100%; + -webkit-text-size-adjust: 100%; + -ms-text-size-adjust: 100%; +} + +body { + margin: 0; +} + +a:hover, a:active { + outline: 0; +} + +abbr[title] { + border-bottom: 1px dotted; +} + +b, strong { + font-weight: bold; +} + +blockquote { + margin: 0; +} + +dfn { + font-style: italic; +} + +ins { + background: #ff9; + color: #000; + text-decoration: none; +} + +mark { + background: #ff0; + color: #000; + font-style: italic; + font-weight: bold; +} + +pre, code, .rst-content tt, .rst-content code, kbd, samp { + font-family: monospace, serif; + _font-family: "courier new", monospace; + font-size: 1em; +} + +pre { + white-space: pre; +} + +q { + quotes: none; +} + +q:before, q:after { + content: ""; + content: none; +} + +small { + font-size: 85%; +} + +sub, sup { + font-size: 75%; + line-height: 0; + position: relative; + vertical-align: baseline; +} + +sup { + top: -0.5em; +} + +sub { + bottom: -0.25em; +} + +ul, ol, dl { + margin: 0; + padding: 0; + list-style: none; + list-style-image: none; +} + +li { + list-style: none; +} + +dd { + margin: 0; +} + +img { + border: 0; + -ms-interpolation-mode: bicubic; + vertical-align: middle; + max-width: 100%; +} + +svg:not(:root) { + overflow: hidden; +} + +figure { + margin: 0; +} + +form { + margin: 0; +} + +fieldset { + border: 0; + margin: 0; + padding: 0; +} + +label { + cursor: pointer; +} + +legend { + border: 0; + *margin-left: -7px; + padding: 0; + white-space: normal; +} + +button, input, select, textarea { + font-size: 100%; + margin: 0; + vertical-align: baseline; + *vertical-align: middle; +} + +button, input { + line-height: normal; +} + +button, input[type="button"], input[type="reset"], input[type="submit"] { + cursor: pointer; + -webkit-appearance: button; + *overflow: visible; +} + +button[disabled], input[disabled] { + cursor: default; +} + +input[type="checkbox"], input[type="radio"] { + box-sizing: border-box; + padding: 0; + *width: 13px; + *height: 13px; +} + +input[type="search"] { + -webkit-appearance: textfield; + -moz-box-sizing: content-box; + -webkit-box-sizing: content-box; + box-sizing: content-box; +} + +input[type="search"]::-webkit-search-decoration, input[type="search"]::-webkit-search-cancel-button { + -webkit-appearance: none; +} + +button::-moz-focus-inner, input::-moz-focus-inner { + border: 0; + padding: 0; +} + +textarea { + overflow: auto; + vertical-align: top; + resize: vertical; +} + +table { + border-collapse: collapse; + border-spacing: 0; +} + +td { + vertical-align: top; +} + +.chromeframe { + margin: 0.2em 0; + background: #ccc; + color: black; + padding: 0.2em 0; +} + +.ir { + display: block; + border: 0; + text-indent: -999em; + overflow: hidden; + background-color: transparent; + background-repeat: no-repeat; + text-align: left; + direction: ltr; + *line-height: 0; +} + +.ir br { + display: none; +} + +.hidden { + display: none !important; + visibility: hidden; +} + +.visuallyhidden { + border: 0; + clip: rect(0 0 0 0); + height: 1px; + margin: -1px; + overflow: hidden; + padding: 0; + position: absolute; + width: 1px; +} + +.visuallyhidden.focusable:active, .visuallyhidden.focusable:focus { + clip: auto; + height: auto; + margin: 0; + overflow: visible; + position: static; + width: auto; +} + +.invisible { + visibility: hidden; +} + +.relative { + position: relative; +} + +big, small { + font-size: 100%; +} + +@media print { + html, body, section { + background: none !important; + } + + * { + box-shadow: none !important; + text-shadow: none !important; + filter: none !important; + -ms-filter: none !important; + } + + a, a:visited { + text-decoration: underline; + } + + .ir a:after, a[href^="javascript:"]:after, a[href^="#"]:after { + content: ""; + } + + pre, blockquote { + page-break-inside: avoid; + } + + thead { + display: table-header-group; + } + + tr, img { + page-break-inside: avoid; + } + + img { + max-width: 100% !important; + } + + @page { + margin: 0.5cm; + } + p, h2, .rst-content .toctree-wrapper p.caption, h3 { + orphans: 3; + widows: 3; + } + + h2, .rst-content .toctree-wrapper p.caption, h3 { + page-break-after: avoid; + } +} +.fa:before, .wy-menu-vertical li span.toctree-expand:before, .wy-menu-vertical li.on a span.toctree-expand:before, .wy-menu-vertical li.current > a span.toctree-expand:before, .rst-content .admonition-title:before, .rst-content h1 .headerlink:before, .rst-content h2 .headerlink:before, .rst-content h3 .headerlink:before, .rst-content h4 .headerlink:before, .rst-content h5 .headerlink:before, .rst-content h6 .headerlink:before, .rst-content dl dt .headerlink:before, .rst-content p.caption .headerlink:before, .rst-content tt.download span:first-child:before, .rst-content code.download span:first-child:before, .icon:before, .wy-dropdown .caret:before, .wy-inline-validate.wy-inline-validate-success .wy-input-context:before, .wy-inline-validate.wy-inline-validate-danger .wy-input-context:before, .wy-inline-validate.wy-inline-validate-warning .wy-input-context:before, .wy-inline-validate.wy-inline-validate-info .wy-input-context:before, .wy-alert, .rst-content .note, .rst-content .attention, .rst-content .caution, .rst-content .danger, .rst-content .error, .rst-content .hint, .rst-content .important, .rst-content .tip, .rst-content .warning, .rst-content .seealso, .rst-content .admonition-todo, .btn, input[type="text"], input[type="password"], input[type="email"], input[type="url"], input[type="date"], input[type="month"], input[type="time"], input[type="datetime"], input[type="datetime-local"], input[type="week"], input[type="number"], input[type="search"], input[type="tel"], input[type="color"], select, textarea, .wy-menu-vertical li.on a, .wy-menu-vertical li.current > a, .wy-side-nav-search > a, .wy-side-nav-search .wy-dropdown > a, .wy-nav-top a { + -webkit-font-smoothing: antialiased; +} + +.clearfix { + *zoom: 1; +} +.clearfix:before, .clearfix:after { + display: table; + content: ""; +} +.clearfix:after { + clear: both; +} + +/*! + * Font Awesome 4.2.0 by @davegandy - http://fontawesome.io - @fontawesome + * License - http://fontawesome.io/license (Font: SIL OFL 1.1, CSS: MIT License) + */ +/* FONT PATH + * -------------------------- */ +@font-face { + font-family: 'FontAwesome'; + src: url("../fonts/fontawesome-webfont.eot?v=4.2.0"); + src: url("../fonts/fontawesome-webfont.eot?#iefix&v=4.2.0") format("embedded-opentype"), url("../fonts/fontawesome-webfont.woff?v=4.2.0") format("woff"), url("../fonts/fontawesome-webfont.ttf?v=4.2.0") format("truetype"), url("../fonts/fontawesome-webfont.svg?v=4.2.0#fontawesomeregular") format("svg"); + font-weight: normal; + font-style: normal; +} +.fa, .wy-menu-vertical li span.toctree-expand, .wy-menu-vertical li.on a span.toctree-expand, .wy-menu-vertical li.current > a span.toctree-expand, .rst-content .admonition-title, .rst-content h1 .headerlink, .rst-content h2 .headerlink, .rst-content h3 .headerlink, .rst-content h4 .headerlink, .rst-content h5 .headerlink, .rst-content h6 .headerlink, .rst-content dl dt .headerlink, .rst-content p.caption .headerlink, .rst-content tt.download span:first-child, .rst-content code.download span:first-child, .icon { + display: inline-block; + font: normal normal normal 14px/1 FontAwesome; + font-size: inherit; + text-rendering: auto; + -webkit-font-smoothing: antialiased; + -moz-osx-font-smoothing: grayscale; +} + +/* makes the font 33% larger relative to the icon container */ +.fa-lg { + font-size: 1.33333em; + line-height: 0.75em; + vertical-align: -15%; +} + +.fa-2x { + font-size: 2em; +} + +.fa-3x { + font-size: 3em; +} + +.fa-4x { + font-size: 4em; +} + +.fa-5x { + font-size: 5em; +} + +.fa-fw { + width: 1.28571em; + text-align: center; +} + +.fa-ul { + padding-left: 0; + margin-left: 2.14286em; + list-style-type: none; +} +.fa-ul > li { + position: relative; +} + +.fa-li { + position: absolute; + left: -2.14286em; + width: 2.14286em; + top: 0.14286em; + text-align: center; +} +.fa-li.fa-lg { + left: -1.85714em; +} + +.fa-border { + padding: .2em .25em .15em; + border: solid 0.08em #eee; + border-radius: .1em; +} + +.pull-right { + float: right; +} + +.pull-left { + float: left; +} + +.fa.pull-left, .wy-menu-vertical li span.pull-left.toctree-expand, .wy-menu-vertical li.on a span.pull-left.toctree-expand, .wy-menu-vertical li.current > a span.pull-left.toctree-expand, .rst-content .pull-left.admonition-title, .rst-content h1 .pull-left.headerlink, .rst-content h2 .pull-left.headerlink, .rst-content h3 .pull-left.headerlink, .rst-content h4 .pull-left.headerlink, .rst-content h5 .pull-left.headerlink, .rst-content h6 .pull-left.headerlink, .rst-content dl dt .pull-left.headerlink, .rst-content p.caption .pull-left.headerlink, .rst-content tt.download span.pull-left:first-child, .rst-content code.download span.pull-left:first-child, .pull-left.icon { + margin-right: .3em; +} +.fa.pull-right, .wy-menu-vertical li span.pull-right.toctree-expand, .wy-menu-vertical li.on a span.pull-right.toctree-expand, .wy-menu-vertical li.current > a span.pull-right.toctree-expand, .rst-content .pull-right.admonition-title, .rst-content h1 .pull-right.headerlink, .rst-content h2 .pull-right.headerlink, .rst-content h3 .pull-right.headerlink, .rst-content h4 .pull-right.headerlink, .rst-content h5 .pull-right.headerlink, .rst-content h6 .pull-right.headerlink, .rst-content dl dt .pull-right.headerlink, .rst-content p.caption .pull-right.headerlink, .rst-content tt.download span.pull-right:first-child, .rst-content code.download span.pull-right:first-child, .pull-right.icon { + margin-left: .3em; +} + +.fa-spin { + -webkit-animation: fa-spin 2s infinite linear; + animation: fa-spin 2s infinite linear; +} + +@-webkit-keyframes fa-spin { + 0% { + -webkit-transform: rotate(0deg); + transform: rotate(0deg); + } + 100% { + -webkit-transform: rotate(359deg); + transform: rotate(359deg); + } +} +@keyframes fa-spin { + 0% { + -webkit-transform: rotate(0deg); + transform: rotate(0deg); + } + 100% { + -webkit-transform: rotate(359deg); + transform: rotate(359deg); + } +} +.fa-rotate-90 { + filter: progid:DXImageTransform.Microsoft.BasicImage(rotation=1); + -webkit-transform: rotate(90deg); + -ms-transform: rotate(90deg); + transform: rotate(90deg); +} + +.fa-rotate-180 { + filter: progid:DXImageTransform.Microsoft.BasicImage(rotation=2); + -webkit-transform: rotate(180deg); + -ms-transform: rotate(180deg); + transform: rotate(180deg); +} + +.fa-rotate-270 { + filter: progid:DXImageTransform.Microsoft.BasicImage(rotation=3); + -webkit-transform: rotate(270deg); + -ms-transform: rotate(270deg); + transform: rotate(270deg); +} + +.fa-flip-horizontal { + filter: progid:DXImageTransform.Microsoft.BasicImage(rotation=0); + -webkit-transform: scale(-1, 1); + -ms-transform: scale(-1, 1); + transform: scale(-1, 1); +} + +.fa-flip-vertical { + filter: progid:DXImageTransform.Microsoft.BasicImage(rotation=2); + -webkit-transform: scale(1, -1); + -ms-transform: scale(1, -1); + transform: scale(1, -1); +} + +:root .fa-rotate-90, +:root .fa-rotate-180, +:root .fa-rotate-270, +:root .fa-flip-horizontal, +:root .fa-flip-vertical { + filter: none; +} + +.fa-stack { + position: relative; + display: inline-block; + width: 2em; + height: 2em; + line-height: 2em; + vertical-align: middle; +} + +.fa-stack-1x, .fa-stack-2x { + position: absolute; + left: 0; + width: 100%; + text-align: center; +} + +.fa-stack-1x { + line-height: inherit; +} + +.fa-stack-2x { + font-size: 2em; +} + +.fa-inverse { + color: #fff; +} + +/* Font Awesome uses the Unicode Private Use Area (PUA) to ensure screen + readers do not read off random characters that represent icons */ +.fa-glass:before { + content: ""; +} + +.fa-music:before { + content: ""; +} + +.fa-search:before, .icon-search:before { + content: ""; +} + +.fa-envelope-o:before { + content: ""; +} + +.fa-heart:before { + content: ""; +} + +.fa-star:before { + content: ""; +} + +.fa-star-o:before { + content: ""; +} + +.fa-user:before { + content: ""; +} + +.fa-film:before { + content: ""; +} + +.fa-th-large:before { + content: ""; +} + +.fa-th:before { + content: ""; +} + +.fa-th-list:before { + content: ""; +} + +.fa-check:before { + content: ""; +} + +.fa-remove:before, +.fa-close:before, +.fa-times:before { + content: ""; +} + +.fa-search-plus:before { + content: ""; +} + +.fa-search-minus:before { + content: ""; +} + +.fa-power-off:before { + content: ""; +} + +.fa-signal:before { + content: ""; +} + +.fa-gear:before, +.fa-cog:before { + content: ""; +} + +.fa-trash-o:before { + content: ""; +} + +.fa-home:before, .icon-home:before { + content: ""; +} + +.fa-file-o:before { + content: ""; +} + +.fa-clock-o:before { + content: ""; +} + +.fa-road:before { + content: ""; +} + +.fa-download:before, .rst-content tt.download span:first-child:before, .rst-content code.download span:first-child:before { + content: ""; +} + +.fa-arrow-circle-o-down:before { + content: ""; +} + +.fa-arrow-circle-o-up:before { + content: ""; +} + +.fa-inbox:before { + content: ""; +} + +.fa-play-circle-o:before { + content: ""; +} + +.fa-rotate-right:before, +.fa-repeat:before { + content: ""; +} + +.fa-refresh:before { + content: ""; +} + +.fa-list-alt:before { + content: ""; +} + +.fa-lock:before { + content: ""; +} + +.fa-flag:before { + content: ""; +} + +.fa-headphones:before { + content: ""; +} + +.fa-volume-off:before { + content: ""; +} + +.fa-volume-down:before { + content: ""; +} + +.fa-volume-up:before { + content: ""; +} + +.fa-qrcode:before { + content: ""; +} + +.fa-barcode:before { + content: ""; +} + +.fa-tag:before { + content: ""; +} + +.fa-tags:before { + content: ""; +} + +.fa-book:before, .icon-book:before { + content: ""; +} + +.fa-bookmark:before { + content: ""; +} + +.fa-print:before { + content: ""; +} + +.fa-camera:before { + content: ""; +} + +.fa-font:before { + content: ""; +} + +.fa-bold:before { + content: ""; +} + +.fa-italic:before { + content: ""; +} + +.fa-text-height:before { + content: ""; +} + +.fa-text-width:before { + content: ""; +} + +.fa-align-left:before { + content: ""; +} + +.fa-align-center:before { + content: ""; +} + +.fa-align-right:before { + content: ""; +} + +.fa-align-justify:before { + content: ""; +} + +.fa-list:before { + content: ""; +} + +.fa-dedent:before, +.fa-outdent:before { + content: ""; +} + +.fa-indent:before { + content: ""; +} + +.fa-video-camera:before { + content: ""; +} + +.fa-photo:before, +.fa-image:before, +.fa-picture-o:before { + content: ""; +} + +.fa-pencil:before { + content: ""; +} + +.fa-map-marker:before { + content: ""; +} + +.fa-adjust:before { + content: ""; +} + +.fa-tint:before { + content: ""; +} + +.fa-edit:before, +.fa-pencil-square-o:before { + content: ""; +} + +.fa-share-square-o:before { + content: ""; +} + +.fa-check-square-o:before { + content: ""; +} + +.fa-arrows:before { + content: ""; +} + +.fa-step-backward:before { + content: ""; +} + +.fa-fast-backward:before { + content: ""; +} + +.fa-backward:before { + content: ""; +} + +.fa-play:before { + content: ""; +} + +.fa-pause:before { + content: ""; +} + +.fa-stop:before { + content: ""; +} + +.fa-forward:before { + content: ""; +} + +.fa-fast-forward:before { + content: ""; +} + +.fa-step-forward:before { + content: ""; +} + +.fa-eject:before { + content: ""; +} + +.fa-chevron-left:before { + content: ""; +} + +.fa-chevron-right:before { + content: ""; +} + +.fa-plus-circle:before { + content: ""; +} + +.fa-minus-circle:before { + content: ""; +} + +.fa-times-circle:before, .wy-inline-validate.wy-inline-validate-danger .wy-input-context:before { + content: ""; +} + +.fa-check-circle:before, .wy-inline-validate.wy-inline-validate-success .wy-input-context:before { + content: ""; +} + +.fa-question-circle:before { + content: ""; +} + +.fa-info-circle:before { + content: ""; +} + +.fa-crosshairs:before { + content: ""; +} + +.fa-times-circle-o:before { + content: ""; +} + +.fa-check-circle-o:before { + content: ""; +} + +.fa-ban:before { + content: ""; +} + +.fa-arrow-left:before { + content: ""; +} + +.fa-arrow-right:before { + content: ""; +} + +.fa-arrow-up:before { + content: ""; +} + +.fa-arrow-down:before { + content: ""; +} + +.fa-mail-forward:before, +.fa-share:before { + content: ""; +} + +.fa-expand:before { + content: ""; +} + +.fa-compress:before { + content: ""; +} + +.fa-plus:before { + content: ""; +} + +.fa-minus:before { + content: ""; +} + +.fa-asterisk:before { + content: ""; +} + +.fa-exclamation-circle:before, .wy-inline-validate.wy-inline-validate-warning .wy-input-context:before, .wy-inline-validate.wy-inline-validate-info .wy-input-context:before, .rst-content .admonition-title:before { + content: ""; +} + +.fa-gift:before { + content: ""; +} + +.fa-leaf:before { + content: ""; +} + +.fa-fire:before, .icon-fire:before { + content: ""; +} + +.fa-eye:before { + content: ""; +} + +.fa-eye-slash:before { + content: ""; +} + +.fa-warning:before, +.fa-exclamation-triangle:before { + content: ""; +} + +.fa-plane:before { + content: ""; +} + +.fa-calendar:before { + content: ""; +} + +.fa-random:before { + content: ""; +} + +.fa-comment:before { + content: ""; +} + +.fa-magnet:before { + content: ""; +} + +.fa-chevron-up:before { + content: ""; +} + +.fa-chevron-down:before { + content: ""; +} + +.fa-retweet:before { + content: ""; +} + +.fa-shopping-cart:before { + content: ""; +} + +.fa-folder:before { + content: ""; +} + +.fa-folder-open:before { + content: ""; +} + +.fa-arrows-v:before { + content: ""; +} + +.fa-arrows-h:before { + content: ""; +} + +.fa-bar-chart-o:before, +.fa-bar-chart:before { + content: ""; +} + +.fa-twitter-square:before { + content: ""; +} + +.fa-facebook-square:before { + content: ""; +} + +.fa-camera-retro:before { + content: ""; +} + +.fa-key:before { + content: ""; +} + +.fa-gears:before, +.fa-cogs:before { + content: ""; +} + +.fa-comments:before { + content: ""; +} + +.fa-thumbs-o-up:before { + content: ""; +} + +.fa-thumbs-o-down:before { + content: ""; +} + +.fa-star-half:before { + content: ""; +} + +.fa-heart-o:before { + content: ""; +} + +.fa-sign-out:before { + content: ""; +} + +.fa-linkedin-square:before { + content: ""; +} + +.fa-thumb-tack:before { + content: ""; +} + +.fa-external-link:before { + content: ""; +} + +.fa-sign-in:before { + content: ""; +} + +.fa-trophy:before { + content: ""; +} + +.fa-github-square:before { + content: ""; +} + +.fa-upload:before { + content: ""; +} + +.fa-lemon-o:before { + content: ""; +} + +.fa-phone:before { + content: ""; +} + +.fa-square-o:before { + content: ""; +} + +.fa-bookmark-o:before { + content: ""; +} + +.fa-phone-square:before { + content: ""; +} + +.fa-twitter:before { + content: ""; +} + +.fa-facebook:before { + content: ""; +} + +.fa-github:before, .icon-github:before { + content: ""; +} + +.fa-unlock:before { + content: ""; +} + +.fa-credit-card:before { + content: ""; +} + +.fa-rss:before { + content: ""; +} + +.fa-hdd-o:before { + content: ""; +} + +.fa-bullhorn:before { + content: ""; +} + +.fa-bell:before { + content: ""; +} + +.fa-certificate:before { + content: ""; +} + +.fa-hand-o-right:before { + content: ""; +} + +.fa-hand-o-left:before { + content: ""; +} + +.fa-hand-o-up:before { + content: ""; +} + +.fa-hand-o-down:before { + content: ""; +} + +.fa-arrow-circle-left:before, .icon-circle-arrow-left:before { + content: ""; +} + +.fa-arrow-circle-right:before, .icon-circle-arrow-right:before { + content: ""; +} + +.fa-arrow-circle-up:before { + content: ""; +} + +.fa-arrow-circle-down:before { + content: ""; +} + +.fa-globe:before { + content: ""; +} + +.fa-wrench:before { + content: ""; +} + +.fa-tasks:before { + content: ""; +} + +.fa-filter:before { + content: ""; +} + +.fa-briefcase:before { + content: ""; +} + +.fa-arrows-alt:before { + content: ""; +} + +.fa-group:before, +.fa-users:before { + content: ""; +} + +.fa-chain:before, +.fa-link:before, +.icon-link:before { + content: ""; +} + +.fa-cloud:before { + content: ""; +} + +.fa-flask:before { + content: ""; +} + +.fa-cut:before, +.fa-scissors:before { + content: ""; +} + +.fa-copy:before, +.fa-files-o:before { + content: ""; +} + +.fa-paperclip:before { + content: ""; +} + +.fa-save:before, +.fa-floppy-o:before { + content: ""; +} + +.fa-square:before { + content: ""; +} + +.fa-navicon:before, +.fa-reorder:before, +.fa-bars:before { + content: ""; +} + +.fa-list-ul:before { + content: ""; +} + +.fa-list-ol:before { + content: ""; +} + +.fa-strikethrough:before { + content: ""; +} + +.fa-underline:before { + content: ""; +} + +.fa-table:before { + content: ""; +} + +.fa-magic:before { + content: ""; +} + +.fa-truck:before { + content: ""; +} + +.fa-pinterest:before { + content: ""; +} + +.fa-pinterest-square:before { + content: ""; +} + +.fa-google-plus-square:before { + content: ""; +} + +.fa-google-plus:before { + content: ""; +} + +.fa-money:before { + content: ""; +} + +.fa-caret-down:before, .wy-dropdown .caret:before, .icon-caret-down:before { + content: ""; +} + +.fa-caret-up:before { + content: ""; +} + +.fa-caret-left:before { + content: ""; +} + +.fa-caret-right:before { + content: ""; +} + +.fa-columns:before { + content: ""; +} + +.fa-unsorted:before, +.fa-sort:before { + content: ""; +} + +.fa-sort-down:before, +.fa-sort-desc:before { + content: ""; +} + +.fa-sort-up:before, +.fa-sort-asc:before { + content: ""; +} + +.fa-envelope:before { + content: ""; +} + +.fa-linkedin:before { + content: ""; +} + +.fa-rotate-left:before, +.fa-undo:before { + content: ""; +} + +.fa-legal:before, +.fa-gavel:before { + content: ""; +} + +.fa-dashboard:before, +.fa-tachometer:before { + content: ""; +} + +.fa-comment-o:before { + content: ""; +} + +.fa-comments-o:before { + content: ""; +} + +.fa-flash:before, +.fa-bolt:before { + content: ""; +} + +.fa-sitemap:before { + content: ""; +} + +.fa-umbrella:before { + content: ""; +} + +.fa-paste:before, +.fa-clipboard:before { + content: ""; +} + +.fa-lightbulb-o:before { + content: ""; +} + +.fa-exchange:before { + content: ""; +} + +.fa-cloud-download:before { + content: ""; +} + +.fa-cloud-upload:before { + content: ""; +} + +.fa-user-md:before { + content: ""; +} + +.fa-stethoscope:before { + content: ""; +} + +.fa-suitcase:before { + content: ""; +} + +.fa-bell-o:before { + content: ""; +} + +.fa-coffee:before { + content: ""; +} + +.fa-cutlery:before { + content: ""; +} + +.fa-file-text-o:before { + content: ""; +} + +.fa-building-o:before { + content: ""; +} + +.fa-hospital-o:before { + content: ""; +} + +.fa-ambulance:before { + content: ""; +} + +.fa-medkit:before { + content: ""; +} + +.fa-fighter-jet:before { + content: ""; +} + +.fa-beer:before { + content: ""; +} + +.fa-h-square:before { + content: ""; +} + +.fa-plus-square:before { + content: ""; +} + +.fa-angle-double-left:before { + content: ""; +} + +.fa-angle-double-right:before { + content: ""; +} + +.fa-angle-double-up:before { + content: ""; +} + +.fa-angle-double-down:before { + content: ""; +} + +.fa-angle-left:before { + content: ""; +} + +.fa-angle-right:before { + content: ""; +} + +.fa-angle-up:before { + content: ""; +} + +.fa-angle-down:before { + content: ""; +} + +.fa-desktop:before { + content: ""; +} + +.fa-laptop:before { + content: ""; +} + +.fa-tablet:before { + content: ""; +} + +.fa-mobile-phone:before, +.fa-mobile:before { + content: ""; +} + +.fa-circle-o:before { + content: ""; +} + +.fa-quote-left:before { + content: ""; +} + +.fa-quote-right:before { + content: ""; +} + +.fa-spinner:before { + content: ""; +} + +.fa-circle:before { + content: ""; +} + +.fa-mail-reply:before, +.fa-reply:before { + content: ""; +} + +.fa-github-alt:before { + content: ""; +} + +.fa-folder-o:before { + content: ""; +} + +.fa-folder-open-o:before { + content: ""; +} + +.fa-smile-o:before { + content: ""; +} + +.fa-frown-o:before { + content: ""; +} + +.fa-meh-o:before { + content: ""; +} + +.fa-gamepad:before { + content: ""; +} + +.fa-keyboard-o:before { + content: ""; +} + +.fa-flag-o:before { + content: ""; +} + +.fa-flag-checkered:before { + content: ""; +} + +.fa-terminal:before { + content: ""; +} + +.fa-code:before { + content: ""; +} + +.fa-mail-reply-all:before, +.fa-reply-all:before { + content: ""; +} + +.fa-star-half-empty:before, +.fa-star-half-full:before, +.fa-star-half-o:before { + content: ""; +} + +.fa-location-arrow:before { + content: ""; +} + +.fa-crop:before { + content: ""; +} + +.fa-code-fork:before { + content: ""; +} + +.fa-unlink:before, +.fa-chain-broken:before { + content: ""; +} + +.fa-question:before { + content: ""; +} + +.fa-info:before { + content: ""; +} + +.fa-exclamation:before { + content: ""; +} + +.fa-superscript:before { + content: ""; +} + +.fa-subscript:before { + content: ""; +} + +.fa-eraser:before { + content: ""; +} + +.fa-puzzle-piece:before { + content: ""; +} + +.fa-microphone:before { + content: ""; +} + +.fa-microphone-slash:before { + content: ""; +} + +.fa-shield:before { + content: ""; +} + +.fa-calendar-o:before { + content: ""; +} + +.fa-fire-extinguisher:before { + content: ""; +} + +.fa-rocket:before { + content: ""; +} + +.fa-maxcdn:before { + content: ""; +} + +.fa-chevron-circle-left:before { + content: ""; +} + +.fa-chevron-circle-right:before { + content: ""; +} + +.fa-chevron-circle-up:before { + content: ""; +} + +.fa-chevron-circle-down:before { + content: ""; +} + +.fa-html5:before { + content: ""; +} + +.fa-css3:before { + content: ""; +} + +.fa-anchor:before { + content: ""; +} + +.fa-unlock-alt:before { + content: ""; +} + +.fa-bullseye:before { + content: ""; +} + +.fa-ellipsis-h:before { + content: ""; +} + +.fa-ellipsis-v:before { + content: ""; +} + +.fa-rss-square:before { + content: ""; +} + +.fa-play-circle:before { + content: ""; +} + +.fa-ticket:before { + content: ""; +} + +.fa-minus-square:before { + content: ""; +} + +.fa-minus-square-o:before, .wy-menu-vertical li.on a span.toctree-expand:before, .wy-menu-vertical li.current > a span.toctree-expand:before { + content: ""; +} + +.fa-level-up:before { + content: ""; +} + +.fa-level-down:before { + content: ""; +} + +.fa-check-square:before { + content: ""; +} + +.fa-pencil-square:before { + content: ""; +} + +.fa-external-link-square:before { + content: ""; +} + +.fa-share-square:before { + content: ""; +} + +.fa-compass:before { + content: ""; +} + +.fa-toggle-down:before, +.fa-caret-square-o-down:before { + content: ""; +} + +.fa-toggle-up:before, +.fa-caret-square-o-up:before { + content: ""; +} + +.fa-toggle-right:before, +.fa-caret-square-o-right:before { + content: ""; +} + +.fa-euro:before, +.fa-eur:before { + content: ""; +} + +.fa-gbp:before { + content: ""; +} + +.fa-dollar:before, +.fa-usd:before { + content: ""; +} + +.fa-rupee:before, +.fa-inr:before { + content: ""; +} + +.fa-cny:before, +.fa-rmb:before, +.fa-yen:before, +.fa-jpy:before { + content: ""; +} + +.fa-ruble:before, +.fa-rouble:before, +.fa-rub:before { + content: ""; +} + +.fa-won:before, +.fa-krw:before { + content: ""; +} + +.fa-bitcoin:before, +.fa-btc:before { + content: ""; +} + +.fa-file:before { + content: ""; +} + +.fa-file-text:before { + content: ""; +} + +.fa-sort-alpha-asc:before { + content: ""; +} + +.fa-sort-alpha-desc:before { + content: ""; +} + +.fa-sort-amount-asc:before { + content: ""; +} + +.fa-sort-amount-desc:before { + content: ""; +} + +.fa-sort-numeric-asc:before { + content: ""; +} + +.fa-sort-numeric-desc:before { + content: ""; +} + +.fa-thumbs-up:before { + content: ""; +} + +.fa-thumbs-down:before { + content: ""; +} + +.fa-youtube-square:before { + content: ""; +} + +.fa-youtube:before { + content: ""; +} + +.fa-xing:before { + content: ""; +} + +.fa-xing-square:before { + content: ""; +} + +.fa-youtube-play:before { + content: ""; +} + +.fa-dropbox:before { + content: ""; +} + +.fa-stack-overflow:before { + content: ""; +} + +.fa-instagram:before { + content: ""; +} + +.fa-flickr:before { + content: ""; +} + +.fa-adn:before { + content: ""; +} + +.fa-bitbucket:before, .icon-bitbucket:before { + content: ""; +} + +.fa-bitbucket-square:before { + content: ""; +} + +.fa-tumblr:before { + content: ""; +} + +.fa-tumblr-square:before { + content: ""; +} + +.fa-long-arrow-down:before { + content: ""; +} + +.fa-long-arrow-up:before { + content: ""; +} + +.fa-long-arrow-left:before { + content: ""; +} + +.fa-long-arrow-right:before { + content: ""; +} + +.fa-apple:before { + content: ""; +} + +.fa-windows:before { + content: ""; +} + +.fa-android:before { + content: ""; +} + +.fa-linux:before { + content: ""; +} + +.fa-dribbble:before { + content: ""; +} + +.fa-skype:before { + content: ""; +} + +.fa-foursquare:before { + content: ""; +} + +.fa-trello:before { + content: ""; +} + +.fa-female:before { + content: ""; +} + +.fa-male:before { + content: ""; +} + +.fa-gittip:before { + content: ""; +} + +.fa-sun-o:before { + content: ""; +} + +.fa-moon-o:before { + content: ""; +} + +.fa-archive:before { + content: ""; +} + +.fa-bug:before { + content: ""; +} + +.fa-vk:before { + content: ""; +} + +.fa-weibo:before { + content: ""; +} + +.fa-renren:before { + content: ""; +} + +.fa-pagelines:before { + content: ""; +} + +.fa-stack-exchange:before { + content: ""; +} + +.fa-arrow-circle-o-right:before { + content: ""; +} + +.fa-arrow-circle-o-left:before { + content: ""; +} + +.fa-toggle-left:before, +.fa-caret-square-o-left:before { + content: ""; +} + +.fa-dot-circle-o:before { + content: ""; +} + +.fa-wheelchair:before { + content: ""; +} + +.fa-vimeo-square:before { + content: ""; +} + +.fa-turkish-lira:before, +.fa-try:before { + content: ""; +} + +.fa-plus-square-o:before, .wy-menu-vertical li span.toctree-expand:before { + content: ""; +} + +.fa-space-shuttle:before { + content: ""; +} + +.fa-slack:before { + content: ""; +} + +.fa-envelope-square:before { + content: ""; +} + +.fa-wordpress:before { + content: ""; +} + +.fa-openid:before { + content: ""; +} + +.fa-institution:before, +.fa-bank:before, +.fa-university:before { + content: ""; +} + +.fa-mortar-board:before, +.fa-graduation-cap:before { + content: ""; +} + +.fa-yahoo:before { + content: ""; +} + +.fa-google:before { + content: ""; +} + +.fa-reddit:before { + content: ""; +} + +.fa-reddit-square:before { + content: ""; +} + +.fa-stumbleupon-circle:before { + content: ""; +} + +.fa-stumbleupon:before { + content: ""; +} + +.fa-delicious:before { + content: ""; +} + +.fa-digg:before { + content: ""; +} + +.fa-pied-piper:before { + content: ""; +} + +.fa-pied-piper-alt:before { + content: ""; +} + +.fa-drupal:before { + content: ""; +} + +.fa-joomla:before { + content: ""; +} + +.fa-language:before { + content: ""; +} + +.fa-fax:before { + content: ""; +} + +.fa-building:before { + content: ""; +} + +.fa-child:before { + content: ""; +} + +.fa-paw:before { + content: ""; +} + +.fa-spoon:before { + content: ""; +} + +.fa-cube:before { + content: ""; +} + +.fa-cubes:before { + content: ""; +} + +.fa-behance:before { + content: ""; +} + +.fa-behance-square:before { + content: ""; +} + +.fa-steam:before { + content: ""; +} + +.fa-steam-square:before { + content: ""; +} + +.fa-recycle:before { + content: ""; +} + +.fa-automobile:before, +.fa-car:before { + content: ""; +} + +.fa-cab:before, +.fa-taxi:before { + content: ""; +} + +.fa-tree:before { + content: ""; +} + +.fa-spotify:before { + content: ""; +} + +.fa-deviantart:before { + content: ""; +} + +.fa-soundcloud:before { + content: ""; +} + +.fa-database:before { + content: ""; +} + +.fa-file-pdf-o:before { + content: ""; +} + +.fa-file-word-o:before { + content: ""; +} + +.fa-file-excel-o:before { + content: ""; +} + +.fa-file-powerpoint-o:before { + content: ""; +} + +.fa-file-photo-o:before, +.fa-file-picture-o:before, +.fa-file-image-o:before { + content: ""; +} + +.fa-file-zip-o:before, +.fa-file-archive-o:before { + content: ""; +} + +.fa-file-sound-o:before, +.fa-file-audio-o:before { + content: ""; +} + +.fa-file-movie-o:before, +.fa-file-video-o:before { + content: ""; +} + +.fa-file-code-o:before { + content: ""; +} + +.fa-vine:before { + content: ""; +} + +.fa-codepen:before { + content: ""; +} + +.fa-jsfiddle:before { + content: ""; +} + +.fa-life-bouy:before, +.fa-life-buoy:before, +.fa-life-saver:before, +.fa-support:before, +.fa-life-ring:before { + content: ""; +} + +.fa-circle-o-notch:before { + content: ""; +} + +.fa-ra:before, +.fa-rebel:before { + content: ""; +} + +.fa-ge:before, +.fa-empire:before { + content: ""; +} + +.fa-git-square:before { + content: ""; +} + +.fa-git:before { + content: ""; +} + +.fa-hacker-news:before { + content: ""; +} + +.fa-tencent-weibo:before { + content: ""; +} + +.fa-qq:before { + content: ""; +} + +.fa-wechat:before, +.fa-weixin:before { + content: ""; +} + +.fa-send:before, +.fa-paper-plane:before { + content: ""; +} + +.fa-send-o:before, +.fa-paper-plane-o:before { + content: ""; +} + +.fa-history:before { + content: ""; +} + +.fa-circle-thin:before { + content: ""; +} + +.fa-header:before { + content: ""; +} + +.fa-paragraph:before { + content: ""; +} + +.fa-sliders:before { + content: ""; +} + +.fa-share-alt:before { + content: ""; +} + +.fa-share-alt-square:before { + content: ""; +} + +.fa-bomb:before { + content: ""; +} + +.fa-soccer-ball-o:before, +.fa-futbol-o:before { + content: ""; +} + +.fa-tty:before { + content: ""; +} + +.fa-binoculars:before { + content: ""; +} + +.fa-plug:before { + content: ""; +} + +.fa-slideshare:before { + content: ""; +} + +.fa-twitch:before { + content: ""; +} + +.fa-yelp:before { + content: ""; +} + +.fa-newspaper-o:before { + content: ""; +} + +.fa-wifi:before { + content: ""; +} + +.fa-calculator:before { + content: ""; +} + +.fa-paypal:before { + content: ""; +} + +.fa-google-wallet:before { + content: ""; +} + +.fa-cc-visa:before { + content: ""; +} + +.fa-cc-mastercard:before { + content: ""; +} + +.fa-cc-discover:before { + content: ""; +} + +.fa-cc-amex:before { + content: ""; +} + +.fa-cc-paypal:before { + content: ""; +} + +.fa-cc-stripe:before { + content: ""; +} + +.fa-bell-slash:before { + content: ""; +} + +.fa-bell-slash-o:before { + content: ""; +} + +.fa-trash:before { + content: ""; +} + +.fa-copyright:before { + content: ""; +} + +.fa-at:before { + content: ""; +} + +.fa-eyedropper:before { + content: ""; +} + +.fa-paint-brush:before { + content: ""; +} + +.fa-birthday-cake:before { + content: ""; +} + +.fa-area-chart:before { + content: ""; +} + +.fa-pie-chart:before { + content: ""; +} + +.fa-line-chart:before { + content: ""; +} + +.fa-lastfm:before { + content: ""; +} + +.fa-lastfm-square:before { + content: ""; +} + +.fa-toggle-off:before { + content: ""; +} + +.fa-toggle-on:before { + content: ""; +} + +.fa-bicycle:before { + content: ""; +} + +.fa-bus:before { + content: ""; +} + +.fa-ioxhost:before { + content: ""; +} + +.fa-angellist:before { + content: ""; +} + +.fa-cc:before { + content: ""; +} + +.fa-shekel:before, +.fa-sheqel:before, +.fa-ils:before { + content: ""; +} + +.fa-meanpath:before { + content: ""; +} + +.fa, .wy-menu-vertical li span.toctree-expand, .wy-menu-vertical li.on a span.toctree-expand, .wy-menu-vertical li.current > a span.toctree-expand, .rst-content .admonition-title, .rst-content h1 .headerlink, .rst-content h2 .headerlink, .rst-content h3 .headerlink, .rst-content h4 .headerlink, .rst-content h5 .headerlink, .rst-content h6 .headerlink, .rst-content dl dt .headerlink, .rst-content p.caption .headerlink, .rst-content tt.download span:first-child, .rst-content code.download span:first-child, .icon, .wy-dropdown .caret, .wy-inline-validate.wy-inline-validate-success .wy-input-context, .wy-inline-validate.wy-inline-validate-danger .wy-input-context, .wy-inline-validate.wy-inline-validate-warning .wy-input-context, .wy-inline-validate.wy-inline-validate-info .wy-input-context { + font-family: inherit; +} +.fa:before, .wy-menu-vertical li span.toctree-expand:before, .wy-menu-vertical li.on a span.toctree-expand:before, .wy-menu-vertical li.current > a span.toctree-expand:before, .rst-content .admonition-title:before, .rst-content h1 .headerlink:before, .rst-content h2 .headerlink:before, .rst-content h3 .headerlink:before, .rst-content h4 .headerlink:before, .rst-content h5 .headerlink:before, .rst-content h6 .headerlink:before, .rst-content dl dt .headerlink:before, .rst-content p.caption .headerlink:before, .rst-content tt.download span:first-child:before, .rst-content code.download span:first-child:before, .icon:before, .wy-dropdown .caret:before, .wy-inline-validate.wy-inline-validate-success .wy-input-context:before, .wy-inline-validate.wy-inline-validate-danger .wy-input-context:before, .wy-inline-validate.wy-inline-validate-warning .wy-input-context:before, .wy-inline-validate.wy-inline-validate-info .wy-input-context:before { + font-family: "FontAwesome"; + display: inline-block; + font-style: normal; + font-weight: normal; + line-height: 1; + text-decoration: inherit; +} + +a .fa, a .wy-menu-vertical li span.toctree-expand, .wy-menu-vertical li a span.toctree-expand, .wy-menu-vertical li.on a span.toctree-expand, .wy-menu-vertical li.current > a span.toctree-expand, a .rst-content .admonition-title, .rst-content a .admonition-title, a .rst-content h1 .headerlink, .rst-content h1 a .headerlink, a .rst-content h2 .headerlink, .rst-content h2 a .headerlink, a .rst-content h3 .headerlink, .rst-content h3 a .headerlink, a .rst-content h4 .headerlink, .rst-content h4 a .headerlink, a .rst-content h5 .headerlink, .rst-content h5 a .headerlink, a .rst-content h6 .headerlink, .rst-content h6 a .headerlink, a .rst-content dl dt .headerlink, .rst-content dl dt a .headerlink, a .rst-content p.caption .headerlink, .rst-content p.caption a .headerlink, a .rst-content tt.download span:first-child, .rst-content tt.download a span:first-child, a .rst-content code.download span:first-child, .rst-content code.download a span:first-child, a .icon { + display: inline-block; + text-decoration: inherit; +} + +.btn .fa, .btn .wy-menu-vertical li span.toctree-expand, .wy-menu-vertical li .btn span.toctree-expand, .btn .wy-menu-vertical li.on a span.toctree-expand, .wy-menu-vertical li.on a .btn span.toctree-expand, .btn .wy-menu-vertical li.current > a span.toctree-expand, .wy-menu-vertical li.current > a .btn span.toctree-expand, .btn .rst-content .admonition-title, .rst-content .btn .admonition-title, .btn .rst-content h1 .headerlink, .rst-content h1 .btn .headerlink, .btn .rst-content h2 .headerlink, .rst-content h2 .btn .headerlink, .btn .rst-content h3 .headerlink, .rst-content h3 .btn .headerlink, .btn .rst-content h4 .headerlink, .rst-content h4 .btn .headerlink, .btn .rst-content h5 .headerlink, .rst-content h5 .btn .headerlink, .btn .rst-content h6 .headerlink, .rst-content h6 .btn .headerlink, .btn .rst-content dl dt .headerlink, .rst-content dl dt .btn .headerlink, .btn .rst-content p.caption .headerlink, .rst-content p.caption .btn .headerlink, .btn .rst-content tt.download span:first-child, .rst-content tt.download .btn span:first-child, .btn .rst-content code.download span:first-child, .rst-content code.download .btn span:first-child, .btn .icon, .nav .fa, .nav .wy-menu-vertical li span.toctree-expand, .wy-menu-vertical li .nav span.toctree-expand, .nav .wy-menu-vertical li.on a span.toctree-expand, .wy-menu-vertical li.on a .nav span.toctree-expand, .nav .wy-menu-vertical li.current > a span.toctree-expand, .wy-menu-vertical li.current > a .nav span.toctree-expand, .nav .rst-content .admonition-title, .rst-content .nav .admonition-title, .nav .rst-content h1 .headerlink, .rst-content h1 .nav .headerlink, .nav .rst-content h2 .headerlink, .rst-content h2 .nav .headerlink, .nav .rst-content h3 .headerlink, .rst-content h3 .nav .headerlink, .nav .rst-content h4 .headerlink, .rst-content h4 .nav .headerlink, .nav .rst-content h5 .headerlink, .rst-content h5 .nav .headerlink, .nav .rst-content h6 .headerlink, .rst-content h6 .nav .headerlink, .nav .rst-content dl dt .headerlink, .rst-content dl dt .nav .headerlink, .nav .rst-content p.caption .headerlink, .rst-content p.caption .nav .headerlink, .nav .rst-content tt.download span:first-child, .rst-content tt.download .nav span:first-child, .nav .rst-content code.download span:first-child, .rst-content code.download .nav span:first-child, .nav .icon { + display: inline; +} +.btn .fa.fa-large, .btn .wy-menu-vertical li span.fa-large.toctree-expand, .wy-menu-vertical li .btn span.fa-large.toctree-expand, .btn .rst-content .fa-large.admonition-title, .rst-content .btn .fa-large.admonition-title, .btn .rst-content h1 .fa-large.headerlink, .rst-content h1 .btn .fa-large.headerlink, .btn .rst-content h2 .fa-large.headerlink, .rst-content h2 .btn .fa-large.headerlink, .btn .rst-content h3 .fa-large.headerlink, .rst-content h3 .btn .fa-large.headerlink, .btn .rst-content h4 .fa-large.headerlink, .rst-content h4 .btn .fa-large.headerlink, .btn .rst-content h5 .fa-large.headerlink, .rst-content h5 .btn .fa-large.headerlink, .btn .rst-content h6 .fa-large.headerlink, .rst-content h6 .btn .fa-large.headerlink, .btn .rst-content dl dt .fa-large.headerlink, .rst-content dl dt .btn .fa-large.headerlink, .btn .rst-content p.caption .fa-large.headerlink, .rst-content p.caption .btn .fa-large.headerlink, .btn .rst-content tt.download span.fa-large:first-child, .rst-content tt.download .btn span.fa-large:first-child, .btn .rst-content code.download span.fa-large:first-child, .rst-content code.download .btn span.fa-large:first-child, .btn .fa-large.icon, .nav .fa.fa-large, .nav .wy-menu-vertical li span.fa-large.toctree-expand, .wy-menu-vertical li .nav span.fa-large.toctree-expand, .nav .rst-content .fa-large.admonition-title, .rst-content .nav .fa-large.admonition-title, .nav .rst-content h1 .fa-large.headerlink, .rst-content h1 .nav .fa-large.headerlink, .nav .rst-content h2 .fa-large.headerlink, .rst-content h2 .nav .fa-large.headerlink, .nav .rst-content h3 .fa-large.headerlink, .rst-content h3 .nav .fa-large.headerlink, .nav .rst-content h4 .fa-large.headerlink, .rst-content h4 .nav .fa-large.headerlink, .nav .rst-content h5 .fa-large.headerlink, .rst-content h5 .nav .fa-large.headerlink, .nav .rst-content h6 .fa-large.headerlink, .rst-content h6 .nav .fa-large.headerlink, .nav .rst-content dl dt .fa-large.headerlink, .rst-content dl dt .nav .fa-large.headerlink, .nav .rst-content p.caption .fa-large.headerlink, .rst-content p.caption .nav .fa-large.headerlink, .nav .rst-content tt.download span.fa-large:first-child, .rst-content tt.download .nav span.fa-large:first-child, .nav .rst-content code.download span.fa-large:first-child, .rst-content code.download .nav span.fa-large:first-child, .nav .fa-large.icon { + line-height: 0.9em; +} +.btn .fa.fa-spin, .btn .wy-menu-vertical li span.fa-spin.toctree-expand, .wy-menu-vertical li .btn span.fa-spin.toctree-expand, .btn .rst-content .fa-spin.admonition-title, .rst-content .btn .fa-spin.admonition-title, .btn .rst-content h1 .fa-spin.headerlink, .rst-content h1 .btn .fa-spin.headerlink, .btn .rst-content h2 .fa-spin.headerlink, .rst-content h2 .btn .fa-spin.headerlink, .btn .rst-content h3 .fa-spin.headerlink, .rst-content h3 .btn .fa-spin.headerlink, .btn .rst-content h4 .fa-spin.headerlink, .rst-content h4 .btn .fa-spin.headerlink, .btn .rst-content h5 .fa-spin.headerlink, .rst-content h5 .btn .fa-spin.headerlink, .btn .rst-content h6 .fa-spin.headerlink, .rst-content h6 .btn .fa-spin.headerlink, .btn .rst-content dl dt .fa-spin.headerlink, .rst-content dl dt .btn .fa-spin.headerlink, .btn .rst-content p.caption .fa-spin.headerlink, .rst-content p.caption .btn .fa-spin.headerlink, .btn .rst-content tt.download span.fa-spin:first-child, .rst-content tt.download .btn span.fa-spin:first-child, .btn .rst-content code.download span.fa-spin:first-child, .rst-content code.download .btn span.fa-spin:first-child, .btn .fa-spin.icon, .nav .fa.fa-spin, .nav .wy-menu-vertical li span.fa-spin.toctree-expand, .wy-menu-vertical li .nav span.fa-spin.toctree-expand, .nav .rst-content .fa-spin.admonition-title, .rst-content .nav .fa-spin.admonition-title, .nav .rst-content h1 .fa-spin.headerlink, .rst-content h1 .nav .fa-spin.headerlink, .nav .rst-content h2 .fa-spin.headerlink, .rst-content h2 .nav .fa-spin.headerlink, .nav .rst-content h3 .fa-spin.headerlink, .rst-content h3 .nav .fa-spin.headerlink, .nav .rst-content h4 .fa-spin.headerlink, .rst-content h4 .nav .fa-spin.headerlink, .nav .rst-content h5 .fa-spin.headerlink, .rst-content h5 .nav .fa-spin.headerlink, .nav .rst-content h6 .fa-spin.headerlink, .rst-content h6 .nav .fa-spin.headerlink, .nav .rst-content dl dt .fa-spin.headerlink, .rst-content dl dt .nav .fa-spin.headerlink, .nav .rst-content p.caption .fa-spin.headerlink, .rst-content p.caption .nav .fa-spin.headerlink, .nav .rst-content tt.download span.fa-spin:first-child, .rst-content tt.download .nav span.fa-spin:first-child, .nav .rst-content code.download span.fa-spin:first-child, .rst-content code.download .nav span.fa-spin:first-child, .nav .fa-spin.icon { + display: inline-block; +} + +.btn.fa:before, .wy-menu-vertical li span.btn.toctree-expand:before, .rst-content .btn.admonition-title:before, .rst-content h1 .btn.headerlink:before, .rst-content h2 .btn.headerlink:before, .rst-content h3 .btn.headerlink:before, .rst-content h4 .btn.headerlink:before, .rst-content h5 .btn.headerlink:before, .rst-content h6 .btn.headerlink:before, .rst-content dl dt .btn.headerlink:before, .rst-content p.caption .btn.headerlink:before, .rst-content tt.download span.btn:first-child:before, .rst-content code.download span.btn:first-child:before, .btn.icon:before { + opacity: 0.5; + -webkit-transition: opacity 0.05s ease-in; + -moz-transition: opacity 0.05s ease-in; + transition: opacity 0.05s ease-in; +} + +.btn.fa:hover:before, .wy-menu-vertical li span.btn.toctree-expand:hover:before, .rst-content .btn.admonition-title:hover:before, .rst-content h1 .btn.headerlink:hover:before, .rst-content h2 .btn.headerlink:hover:before, .rst-content h3 .btn.headerlink:hover:before, .rst-content h4 .btn.headerlink:hover:before, .rst-content h5 .btn.headerlink:hover:before, .rst-content h6 .btn.headerlink:hover:before, .rst-content dl dt .btn.headerlink:hover:before, .rst-content p.caption .btn.headerlink:hover:before, .rst-content tt.download span.btn:first-child:hover:before, .rst-content code.download span.btn:first-child:hover:before, .btn.icon:hover:before { + opacity: 1; +} + +.btn-mini .fa:before, .btn-mini .wy-menu-vertical li span.toctree-expand:before, .wy-menu-vertical li .btn-mini span.toctree-expand:before, .btn-mini .rst-content .admonition-title:before, .rst-content .btn-mini .admonition-title:before, .btn-mini .rst-content h1 .headerlink:before, .rst-content h1 .btn-mini .headerlink:before, .btn-mini .rst-content h2 .headerlink:before, .rst-content h2 .btn-mini .headerlink:before, .btn-mini .rst-content h3 .headerlink:before, .rst-content h3 .btn-mini .headerlink:before, .btn-mini .rst-content h4 .headerlink:before, .rst-content h4 .btn-mini .headerlink:before, .btn-mini .rst-content h5 .headerlink:before, .rst-content h5 .btn-mini .headerlink:before, .btn-mini .rst-content h6 .headerlink:before, .rst-content h6 .btn-mini .headerlink:before, .btn-mini .rst-content dl dt .headerlink:before, .rst-content dl dt .btn-mini .headerlink:before, .btn-mini .rst-content p.caption .headerlink:before, .rst-content p.caption .btn-mini .headerlink:before, .btn-mini .rst-content tt.download span:first-child:before, .rst-content tt.download .btn-mini span:first-child:before, .btn-mini .rst-content code.download span:first-child:before, .rst-content code.download .btn-mini span:first-child:before, .btn-mini .icon:before { + font-size: 14px; + vertical-align: -15%; +} + +.wy-alert, .rst-content .note, .rst-content .attention, .rst-content .caution, .rst-content .danger, .rst-content .error, .rst-content .hint, .rst-content .important, .rst-content .tip, .rst-content .warning, .rst-content .seealso, .rst-content .admonition-todo { + padding: 12px; + line-height: 24px; + margin-bottom: 24px; + background: #e7f2fa; +} + +.wy-alert-title, .rst-content .admonition-title { + color: #fff; + font-weight: bold; + display: block; + color: #fff; + background: #6ab0de; + margin: -12px; + padding: 6px 12px; + margin-bottom: 12px; +} + +.wy-alert.wy-alert-danger, .rst-content .wy-alert-danger.note, .rst-content .wy-alert-danger.attention, .rst-content .wy-alert-danger.caution, .rst-content .danger, .rst-content .error, .rst-content .wy-alert-danger.hint, .rst-content .wy-alert-danger.important, .rst-content .wy-alert-danger.tip, .rst-content .wy-alert-danger.warning, .rst-content .wy-alert-danger.seealso, .rst-content .wy-alert-danger.admonition-todo { + background: #fdf3f2; +} +.wy-alert.wy-alert-danger .wy-alert-title, .rst-content .wy-alert-danger.note .wy-alert-title, .rst-content .wy-alert-danger.attention .wy-alert-title, .rst-content .wy-alert-danger.caution .wy-alert-title, .rst-content .danger .wy-alert-title, .rst-content .error .wy-alert-title, .rst-content .wy-alert-danger.hint .wy-alert-title, .rst-content .wy-alert-danger.important .wy-alert-title, .rst-content .wy-alert-danger.tip .wy-alert-title, .rst-content .wy-alert-danger.warning .wy-alert-title, .rst-content .wy-alert-danger.seealso .wy-alert-title, .rst-content .wy-alert-danger.admonition-todo .wy-alert-title, .wy-alert.wy-alert-danger .rst-content .admonition-title, .rst-content .wy-alert.wy-alert-danger .admonition-title, .rst-content .wy-alert-danger.note .admonition-title, .rst-content .wy-alert-danger.attention .admonition-title, .rst-content .wy-alert-danger.caution .admonition-title, .rst-content .danger .admonition-title, .rst-content .error .admonition-title, .rst-content .wy-alert-danger.hint .admonition-title, .rst-content .wy-alert-danger.important .admonition-title, .rst-content .wy-alert-danger.tip .admonition-title, .rst-content .wy-alert-danger.warning .admonition-title, .rst-content .wy-alert-danger.seealso .admonition-title, .rst-content .wy-alert-danger.admonition-todo .admonition-title { + background: #f29f97; +} + +.wy-alert.wy-alert-warning, .rst-content .wy-alert-warning.note, .rst-content .attention, .rst-content .caution, .rst-content .wy-alert-warning.danger, .rst-content .wy-alert-warning.error, .rst-content .wy-alert-warning.hint, .rst-content .wy-alert-warning.important, .rst-content .wy-alert-warning.tip, .rst-content .warning, .rst-content .wy-alert-warning.seealso, .rst-content .admonition-todo { + background: #ffedcc; +} +.wy-alert.wy-alert-warning .wy-alert-title, .rst-content .wy-alert-warning.note .wy-alert-title, .rst-content .attention .wy-alert-title, .rst-content .caution .wy-alert-title, .rst-content .wy-alert-warning.danger .wy-alert-title, .rst-content .wy-alert-warning.error .wy-alert-title, .rst-content .wy-alert-warning.hint .wy-alert-title, .rst-content .wy-alert-warning.important .wy-alert-title, .rst-content .wy-alert-warning.tip .wy-alert-title, .rst-content .warning .wy-alert-title, .rst-content .wy-alert-warning.seealso .wy-alert-title, .rst-content .admonition-todo .wy-alert-title, .wy-alert.wy-alert-warning .rst-content .admonition-title, .rst-content .wy-alert.wy-alert-warning .admonition-title, .rst-content .wy-alert-warning.note .admonition-title, .rst-content .attention .admonition-title, .rst-content .caution .admonition-title, .rst-content .wy-alert-warning.danger .admonition-title, .rst-content .wy-alert-warning.error .admonition-title, .rst-content .wy-alert-warning.hint .admonition-title, .rst-content .wy-alert-warning.important .admonition-title, .rst-content .wy-alert-warning.tip .admonition-title, .rst-content .warning .admonition-title, .rst-content .wy-alert-warning.seealso .admonition-title, .rst-content .admonition-todo .admonition-title { + background: #f0b37e; +} + +.wy-alert.wy-alert-info, .rst-content .note, .rst-content .wy-alert-info.attention, .rst-content .wy-alert-info.caution, .rst-content .wy-alert-info.danger, .rst-content .wy-alert-info.error, .rst-content .wy-alert-info.hint, .rst-content .wy-alert-info.important, .rst-content .wy-alert-info.tip, .rst-content .wy-alert-info.warning, .rst-content .seealso, .rst-content .wy-alert-info.admonition-todo { + background: #e7f2fa; +} +.wy-alert.wy-alert-info .wy-alert-title, .rst-content .note .wy-alert-title, .rst-content .wy-alert-info.attention .wy-alert-title, .rst-content .wy-alert-info.caution .wy-alert-title, .rst-content .wy-alert-info.danger .wy-alert-title, .rst-content .wy-alert-info.error .wy-alert-title, .rst-content .wy-alert-info.hint .wy-alert-title, .rst-content .wy-alert-info.important .wy-alert-title, .rst-content .wy-alert-info.tip .wy-alert-title, .rst-content .wy-alert-info.warning .wy-alert-title, .rst-content .seealso .wy-alert-title, .rst-content .wy-alert-info.admonition-todo .wy-alert-title, .wy-alert.wy-alert-info .rst-content .admonition-title, .rst-content .wy-alert.wy-alert-info .admonition-title, .rst-content .note .admonition-title, .rst-content .wy-alert-info.attention .admonition-title, .rst-content .wy-alert-info.caution .admonition-title, .rst-content .wy-alert-info.danger .admonition-title, .rst-content .wy-alert-info.error .admonition-title, .rst-content .wy-alert-info.hint .admonition-title, .rst-content .wy-alert-info.important .admonition-title, .rst-content .wy-alert-info.tip .admonition-title, .rst-content .wy-alert-info.warning .admonition-title, .rst-content .seealso .admonition-title, .rst-content .wy-alert-info.admonition-todo .admonition-title { + background: #6ab0de; +} + +.wy-alert.wy-alert-success, .rst-content .wy-alert-success.note, .rst-content .wy-alert-success.attention, .rst-content .wy-alert-success.caution, .rst-content .wy-alert-success.danger, .rst-content .wy-alert-success.error, .rst-content .hint, .rst-content .important, .rst-content .tip, .rst-content .wy-alert-success.warning, .rst-content .wy-alert-success.seealso, .rst-content .wy-alert-success.admonition-todo { + background: #dbfaf4; +} +.wy-alert.wy-alert-success .wy-alert-title, .rst-content .wy-alert-success.note .wy-alert-title, .rst-content .wy-alert-success.attention .wy-alert-title, .rst-content .wy-alert-success.caution .wy-alert-title, .rst-content .wy-alert-success.danger .wy-alert-title, .rst-content .wy-alert-success.error .wy-alert-title, .rst-content .hint .wy-alert-title, .rst-content .important .wy-alert-title, .rst-content .tip .wy-alert-title, .rst-content .wy-alert-success.warning .wy-alert-title, .rst-content .wy-alert-success.seealso .wy-alert-title, .rst-content .wy-alert-success.admonition-todo .wy-alert-title, .wy-alert.wy-alert-success .rst-content .admonition-title, .rst-content .wy-alert.wy-alert-success .admonition-title, .rst-content .wy-alert-success.note .admonition-title, .rst-content .wy-alert-success.attention .admonition-title, .rst-content .wy-alert-success.caution .admonition-title, .rst-content .wy-alert-success.danger .admonition-title, .rst-content .wy-alert-success.error .admonition-title, .rst-content .hint .admonition-title, .rst-content .important .admonition-title, .rst-content .tip .admonition-title, .rst-content .wy-alert-success.warning .admonition-title, .rst-content .wy-alert-success.seealso .admonition-title, .rst-content .wy-alert-success.admonition-todo .admonition-title { + background: #1abc9c; +} + +.wy-alert.wy-alert-neutral, .rst-content .wy-alert-neutral.note, .rst-content .wy-alert-neutral.attention, .rst-content .wy-alert-neutral.caution, .rst-content .wy-alert-neutral.danger, .rst-content .wy-alert-neutral.error, .rst-content .wy-alert-neutral.hint, .rst-content .wy-alert-neutral.important, .rst-content .wy-alert-neutral.tip, .rst-content .wy-alert-neutral.warning, .rst-content .wy-alert-neutral.seealso, .rst-content .wy-alert-neutral.admonition-todo { + background: #f3f6f6; +} +.wy-alert.wy-alert-neutral .wy-alert-title, .rst-content .wy-alert-neutral.note .wy-alert-title, .rst-content .wy-alert-neutral.attention .wy-alert-title, .rst-content .wy-alert-neutral.caution .wy-alert-title, .rst-content .wy-alert-neutral.danger .wy-alert-title, .rst-content .wy-alert-neutral.error .wy-alert-title, .rst-content .wy-alert-neutral.hint .wy-alert-title, .rst-content .wy-alert-neutral.important .wy-alert-title, .rst-content .wy-alert-neutral.tip .wy-alert-title, .rst-content .wy-alert-neutral.warning .wy-alert-title, .rst-content .wy-alert-neutral.seealso .wy-alert-title, .rst-content .wy-alert-neutral.admonition-todo .wy-alert-title, .wy-alert.wy-alert-neutral .rst-content .admonition-title, .rst-content .wy-alert.wy-alert-neutral .admonition-title, .rst-content .wy-alert-neutral.note .admonition-title, .rst-content .wy-alert-neutral.attention .admonition-title, .rst-content .wy-alert-neutral.caution .admonition-title, .rst-content .wy-alert-neutral.danger .admonition-title, .rst-content .wy-alert-neutral.error .admonition-title, .rst-content .wy-alert-neutral.hint .admonition-title, .rst-content .wy-alert-neutral.important .admonition-title, .rst-content .wy-alert-neutral.tip .admonition-title, .rst-content .wy-alert-neutral.warning .admonition-title, .rst-content .wy-alert-neutral.seealso .admonition-title, .rst-content .wy-alert-neutral.admonition-todo .admonition-title { + color: #404040; + background: #e1e4e5; +} +.wy-alert.wy-alert-neutral a, .rst-content .wy-alert-neutral.note a, .rst-content .wy-alert-neutral.attention a, .rst-content .wy-alert-neutral.caution a, .rst-content .wy-alert-neutral.danger a, .rst-content .wy-alert-neutral.error a, .rst-content .wy-alert-neutral.hint a, .rst-content .wy-alert-neutral.important a, .rst-content .wy-alert-neutral.tip a, .rst-content .wy-alert-neutral.warning a, .rst-content .wy-alert-neutral.seealso a, .rst-content .wy-alert-neutral.admonition-todo a { + color: #2980B9; +} + +.wy-alert p:last-child, .rst-content .note p:last-child, .rst-content .attention p:last-child, .rst-content .caution p:last-child, .rst-content .danger p:last-child, .rst-content .error p:last-child, .rst-content .hint p:last-child, .rst-content .important p:last-child, .rst-content .tip p:last-child, .rst-content .warning p:last-child, .rst-content .seealso p:last-child, .rst-content .admonition-todo p:last-child { + margin-bottom: 0; +} + +.wy-tray-container { + position: fixed; + bottom: 0px; + left: 0; + z-index: 600; +} +.wy-tray-container li { + display: block; + width: 300px; + background: transparent; + color: #fff; + text-align: center; + box-shadow: 0 5px 5px 0 rgba(0, 0, 0, 0.1); + padding: 0 24px; + min-width: 20%; + opacity: 0; + height: 0; + line-height: 56px; + overflow: hidden; + -webkit-transition: all 0.3s ease-in; + -moz-transition: all 0.3s ease-in; + transition: all 0.3s ease-in; +} +.wy-tray-container li.wy-tray-item-success { + background: #27AE60; +} +.wy-tray-container li.wy-tray-item-info { + background: #2980B9; +} +.wy-tray-container li.wy-tray-item-warning { + background: #E67E22; +} +.wy-tray-container li.wy-tray-item-danger { + background: #E74C3C; +} +.wy-tray-container li.on { + opacity: 1; + height: 56px; +} + +@media screen and (max-width: 768px) { + .wy-tray-container { + bottom: auto; + top: 0; + width: 100%; + } + .wy-tray-container li { + width: 100%; + } +} +button { + font-size: 100%; + margin: 0; + vertical-align: baseline; + *vertical-align: middle; + cursor: pointer; + line-height: normal; + -webkit-appearance: button; + *overflow: visible; +} + +button::-moz-focus-inner, input::-moz-focus-inner { + border: 0; + padding: 0; +} + +button[disabled] { + cursor: default; +} + +.btn { + /* Structure */ + display: inline-block; + border-radius: 2px; + line-height: normal; + white-space: nowrap; + text-align: center; + cursor: pointer; + font-size: 100%; + padding: 6px 12px 8px 12px; + color: #fff; + border: 1px solid rgba(0, 0, 0, 0.1); + background-color: #27AE60; + text-decoration: none; + font-weight: normal; + font-family: "Lato", "proxima-nova", "Helvetica Neue", Arial, sans-serif; + box-shadow: 0px 1px 2px -1px rgba(255, 255, 255, 0.5) inset, 0px -2px 0px 0px rgba(0, 0, 0, 0.1) inset; + outline-none: false; + vertical-align: middle; + *display: inline; + zoom: 1; + -webkit-user-drag: none; + -webkit-user-select: none; + -moz-user-select: none; + -ms-user-select: none; + user-select: none; + -webkit-transition: all 0.1s linear; + -moz-transition: all 0.1s linear; + transition: all 0.1s linear; +} + +.btn-hover { + background: #2e8ece; + color: #fff; +} + +.btn:hover { + background: #2cc36b; + color: #fff; +} +.btn:focus { + background: #2cc36b; + outline: 0; +} +.btn:active { + box-shadow: 0px -1px 0px 0px rgba(0, 0, 0, 0.05) inset, 0px 2px 0px 0px rgba(0, 0, 0, 0.1) inset; + padding: 8px 12px 6px 12px; +} +.btn:visited { + color: #fff; +} +.btn:disabled { + background-image: none; + filter: progid:DXImageTransform.Microsoft.gradient(enabled = false); + filter: alpha(opacity=40); + opacity: 0.4; + cursor: not-allowed; + box-shadow: none; +} + +.btn-disabled { + background-image: none; + filter: progid:DXImageTransform.Microsoft.gradient(enabled = false); + filter: alpha(opacity=40); + opacity: 0.4; + cursor: not-allowed; + box-shadow: none; +} +.btn-disabled:hover, .btn-disabled:focus, .btn-disabled:active { + background-image: none; + filter: progid:DXImageTransform.Microsoft.gradient(enabled = false); + filter: alpha(opacity=40); + opacity: 0.4; + cursor: not-allowed; + box-shadow: none; +} + +.btn::-moz-focus-inner { + padding: 0; + border: 0; +} + +.btn-small { + font-size: 80%; +} + +.btn-info { + background-color: #2980B9 !important; +} +.btn-info:hover { + background-color: #2e8ece !important; +} + +.btn-neutral { + background-color: #f3f6f6 !important; + color: #404040 !important; +} +.btn-neutral:hover { + background-color: #e5ebeb !important; + color: #404040; +} +.btn-neutral:visited { + color: #404040 !important; +} + +.btn-success { + background-color: #27AE60 !important; +} +.btn-success:hover { + background-color: #229955 !important; +} + +.btn-danger { + background-color: #E74C3C !important; +} +.btn-danger:hover { + background-color: #ea6153 !important; +} + +.btn-warning { + background-color: #E67E22 !important; +} +.btn-warning:hover { + background-color: #e98b39 !important; +} + +.btn-invert { + background-color: #222; +} +.btn-invert:hover { + background-color: #2f2f2f !important; +} + +.btn-link { + background-color: transparent !important; + color: #2980B9; + box-shadow: none; + border-color: transparent !important; +} +.btn-link:hover { + background-color: transparent !important; + color: #409ad5 !important; + box-shadow: none; +} +.btn-link:active { + background-color: transparent !important; + color: #409ad5 !important; + box-shadow: none; +} +.btn-link:visited { + color: #9B59B6; +} + +.wy-btn-group .btn, .wy-control .btn { + vertical-align: middle; +} + +.wy-btn-group { + margin-bottom: 24px; + *zoom: 1; +} +.wy-btn-group:before, .wy-btn-group:after { + display: table; + content: ""; +} +.wy-btn-group:after { + clear: both; +} + +.wy-dropdown { + position: relative; + display: inline-block; +} + +.wy-dropdown-active .wy-dropdown-menu { + display: block; +} + +.wy-dropdown-menu { + position: absolute; + left: 0; + display: none; + float: left; + top: 100%; + min-width: 100%; + background: #fcfcfc; + z-index: 100; + border: solid 1px #cfd7dd; + box-shadow: 0 2px 2px 0 rgba(0, 0, 0, 0.1); + padding: 12px; +} +.wy-dropdown-menu > dd > a { + display: block; + clear: both; + color: #404040; + white-space: nowrap; + font-size: 90%; + padding: 0 12px; + cursor: pointer; +} +.wy-dropdown-menu > dd > a:hover { + background: #2980B9; + color: #fff; +} +.wy-dropdown-menu > dd.divider { + border-top: solid 1px #cfd7dd; + margin: 6px 0; +} +.wy-dropdown-menu > dd.search { + padding-bottom: 12px; +} +.wy-dropdown-menu > dd.search input[type="search"] { + width: 100%; +} +.wy-dropdown-menu > dd.call-to-action { + background: #e3e3e3; + text-transform: uppercase; + font-weight: 500; + font-size: 80%; +} +.wy-dropdown-menu > dd.call-to-action:hover { + background: #e3e3e3; +} +.wy-dropdown-menu > dd.call-to-action .btn { + color: #fff; +} + +.wy-dropdown.wy-dropdown-up .wy-dropdown-menu { + bottom: 100%; + top: auto; + left: auto; + right: 0; +} + +.wy-dropdown.wy-dropdown-bubble .wy-dropdown-menu { + background: #fcfcfc; + margin-top: 2px; +} +.wy-dropdown.wy-dropdown-bubble .wy-dropdown-menu a { + padding: 6px 12px; +} +.wy-dropdown.wy-dropdown-bubble .wy-dropdown-menu a:hover { + background: #2980B9; + color: #fff; +} + +.wy-dropdown.wy-dropdown-left .wy-dropdown-menu { + right: 0; + left: auto; + text-align: right; +} + +.wy-dropdown-arrow:before { + content: " "; + border-bottom: 5px solid whitesmoke; + border-left: 5px solid transparent; + border-right: 5px solid transparent; + position: absolute; + display: block; + top: -4px; + left: 50%; + margin-left: -3px; +} +.wy-dropdown-arrow.wy-dropdown-arrow-left:before { + left: 11px; +} + +.wy-form-stacked select { + display: block; +} + +.wy-form-aligned input, .wy-form-aligned textarea, .wy-form-aligned select, .wy-form-aligned .wy-help-inline, .wy-form-aligned label { + display: inline-block; + *display: inline; + *zoom: 1; + vertical-align: middle; +} + +.wy-form-aligned .wy-control-group > label { + display: inline-block; + vertical-align: middle; + width: 10em; + margin: 6px 12px 0 0; + float: left; +} +.wy-form-aligned .wy-control { + float: left; +} +.wy-form-aligned .wy-control label { + display: block; +} +.wy-form-aligned .wy-control select { + margin-top: 6px; +} + +fieldset { + border: 0; + margin: 0; + padding: 0; +} + +legend { + display: block; + width: 100%; + border: 0; + padding: 0; + white-space: normal; + margin-bottom: 24px; + font-size: 150%; + *margin-left: -7px; +} + +label { + display: block; + margin: 0 0 0.3125em 0; + color: #333; + font-size: 90%; +} + +input, select, textarea { + font-size: 100%; + margin: 0; + vertical-align: baseline; + *vertical-align: middle; +} + +.wy-control-group { + margin-bottom: 24px; + *zoom: 1; + max-width: 68em; + margin-left: auto; + margin-right: auto; + *zoom: 1; +} +.wy-control-group:before, .wy-control-group:after { + display: table; + content: ""; +} +.wy-control-group:after { + clear: both; +} +.wy-control-group:before, .wy-control-group:after { + display: table; + content: ""; +} +.wy-control-group:after { + clear: both; +} + +.wy-control-group.wy-control-group-required > label:after { + content: " *"; + color: #E74C3C; +} + +.wy-control-group .wy-form-full, .wy-control-group .wy-form-halves, .wy-control-group .wy-form-thirds { + padding-bottom: 12px; +} +.wy-control-group .wy-form-full select, .wy-control-group .wy-form-halves select, .wy-control-group .wy-form-thirds select { + width: 100%; +} +.wy-control-group .wy-form-full input[type="text"], .wy-control-group .wy-form-full input[type="password"], .wy-control-group .wy-form-full input[type="email"], .wy-control-group .wy-form-full input[type="url"], .wy-control-group .wy-form-full input[type="date"], .wy-control-group .wy-form-full input[type="month"], .wy-control-group .wy-form-full input[type="time"], .wy-control-group .wy-form-full input[type="datetime"], .wy-control-group .wy-form-full input[type="datetime-local"], .wy-control-group .wy-form-full input[type="week"], .wy-control-group .wy-form-full input[type="number"], .wy-control-group .wy-form-full input[type="search"], .wy-control-group .wy-form-full input[type="tel"], .wy-control-group .wy-form-full input[type="color"], .wy-control-group .wy-form-halves input[type="text"], .wy-control-group .wy-form-halves input[type="password"], .wy-control-group .wy-form-halves input[type="email"], .wy-control-group .wy-form-halves input[type="url"], .wy-control-group .wy-form-halves input[type="date"], .wy-control-group .wy-form-halves input[type="month"], .wy-control-group .wy-form-halves input[type="time"], .wy-control-group .wy-form-halves input[type="datetime"], .wy-control-group .wy-form-halves input[type="datetime-local"], .wy-control-group .wy-form-halves input[type="week"], .wy-control-group .wy-form-halves input[type="number"], .wy-control-group .wy-form-halves input[type="search"], .wy-control-group .wy-form-halves input[type="tel"], .wy-control-group .wy-form-halves input[type="color"], .wy-control-group .wy-form-thirds input[type="text"], .wy-control-group .wy-form-thirds input[type="password"], .wy-control-group .wy-form-thirds input[type="email"], .wy-control-group .wy-form-thirds input[type="url"], .wy-control-group .wy-form-thirds input[type="date"], .wy-control-group .wy-form-thirds input[type="month"], .wy-control-group .wy-form-thirds input[type="time"], .wy-control-group .wy-form-thirds input[type="datetime"], .wy-control-group .wy-form-thirds input[type="datetime-local"], .wy-control-group .wy-form-thirds input[type="week"], .wy-control-group .wy-form-thirds input[type="number"], .wy-control-group .wy-form-thirds input[type="search"], .wy-control-group .wy-form-thirds input[type="tel"], .wy-control-group .wy-form-thirds input[type="color"] { + width: 100%; +} + +.wy-control-group .wy-form-full { + float: left; + display: block; + margin-right: 2.35765%; + width: 100%; + margin-right: 0; +} +.wy-control-group .wy-form-full:last-child { + margin-right: 0; +} + +.wy-control-group .wy-form-halves { + float: left; + display: block; + margin-right: 2.35765%; + width: 48.82117%; +} +.wy-control-group .wy-form-halves:last-child { + margin-right: 0; +} +.wy-control-group .wy-form-halves:nth-of-type(2n) { + margin-right: 0; +} +.wy-control-group .wy-form-halves:nth-of-type(2n+1) { + clear: left; +} + +.wy-control-group .wy-form-thirds { + float: left; + display: block; + margin-right: 2.35765%; + width: 31.76157%; +} +.wy-control-group .wy-form-thirds:last-child { + margin-right: 0; +} +.wy-control-group .wy-form-thirds:nth-of-type(3n) { + margin-right: 0; +} +.wy-control-group .wy-form-thirds:nth-of-type(3n+1) { + clear: left; +} + +.wy-control-group.wy-control-group-no-input .wy-control { + margin: 6px 0 0 0; + font-size: 90%; +} + +.wy-control-no-input { + display: inline-block; + margin: 6px 0 0 0; + font-size: 90%; +} + +.wy-control-group.fluid-input input[type="text"], .wy-control-group.fluid-input input[type="password"], .wy-control-group.fluid-input input[type="email"], .wy-control-group.fluid-input input[type="url"], .wy-control-group.fluid-input input[type="date"], .wy-control-group.fluid-input input[type="month"], .wy-control-group.fluid-input input[type="time"], .wy-control-group.fluid-input input[type="datetime"], .wy-control-group.fluid-input input[type="datetime-local"], .wy-control-group.fluid-input input[type="week"], .wy-control-group.fluid-input input[type="number"], .wy-control-group.fluid-input input[type="search"], .wy-control-group.fluid-input input[type="tel"], .wy-control-group.fluid-input input[type="color"] { + width: 100%; +} + +.wy-form-message-inline { + display: inline-block; + padding-left: 0.3em; + color: #666; + vertical-align: middle; + font-size: 90%; +} + +.wy-form-message { + display: block; + color: #999; + font-size: 70%; + margin-top: 0.3125em; + font-style: italic; +} +.wy-form-message p { + font-size: inherit; + font-style: italic; + margin-bottom: 6px; +} +.wy-form-message p:last-child { + margin-bottom: 0; +} + +input { + line-height: normal; +} + +input[type="button"], input[type="reset"], input[type="submit"] { + -webkit-appearance: button; + cursor: pointer; + font-family: "Lato", "proxima-nova", "Helvetica Neue", Arial, sans-serif; + *overflow: visible; +} +input[type="text"], input[type="password"], input[type="email"], input[type="url"], input[type="date"], input[type="month"], input[type="time"], input[type="datetime"], input[type="datetime-local"], input[type="week"], input[type="number"], input[type="search"], input[type="tel"], input[type="color"] { + -webkit-appearance: none; + padding: 6px; + display: inline-block; + border: 1px solid #ccc; + font-size: 80%; + font-family: "Lato", "proxima-nova", "Helvetica Neue", Arial, sans-serif; + box-shadow: inset 0 1px 3px #ddd; + border-radius: 0; + -webkit-transition: border 0.3s linear; + -moz-transition: border 0.3s linear; + transition: border 0.3s linear; +} +input[type="datetime-local"] { + padding: 0.34375em 0.625em; +} +input[disabled] { + cursor: default; +} +input[type="checkbox"], input[type="radio"] { + -webkit-box-sizing: border-box; + -moz-box-sizing: border-box; + box-sizing: border-box; + padding: 0; + margin-right: 0.3125em; + *height: 13px; + *width: 13px; +} +input[type="search"] { + -webkit-box-sizing: border-box; + -moz-box-sizing: border-box; + box-sizing: border-box; +} +input[type="search"]::-webkit-search-cancel-button, input[type="search"]::-webkit-search-decoration { + -webkit-appearance: none; +} +input[type="text"]:focus, input[type="password"]:focus, input[type="email"]:focus, input[type="url"]:focus, input[type="date"]:focus, input[type="month"]:focus, input[type="time"]:focus, input[type="datetime"]:focus, input[type="datetime-local"]:focus, input[type="week"]:focus, input[type="number"]:focus, input[type="search"]:focus, input[type="tel"]:focus, input[type="color"]:focus { + outline: 0; + outline: thin dotted \9; + border-color: #333; +} +input.no-focus:focus { + border-color: #ccc !important; +} +input[type="file"]:focus, input[type="radio"]:focus, input[type="checkbox"]:focus { + outline: thin dotted #333; + outline: 1px auto #129FEA; +} +input[type="text"][disabled], input[type="password"][disabled], input[type="email"][disabled], input[type="url"][disabled], input[type="date"][disabled], input[type="month"][disabled], input[type="time"][disabled], input[type="datetime"][disabled], input[type="datetime-local"][disabled], input[type="week"][disabled], input[type="number"][disabled], input[type="search"][disabled], input[type="tel"][disabled], input[type="color"][disabled] { + cursor: not-allowed; + background-color: #fafafa; +} + +input:focus:invalid, textarea:focus:invalid, select:focus:invalid { + color: #E74C3C; + border: 1px solid #E74C3C; +} + +input:focus:invalid:focus, textarea:focus:invalid:focus, select:focus:invalid:focus { + border-color: #E74C3C; +} + +input[type="file"]:focus:invalid:focus, input[type="radio"]:focus:invalid:focus, input[type="checkbox"]:focus:invalid:focus { + outline-color: #E74C3C; +} + +input.wy-input-large { + padding: 12px; + font-size: 100%; +} + +textarea { + overflow: auto; + vertical-align: top; + width: 100%; + font-family: "Lato", "proxima-nova", "Helvetica Neue", Arial, sans-serif; +} + +select, textarea { + padding: 0.5em 0.625em; + display: inline-block; + border: 1px solid #ccc; + font-size: 80%; + box-shadow: inset 0 1px 3px #ddd; + -webkit-transition: border 0.3s linear; + -moz-transition: border 0.3s linear; + transition: border 0.3s linear; +} + +select { + border: 1px solid #ccc; + background-color: #fff; +} +select[multiple] { + height: auto; +} + +select:focus, textarea:focus { + outline: 0; +} + +select[disabled], textarea[disabled], input[readonly], select[readonly], textarea[readonly] { + cursor: not-allowed; + background-color: #fafafa; +} + +input[type="radio"][disabled], input[type="checkbox"][disabled] { + cursor: not-allowed; +} + +.wy-checkbox, .wy-radio { + margin: 6px 0; + color: #404040; + display: block; +} +.wy-checkbox input, .wy-radio input { + vertical-align: baseline; +} + +.wy-form-message-inline { + display: inline-block; + *display: inline; + *zoom: 1; + vertical-align: middle; +} + +.wy-input-prefix, .wy-input-suffix { + white-space: nowrap; + padding: 6px; +} +.wy-input-prefix .wy-input-context, .wy-input-suffix .wy-input-context { + line-height: 27px; + padding: 0 8px; + display: inline-block; + font-size: 80%; + background-color: #f3f6f6; + border: solid 1px #ccc; + color: #999; +} + +.wy-input-suffix .wy-input-context { + border-left: 0; +} + +.wy-input-prefix .wy-input-context { + border-right: 0; +} + +.wy-switch { + width: 36px; + height: 12px; + margin: 12px 0; + position: relative; + border-radius: 4px; + background: #ccc; + cursor: pointer; + -webkit-transition: all 0.2s ease-in-out; + -moz-transition: all 0.2s ease-in-out; + transition: all 0.2s ease-in-out; +} +.wy-switch:before { + position: absolute; + content: ""; + display: block; + width: 18px; + height: 18px; + border-radius: 4px; + background: #999; + left: -3px; + top: -3px; + -webkit-transition: all 0.2s ease-in-out; + -moz-transition: all 0.2s ease-in-out; + transition: all 0.2s ease-in-out; +} +.wy-switch:after { + content: "false"; + position: absolute; + left: 48px; + display: block; + font-size: 12px; + color: #ccc; +} + +.wy-switch.active { + background: #1e8449; +} +.wy-switch.active:before { + left: 24px; + background: #27AE60; +} +.wy-switch.active:after { + content: "true"; +} + +.wy-switch.disabled, .wy-switch.active.disabled { + cursor: not-allowed; +} + +.wy-control-group.wy-control-group-error .wy-form-message, .wy-control-group.wy-control-group-error > label { + color: #E74C3C; +} +.wy-control-group.wy-control-group-error input[type="text"], .wy-control-group.wy-control-group-error input[type="password"], .wy-control-group.wy-control-group-error input[type="email"], .wy-control-group.wy-control-group-error input[type="url"], .wy-control-group.wy-control-group-error input[type="date"], .wy-control-group.wy-control-group-error input[type="month"], .wy-control-group.wy-control-group-error input[type="time"], .wy-control-group.wy-control-group-error input[type="datetime"], .wy-control-group.wy-control-group-error input[type="datetime-local"], .wy-control-group.wy-control-group-error input[type="week"], .wy-control-group.wy-control-group-error input[type="number"], .wy-control-group.wy-control-group-error input[type="search"], .wy-control-group.wy-control-group-error input[type="tel"], .wy-control-group.wy-control-group-error input[type="color"] { + border: solid 1px #E74C3C; +} +.wy-control-group.wy-control-group-error textarea { + border: solid 1px #E74C3C; +} + +.wy-inline-validate { + white-space: nowrap; +} +.wy-inline-validate .wy-input-context { + padding: 0.5em 0.625em; + display: inline-block; + font-size: 80%; +} + +.wy-inline-validate.wy-inline-validate-success .wy-input-context { + color: #27AE60; +} + +.wy-inline-validate.wy-inline-validate-danger .wy-input-context { + color: #E74C3C; +} + +.wy-inline-validate.wy-inline-validate-warning .wy-input-context { + color: #E67E22; +} + +.wy-inline-validate.wy-inline-validate-info .wy-input-context { + color: #2980B9; +} + +.rotate-90 { + -webkit-transform: rotate(90deg); + -moz-transform: rotate(90deg); + -ms-transform: rotate(90deg); + -o-transform: rotate(90deg); + transform: rotate(90deg); +} + +.rotate-180 { + -webkit-transform: rotate(180deg); + -moz-transform: rotate(180deg); + -ms-transform: rotate(180deg); + -o-transform: rotate(180deg); + transform: rotate(180deg); +} + +.rotate-270 { + -webkit-transform: rotate(270deg); + -moz-transform: rotate(270deg); + -ms-transform: rotate(270deg); + -o-transform: rotate(270deg); + transform: rotate(270deg); +} + +.mirror { + -webkit-transform: scaleX(-1); + -moz-transform: scaleX(-1); + -ms-transform: scaleX(-1); + -o-transform: scaleX(-1); + transform: scaleX(-1); +} +.mirror.rotate-90 { + -webkit-transform: scaleX(-1) rotate(90deg); + -moz-transform: scaleX(-1) rotate(90deg); + -ms-transform: scaleX(-1) rotate(90deg); + -o-transform: scaleX(-1) rotate(90deg); + transform: scaleX(-1) rotate(90deg); +} +.mirror.rotate-180 { + -webkit-transform: scaleX(-1) rotate(180deg); + -moz-transform: scaleX(-1) rotate(180deg); + -ms-transform: scaleX(-1) rotate(180deg); + -o-transform: scaleX(-1) rotate(180deg); + transform: scaleX(-1) rotate(180deg); +} +.mirror.rotate-270 { + -webkit-transform: scaleX(-1) rotate(270deg); + -moz-transform: scaleX(-1) rotate(270deg); + -ms-transform: scaleX(-1) rotate(270deg); + -o-transform: scaleX(-1) rotate(270deg); + transform: scaleX(-1) rotate(270deg); +} + +@media only screen and (max-width: 480px) { + .wy-form button[type="submit"] { + margin: 0.7em 0 0; + } + .wy-form input[type="text"], .wy-form input[type="password"], .wy-form input[type="email"], .wy-form input[type="url"], .wy-form input[type="date"], .wy-form input[type="month"], .wy-form input[type="time"], .wy-form input[type="datetime"], .wy-form input[type="datetime-local"], .wy-form input[type="week"], .wy-form input[type="number"], .wy-form input[type="search"], .wy-form input[type="tel"], .wy-form input[type="color"] { + margin-bottom: 0.3em; + display: block; + } + .wy-form label { + margin-bottom: 0.3em; + display: block; + } + + .wy-form input[type="password"], .wy-form input[type="email"], .wy-form input[type="url"], .wy-form input[type="date"], .wy-form input[type="month"], .wy-form input[type="time"], .wy-form input[type="datetime"], .wy-form input[type="datetime-local"], .wy-form input[type="week"], .wy-form input[type="number"], .wy-form input[type="search"], .wy-form input[type="tel"], .wy-form input[type="color"] { + margin-bottom: 0; + } + + .wy-form-aligned .wy-control-group label { + margin-bottom: 0.3em; + text-align: left; + display: block; + width: 100%; + } + .wy-form-aligned .wy-control { + margin: 1.5em 0 0 0; + } + + .wy-form .wy-help-inline, .wy-form-message-inline, .wy-form-message { + display: block; + font-size: 80%; + padding: 6px 0; + } +} +@media screen and (max-width: 768px) { + .tablet-hide { + display: none; + } +} + +@media screen and (max-width: 480px) { + .mobile-hide { + display: none; + } +} + +.float-left { + float: left; +} + +.float-right { + float: right; +} + +.full-width { + width: 100%; +} + +.wy-table, .rst-content table.docutils, .rst-content table.field-list { + border-collapse: collapse; + border-spacing: 0; + empty-cells: show; + margin-bottom: 24px; +} +.wy-table caption, .rst-content table.docutils caption, .rst-content table.field-list caption { + color: #000; + font: italic 85%/1 arial, sans-serif; + padding: 1em 0; + text-align: center; +} +.wy-table td, .rst-content table.docutils td, .rst-content table.field-list td, .wy-table th, .rst-content table.docutils th, .rst-content table.field-list th { + font-size: 90%; + margin: 0; + overflow: visible; + padding: 8px 16px; +} +.wy-table td:first-child, .rst-content table.docutils td:first-child, .rst-content table.field-list td:first-child, .wy-table th:first-child, .rst-content table.docutils th:first-child, .rst-content table.field-list th:first-child { + border-left-width: 0; +} +.wy-table thead, .rst-content table.docutils thead, .rst-content table.field-list thead { + color: #000; + text-align: left; + vertical-align: bottom; + white-space: nowrap; +} +.wy-table thead th, .rst-content table.docutils thead th, .rst-content table.field-list thead th { + font-weight: bold; + border-bottom: solid 2px #e1e4e5; +} +.wy-table td, .rst-content table.docutils td, .rst-content table.field-list td { + background-color: transparent; + vertical-align: middle; +} + +.wy-table td p, .rst-content table.docutils td p, .rst-content table.field-list td p { + line-height: 18px; +} +.wy-table td p:last-child, .rst-content table.docutils td p:last-child, .rst-content table.field-list td p:last-child { + margin-bottom: 0; +} + +.wy-table .wy-table-cell-min, .rst-content table.docutils .wy-table-cell-min, .rst-content table.field-list .wy-table-cell-min { + width: 1%; + padding-right: 0; +} +.wy-table .wy-table-cell-min input[type=checkbox], .rst-content table.docutils .wy-table-cell-min input[type=checkbox], .rst-content table.field-list .wy-table-cell-min input[type=checkbox], .wy-table .wy-table-cell-min input[type=checkbox], .rst-content table.docutils .wy-table-cell-min input[type=checkbox], .rst-content table.field-list .wy-table-cell-min input[type=checkbox] { + margin: 0; +} + +.wy-table-secondary { + color: gray; + font-size: 90%; +} + +.wy-table-tertiary { + color: gray; + font-size: 80%; +} + +.wy-table-odd td, .wy-table-striped tr:nth-child(2n-1) td, .rst-content table.docutils:not(.field-list) tr:nth-child(2n-1) td { + background-color: #f3f6f6; +} + +.wy-table-backed { + background-color: #f3f6f6; +} + +/* BORDERED TABLES */ +.wy-table-bordered-all, .rst-content table.docutils { + border: 1px solid #e1e4e5; +} +.wy-table-bordered-all td, .rst-content table.docutils td { + border-bottom: 1px solid #e1e4e5; + border-left: 1px solid #e1e4e5; +} +.wy-table-bordered-all tbody > tr:last-child td, .rst-content table.docutils tbody > tr:last-child td { + border-bottom-width: 0; +} + +.wy-table-bordered { + border: 1px solid #e1e4e5; +} + +.wy-table-bordered-rows td { + border-bottom: 1px solid #e1e4e5; +} +.wy-table-bordered-rows tbody > tr:last-child td { + border-bottom-width: 0; +} + +.wy-table-horizontal tbody > tr:last-child td { + border-bottom-width: 0; +} +.wy-table-horizontal td, .wy-table-horizontal th { + border-width: 0 0 1px 0; + border-bottom: 1px solid #e1e4e5; +} +.wy-table-horizontal tbody > tr:last-child td { + border-bottom-width: 0; +} + +/* RESPONSIVE TABLES */ +.wy-table-responsive { + margin-bottom: 24px; + max-width: 100%; + overflow: auto; +} +.wy-table-responsive table { + margin-bottom: 0 !important; +} +.wy-table-responsive table td, .wy-table-responsive table th { + white-space: nowrap; +} + +a { + color: #2980B9; + text-decoration: none; + cursor: pointer; +} +a:hover { + color: #3091d1; +} +a:visited { + color: #9B59B6; +} + +html { + height: 100%; + overflow-x: hidden; +} + +body { + font-family: "Lato", "proxima-nova", "Helvetica Neue", Arial, sans-serif; + font-weight: normal; + color: #404040; + min-height: 100%; + overflow-x: hidden; + background: #edf0f2; +} + +.wy-text-left { + text-align: left; +} + +.wy-text-center { + text-align: center; +} + +.wy-text-right { + text-align: right; +} + +.wy-text-large { + font-size: 120%; +} + +.wy-text-normal { + font-size: 100%; +} + +.wy-text-small, small { + font-size: 80%; +} + +.wy-text-strike { + text-decoration: line-through; +} + +.wy-text-warning { + color: #E67E22 !important; +} + +a.wy-text-warning:hover { + color: #eb9950 !important; +} + +.wy-text-info { + color: #2980B9 !important; +} + +a.wy-text-info:hover { + color: #409ad5 !important; +} + +.wy-text-success { + color: #27AE60 !important; +} + +a.wy-text-success:hover { + color: #36d278 !important; +} + +.wy-text-danger { + color: #E74C3C !important; +} + +a.wy-text-danger:hover { + color: #ed7669 !important; +} + +.wy-text-neutral { + color: #404040 !important; +} + +a.wy-text-neutral:hover { + color: #595959 !important; +} + +h1, h2, .rst-content .toctree-wrapper p.caption, h3, h4, h5, h6, legend { + margin-top: 0; + font-weight: 700; + font-family: "Roboto Slab", "ff-tisa-web-pro", "Georgia", Arial, sans-serif; +} + +p { + line-height: 24px; + margin: 0; + font-size: 16px; + margin-bottom: 24px; +} + +h1 { + font-size: 175%; +} + +h2, .rst-content .toctree-wrapper p.caption { + font-size: 150%; +} + +h3 { + font-size: 125%; +} + +h4 { + font-size: 115%; +} + +h5 { + font-size: 110%; +} + +h6 { + font-size: 100%; +} + +hr { + display: block; + height: 1px; + border: 0; + border-top: 1px solid #e1e4e5; + margin: 24px 0; + padding: 0; +} + +code, .rst-content tt, .rst-content code { + white-space: nowrap; + max-width: 100%; + background: #fff; + border: solid 1px #e1e4e5; + font-size: 75%; + padding: 0 5px; + font-family: Consolas, "Andale Mono WT", "Andale Mono", "Lucida Console", "Lucida Sans Typewriter", "DejaVu Sans Mono", "Bitstream Vera Sans Mono", "Liberation Mono", "Nimbus Mono L", Monaco, "Courier New", Courier, monospace; + color: #E74C3C; + overflow-x: auto; +} +code.code-large, .rst-content tt.code-large { + font-size: 90%; +} + +.wy-plain-list-disc, .rst-content .section ul, .rst-content .toctree-wrapper ul, article ul { + list-style: disc; + line-height: 24px; + margin-bottom: 24px; +} +.wy-plain-list-disc li, .rst-content .section ul li, .rst-content .toctree-wrapper ul li, article ul li { + list-style: disc; + margin-left: 24px; +} +.wy-plain-list-disc li p:last-child, .rst-content .section ul li p:last-child, .rst-content .toctree-wrapper ul li p:last-child, article ul li p:last-child { + margin-bottom: 0; +} +.wy-plain-list-disc li ul, .rst-content .section ul li ul, .rst-content .toctree-wrapper ul li ul, article ul li ul { + margin-bottom: 0; +} +.wy-plain-list-disc li li, .rst-content .section ul li li, .rst-content .toctree-wrapper ul li li, article ul li li { + list-style: circle; +} +.wy-plain-list-disc li li li, .rst-content .section ul li li li, .rst-content .toctree-wrapper ul li li li, article ul li li li { + list-style: square; +} +.wy-plain-list-disc li ol li, .rst-content .section ul li ol li, .rst-content .toctree-wrapper ul li ol li, article ul li ol li { + list-style: decimal; +} + +.wy-plain-list-decimal, .rst-content .section ol, .rst-content ol.arabic, article ol { + list-style: decimal; + line-height: 24px; + margin-bottom: 24px; +} +.wy-plain-list-decimal li, .rst-content .section ol li, .rst-content ol.arabic li, article ol li { + list-style: decimal; + margin-left: 24px; +} +.wy-plain-list-decimal li p:last-child, .rst-content .section ol li p:last-child, .rst-content ol.arabic li p:last-child, article ol li p:last-child { + margin-bottom: 0; +} +.wy-plain-list-decimal li ul, .rst-content .section ol li ul, .rst-content ol.arabic li ul, article ol li ul { + margin-bottom: 0; +} +.wy-plain-list-decimal li ul li, .rst-content .section ol li ul li, .rst-content ol.arabic li ul li, article ol li ul li { + list-style: disc; +} + +.codeblock-example { + border: 1px solid #e1e4e5; + border-bottom: none; + padding: 24px; + padding-top: 48px; + font-weight: 500; + background: #fff; + position: relative; +} +.codeblock-example:after { + content: "Example"; + position: absolute; + top: 0px; + left: 0px; + background: #9B59B6; + color: white; + padding: 6px 12px; +} +.codeblock-example.prettyprint-example-only { + border: 1px solid #e1e4e5; + margin-bottom: 24px; +} + +.codeblock, pre.literal-block, .rst-content .literal-block, .rst-content pre.literal-block, div[class^='highlight'] { + border: 1px solid #e1e4e5; + padding: 0px; + overflow-x: auto; + background: #fff; + margin: 1px 0 24px 0; +} +.codeblock div[class^='highlight'], pre.literal-block div[class^='highlight'], .rst-content .literal-block div[class^='highlight'], div[class^='highlight'] div[class^='highlight'] { + border: none; + background: none; + margin: 0; +} + +div[class^='highlight'] td.code { + width: 100%; +} + +.linenodiv pre { + border-right: solid 1px #e6e9ea; + margin: 0; + padding: 12px 12px; + font-family: Consolas, "Andale Mono WT", "Andale Mono", "Lucida Console", "Lucida Sans Typewriter", "DejaVu Sans Mono", "Bitstream Vera Sans Mono", "Liberation Mono", "Nimbus Mono L", Monaco, "Courier New", Courier, monospace; + font-size: 12px; + line-height: 1.5; + color: #d9d9d9; +} + +div[class^='highlight'] pre { + white-space: pre; + margin: 0; + padding: 12px 12px; + font-family: Consolas, "Andale Mono WT", "Andale Mono", "Lucida Console", "Lucida Sans Typewriter", "DejaVu Sans Mono", "Bitstream Vera Sans Mono", "Liberation Mono", "Nimbus Mono L", Monaco, "Courier New", Courier, monospace; + font-size: 12px; + line-height: 1.5; + display: block; + overflow: auto; + color: #404040; +} + +@media print { + .codeblock, pre.literal-block, .rst-content .literal-block, .rst-content pre.literal-block, div[class^='highlight'], div[class^='highlight'] pre { + white-space: pre-wrap; + } +} +.hll { + background-color: #ffffcc; + margin: 0 -12px; + padding: 0 12px; + display: block; +} + +.c { + color: #999988; + font-style: italic; +} + +.err { + color: #a61717; + background-color: #e3d2d2; +} + +.k { + font-weight: bold; +} + +.o { + font-weight: bold; +} + +.cm { + color: #999988; + font-style: italic; +} + +.cp { + color: #999999; + font-weight: bold; +} + +.c1 { + color: #999988; + font-style: italic; +} + +.cs { + color: #999999; + font-weight: bold; + font-style: italic; +} + +.gd { + color: #000000; + background-color: #ffdddd; +} + +.gd .x { + color: #000000; + background-color: #ffaaaa; +} + +.ge { + font-style: italic; +} + +.gr { + color: #aa0000; +} + +.gh { + color: #999999; +} + +.gi { + color: #000000; + background-color: #ddffdd; +} + +.gi .x { + color: #000000; + background-color: #aaffaa; +} + +.go { + color: #888888; +} + +.gp { + color: #555555; +} + +.gs { + font-weight: bold; +} + +.gu { + color: #800080; + font-weight: bold; +} + +.gt { + color: #aa0000; +} + +.kc { + font-weight: bold; +} + +.kd { + font-weight: bold; +} + +.kn { + font-weight: bold; +} + +.kp { + font-weight: bold; +} + +.kr { + font-weight: bold; +} + +.kt { + color: #445588; + font-weight: bold; +} + +.m { + color: #009999; +} + +.s { + color: #dd1144; +} + +.n { + color: #333333; +} + +.na { + color: teal; +} + +.nb { + color: #0086b3; +} + +.nc { + color: #445588; + font-weight: bold; +} + +.no { + color: teal; +} + +.ni { + color: purple; +} + +.ne { + color: #990000; + font-weight: bold; +} + +.nf { + color: #990000; + font-weight: bold; +} + +.nn { + color: #555555; +} + +.nt { + color: navy; +} + +.nv { + color: teal; +} + +.ow { + font-weight: bold; +} + +.w { + color: #bbbbbb; +} + +.mf { + color: #009999; +} + +.mh { + color: #009999; +} + +.mi { + color: #009999; +} + +.mo { + color: #009999; +} + +.sb { + color: #dd1144; +} + +.sc { + color: #dd1144; +} + +.sd { + color: #dd1144; +} + +.s2 { + color: #dd1144; +} + +.se { + color: #dd1144; +} + +.sh { + color: #dd1144; +} + +.si { + color: #dd1144; +} + +.sx { + color: #dd1144; +} + +.sr { + color: #009926; +} + +.s1 { + color: #dd1144; +} + +.ss { + color: #990073; +} + +.bp { + color: #999999; +} + +.vc { + color: teal; +} + +.vg { + color: teal; +} + +.vi { + color: teal; +} + +.il { + color: #009999; +} + +.gc { + color: #999; + background-color: #EAF2F5; +} + +.wy-breadcrumbs li { + display: inline-block; +} +.wy-breadcrumbs li.wy-breadcrumbs-aside { + float: right; +} +.wy-breadcrumbs li a { + display: inline-block; + padding: 5px; +} +.wy-breadcrumbs li a:first-child { + padding-left: 0; +} +.wy-breadcrumbs li code, .wy-breadcrumbs li .rst-content tt, .rst-content .wy-breadcrumbs li tt { + padding: 5px; + border: none; + background: none; +} +.wy-breadcrumbs li code.literal, .wy-breadcrumbs li .rst-content tt.literal, .rst-content .wy-breadcrumbs li tt.literal { + color: #404040; +} + +.wy-breadcrumbs-extra { + margin-bottom: 0; + color: #b3b3b3; + font-size: 80%; + display: inline-block; +} + +@media screen and (max-width: 480px) { + .wy-breadcrumbs-extra { + display: none; + } + + .wy-breadcrumbs li.wy-breadcrumbs-aside { + display: none; + } +} +@media print { + .wy-breadcrumbs li.wy-breadcrumbs-aside { + display: none; + } +} +.wy-affix { + position: fixed; + top: 1.618em; +} + +.wy-menu a:hover { + text-decoration: none; +} + +.wy-menu-horiz { + *zoom: 1; +} +.wy-menu-horiz:before, .wy-menu-horiz:after { + display: table; + content: ""; +} +.wy-menu-horiz:after { + clear: both; +} +.wy-menu-horiz ul, .wy-menu-horiz li { + display: inline-block; +} +.wy-menu-horiz li:hover { + background: rgba(255, 255, 255, 0.1); +} +.wy-menu-horiz li.divide-left { + border-left: solid 1px #404040; +} +.wy-menu-horiz li.divide-right { + border-right: solid 1px #404040; +} +.wy-menu-horiz a { + height: 32px; + display: inline-block; + line-height: 32px; + padding: 0 16px; +} + +.wy-menu-vertical header, .wy-menu-vertical p.caption { + height: 32px; + display: inline-block; + line-height: 32px; + padding: 0 1.618em; + margin-bottom: 0; + display: block; + font-weight: bold; + text-transform: uppercase; + font-size: 80%; + color: #555; + white-space: nowrap; +} +.wy-menu-vertical ul { + margin-bottom: 0; +} +.wy-menu-vertical li.divide-top { + border-top: solid 1px #404040; +} +.wy-menu-vertical li.divide-bottom { + border-bottom: solid 1px #404040; +} +.wy-menu-vertical li.current { + background: #e3e3e3; +} +.wy-menu-vertical li.current a { + color: gray; + border-right: solid 1px #c9c9c9; + padding: 0.4045em 2.427em; +} +.wy-menu-vertical li.current a:hover { + background: #d6d6d6; +} +.wy-menu-vertical li code, .wy-menu-vertical li .rst-content tt, .rst-content .wy-menu-vertical li tt { + border: none; + background: inherit; + color: inherit; + padding-left: 0; + padding-right: 0; +} +.wy-menu-vertical li span.toctree-expand { + display: block; + float: left; + margin-left: -1.2em; + font-size: 0.8em; + line-height: 1.6em; + color: #4d4d4d; +} +.wy-menu-vertical li.on a, .wy-menu-vertical li.current > a { + color: #404040; + padding: 0.4045em 1.618em; + font-weight: bold; + position: relative; + background: #fcfcfc; + border: none; + border-bottom: solid 1px #c9c9c9; + border-top: solid 1px #c9c9c9; + padding-left: 1.618em -4px; +} +.wy-menu-vertical li.on a:hover, .wy-menu-vertical li.current > a:hover { + background: #fcfcfc; +} +.wy-menu-vertical li.on a:hover span.toctree-expand, .wy-menu-vertical li.current > a:hover span.toctree-expand { + color: gray; +} +.wy-menu-vertical li.on a span.toctree-expand, .wy-menu-vertical li.current > a span.toctree-expand { + display: block; + font-size: 0.8em; + line-height: 1.6em; + color: #333333; +} +.wy-menu-vertical li.toctree-l1.current li.toctree-l2 > ul, .wy-menu-vertical li.toctree-l2.current li.toctree-l3 > ul { + display: none; +} +.wy-menu-vertical li.toctree-l1.current li.toctree-l2.current > ul, .wy-menu-vertical li.toctree-l2.current li.toctree-l3.current > ul { + display: block; +} +.wy-menu-vertical li.toctree-l2.current > a { + background: #c9c9c9; + padding: 0.4045em 2.427em; +} +.wy-menu-vertical li.toctree-l2.current li.toctree-l3 > a { + display: block; + background: #c9c9c9; + padding: 0.4045em 4.045em; +} +.wy-menu-vertical li.toctree-l2 a:hover span.toctree-expand { + color: gray; +} +.wy-menu-vertical li.toctree-l2 span.toctree-expand { + color: #a3a3a3; +} +.wy-menu-vertical li.toctree-l3 { + font-size: 0.9em; +} +.wy-menu-vertical li.toctree-l3.current > a { + background: #bdbdbd; + padding: 0.4045em 4.045em; +} +.wy-menu-vertical li.toctree-l3.current li.toctree-l4 > a { + display: block; + background: #bdbdbd; + padding: 0.4045em 5.663em; + border-top: none; + border-bottom: none; +} +.wy-menu-vertical li.toctree-l3 a:hover span.toctree-expand { + color: gray; +} +.wy-menu-vertical li.toctree-l3 span.toctree-expand { + color: #969696; +} +.wy-menu-vertical li.toctree-l4 { + font-size: 0.9em; +} +.wy-menu-vertical li.current ul { + display: block; +} +.wy-menu-vertical li ul { + margin-bottom: 0; + display: none; +} +.wy-menu-vertical .local-toc li ul { + display: block; +} +.wy-menu-vertical li ul li a { + margin-bottom: 0; + color: #b3b3b3; + font-weight: normal; +} +.wy-menu-vertical a { + display: inline-block; + line-height: 18px; + padding: 0.4045em 1.618em; + display: block; + position: relative; + font-size: 90%; + color: #b3b3b3; +} +.wy-menu-vertical a:hover { + background-color: #4e4a4a; + cursor: pointer; +} +.wy-menu-vertical a:hover span.toctree-expand { + color: #b3b3b3; +} +.wy-menu-vertical a:active { + background-color: #2980B9; + cursor: pointer; + color: #fff; +} +.wy-menu-vertical a:active span.toctree-expand { + color: #fff; +} + +.wy-side-nav-search { + z-index: 200; + background-color: #2980B9; + text-align: center; + padding: 0.809em; + display: block; + color: #fcfcfc; + margin-bottom: 0.809em; +} +.wy-side-nav-search input[type=text] { + width: 100%; + border-radius: 50px; + padding: 6px 12px; + border-color: #2472a4; +} +.wy-side-nav-search img { + display: block; + margin: auto auto 0.809em auto; + height: 45px; + width: 45px; + background-color: #2980B9; + padding: 5px; + border-radius: 100%; +} +.wy-side-nav-search > a, .wy-side-nav-search .wy-dropdown > a { + color: #fcfcfc; + font-size: 100%; + font-weight: bold; + display: inline-block; + padding: 4px 6px; + margin-bottom: 0.809em; +} +.wy-side-nav-search > a:hover, .wy-side-nav-search .wy-dropdown > a:hover { + background: rgba(255, 255, 255, 0.1); +} +.wy-side-nav-search > a img.logo, .wy-side-nav-search .wy-dropdown > a img.logo { + display: block; + margin: 0 auto; + height: auto; + width: auto; + border-radius: 0; + max-width: 100%; + background: transparent; +} +.wy-side-nav-search > a.icon img.logo, .wy-side-nav-search .wy-dropdown > a.icon img.logo { + margin-top: 0.85em; +} +.wy-side-nav-search > div.version { + margin-top: -0.4045em; + margin-bottom: 0.809em; + font-weight: normal; + color: rgba(255, 255, 255, 0.3); +} + +.wy-nav .wy-menu-vertical header { + color: #2980B9; +} +.wy-nav .wy-menu-vertical a { + color: #b3b3b3; +} +.wy-nav .wy-menu-vertical a:hover { + background-color: #2980B9; + color: #fff; +} + +[data-menu-wrap] { + -webkit-transition: all 0.2s ease-in; + -moz-transition: all 0.2s ease-in; + transition: all 0.2s ease-in; + position: absolute; + opacity: 1; + width: 100%; + opacity: 0; +} +[data-menu-wrap].move-center { + left: 0; + right: auto; + opacity: 1; +} +[data-menu-wrap].move-left { + right: auto; + left: -100%; + opacity: 0; +} +[data-menu-wrap].move-right { + right: -100%; + left: auto; + opacity: 0; +} + +.wy-body-for-nav { + background: left repeat-y #fcfcfc; + background-image: url(data:image/png;base64,iVBORw0KGgoAAAANSUhEUgAAAAEAAAABCAIAAACQd1PeAAAAGXRFWHRTb2Z0d2FyZQBBZG9iZSBJbWFnZVJlYWR5ccllPAAAAyRpVFh0WE1MOmNvbS5hZG9iZS54bXAAAAAAADw/eHBhY2tldCBiZWdpbj0i77u/IiBpZD0iVzVNME1wQ2VoaUh6cmVTek5UY3prYzlkIj8+IDx4OnhtcG1ldGEgeG1sbnM6eD0iYWRvYmU6bnM6bWV0YS8iIHg6eG1wdGs9IkFkb2JlIFhNUCBDb3JlIDUuMy1jMDExIDY2LjE0NTY2MSwgMjAxMi8wMi8wNi0xNDo1NjoyNyAgICAgICAgIj4gPHJkZjpSREYgeG1sbnM6cmRmPSJodHRwOi8vd3d3LnczLm9yZy8xOTk5LzAyLzIyLXJkZi1zeW50YXgtbnMjIj4gPHJkZjpEZXNjcmlwdGlvbiByZGY6YWJvdXQ9IiIgeG1sbnM6eG1wPSJodHRwOi8vbnMuYWRvYmUuY29tL3hhcC8xLjAvIiB4bWxuczp4bXBNTT0iaHR0cDovL25zLmFkb2JlLmNvbS94YXAvMS4wL21tLyIgeG1sbnM6c3RSZWY9Imh0dHA6Ly9ucy5hZG9iZS5jb20veGFwLzEuMC9zVHlwZS9SZXNvdXJjZVJlZiMiIHhtcDpDcmVhdG9yVG9vbD0iQWRvYmUgUGhvdG9zaG9wIENTNiAoTWFjaW50b3NoKSIgeG1wTU06SW5zdGFuY2VJRD0ieG1wLmlpZDoxOERBMTRGRDBFMUUxMUUzODUwMkJCOThDMEVFNURFMCIgeG1wTU06RG9jdW1lbnRJRD0ieG1wLmRpZDoxOERBMTRGRTBFMUUxMUUzODUwMkJCOThDMEVFNURFMCI+IDx4bXBNTTpEZXJpdmVkRnJvbSBzdFJlZjppbnN0YW5jZUlEPSJ4bXAuaWlkOjE4REExNEZCMEUxRTExRTM4NTAyQkI5OEMwRUU1REUwIiBzdFJlZjpkb2N1bWVudElEPSJ4bXAuZGlkOjE4REExNEZDMEUxRTExRTM4NTAyQkI5OEMwRUU1REUwIi8+IDwvcmRmOkRlc2NyaXB0aW9uPiA8L3JkZjpSREY+IDwveDp4bXBtZXRhPiA8P3hwYWNrZXQgZW5kPSJyIj8+EwrlwAAAAA5JREFUeNpiMDU0BAgwAAE2AJgB9BnaAAAAAElFTkSuQmCC); + background-size: 300px 1px; +} + +.wy-grid-for-nav { + position: absolute; + width: 100%; + height: 100%; +} + +.wy-nav-side { + position: fixed; + top: 0; + bottom: 0; + left: 0; + padding-bottom: 2em; + width: 300px; + overflow-x: hidden; + overflow-y: scroll; + min-height: 100%; + background: #343131; + z-index: 200; +} + +.wy-nav-top { + display: none; + background: #2980B9; + color: #fff; + padding: 0.4045em 0.809em; + position: relative; + line-height: 50px; + text-align: center; + font-size: 100%; + *zoom: 1; +} +.wy-nav-top:before, .wy-nav-top:after { + display: table; + content: ""; +} +.wy-nav-top:after { + clear: both; +} +.wy-nav-top a { + color: #fff; + font-weight: bold; +} +.wy-nav-top img { + margin-right: 12px; + height: 45px; + width: 45px; + background-color: #2980B9; + padding: 5px; + border-radius: 100%; +} +.wy-nav-top i { + font-size: 30px; + float: left; + cursor: pointer; +} + +.wy-nav-content-wrap { + margin-left: 300px; + background: #fcfcfc; + min-height: 100%; +} + +.wy-nav-content { + padding: 1.618em 3.236em; + height: 100%; + margin: auto; +} + +.wy-body-mask { + position: fixed; + width: 100%; + height: 100%; + background: rgba(0, 0, 0, 0.2); + display: none; + z-index: 499; +} +.wy-body-mask.on { + display: block; +} + +footer { + color: #999; +} +footer p { + margin-bottom: 12px; +} +footer span.commit code, footer span.commit .rst-content tt, .rst-content footer span.commit tt { + padding: 0px; + font-family: Consolas, "Andale Mono WT", "Andale Mono", "Lucida Console", "Lucida Sans Typewriter", "DejaVu Sans Mono", "Bitstream Vera Sans Mono", "Liberation Mono", "Nimbus Mono L", Monaco, "Courier New", Courier, monospace; + font-size: 1em; + background: none; + border: none; + color: #999; +} + +.rst-footer-buttons { + *zoom: 1; +} +.rst-footer-buttons:before, .rst-footer-buttons:after { + display: table; + content: ""; +} +.rst-footer-buttons:after { + clear: both; +} + +#search-results .search li { + margin-bottom: 24px; + border-bottom: solid 1px #e1e4e5; + padding-bottom: 24px; +} +#search-results .search li:first-child { + border-top: solid 1px #e1e4e5; + padding-top: 24px; +} +#search-results .search li a { + font-size: 120%; + margin-bottom: 12px; + display: inline-block; +} +#search-results .context { + color: gray; + font-size: 90%; +} + +@media screen and (max-width: 768px) { + .wy-body-for-nav { + background: #fcfcfc; + } + + .wy-nav-top { + display: block; + } + + .wy-nav-side { + left: -300px; + } + .wy-nav-side.shift { + width: 85%; + left: 0; + } + + .wy-nav-content-wrap { + margin-left: 0; + } + .wy-nav-content-wrap .wy-nav-content { + padding: 1.618em; + } + .wy-nav-content-wrap.shift { + position: fixed; + min-width: 100%; + left: 85%; + top: 0; + height: 100%; + overflow: hidden; + } +} +@media screen and (min-width: 1400px) { + .wy-nav-content-wrap { + background: rgba(0, 0, 0, 0.05); + } + + .wy-nav-content { + margin: 0; + background: #fcfcfc; + } +} +@media print { + .rst-versions, footer, .wy-nav-side { + display: none; + } + + .wy-nav-content-wrap { + margin-left: 0; + } +} +.rst-versions { + position: fixed; + bottom: 0; + left: 0; + width: 300px; + color: #fcfcfc; + background: #1f1d1d; + border-top: solid 10px #343131; + font-family: "Lato", "proxima-nova", "Helvetica Neue", Arial, sans-serif; + z-index: 400; +} +.rst-versions a { + color: #2980B9; + text-decoration: none; +} +.rst-versions .rst-badge-small { + display: none; +} +.rst-versions .rst-current-version { + padding: 12px; + background-color: #272525; + display: block; + text-align: right; + font-size: 90%; + cursor: pointer; + color: #27AE60; + *zoom: 1; +} +.rst-versions .rst-current-version:before, .rst-versions .rst-current-version:after { + display: table; + content: ""; +} +.rst-versions .rst-current-version:after { + clear: both; +} +.rst-versions .rst-current-version .fa, .rst-versions .rst-current-version .wy-menu-vertical li span.toctree-expand, .wy-menu-vertical li .rst-versions .rst-current-version span.toctree-expand, .rst-versions .rst-current-version .rst-content .admonition-title, .rst-content .rst-versions .rst-current-version .admonition-title, .rst-versions .rst-current-version .rst-content h1 .headerlink, .rst-content h1 .rst-versions .rst-current-version .headerlink, .rst-versions .rst-current-version .rst-content h2 .headerlink, .rst-content h2 .rst-versions .rst-current-version .headerlink, .rst-versions .rst-current-version .rst-content h3 .headerlink, .rst-content h3 .rst-versions .rst-current-version .headerlink, .rst-versions .rst-current-version .rst-content h4 .headerlink, .rst-content h4 .rst-versions .rst-current-version .headerlink, .rst-versions .rst-current-version .rst-content h5 .headerlink, .rst-content h5 .rst-versions .rst-current-version .headerlink, .rst-versions .rst-current-version .rst-content h6 .headerlink, .rst-content h6 .rst-versions .rst-current-version .headerlink, .rst-versions .rst-current-version .rst-content dl dt .headerlink, .rst-content dl dt .rst-versions .rst-current-version .headerlink, .rst-versions .rst-current-version .rst-content p.caption .headerlink, .rst-content p.caption .rst-versions .rst-current-version .headerlink, .rst-versions .rst-current-version .rst-content tt.download span:first-child, .rst-content tt.download .rst-versions .rst-current-version span:first-child, .rst-versions .rst-current-version .rst-content code.download span:first-child, .rst-content code.download .rst-versions .rst-current-version span:first-child, .rst-versions .rst-current-version .icon { + color: #fcfcfc; +} +.rst-versions .rst-current-version .fa-book, .rst-versions .rst-current-version .icon-book { + float: left; +} +.rst-versions .rst-current-version .icon-book { + float: left; +} +.rst-versions .rst-current-version.rst-out-of-date { + background-color: #E74C3C; + color: #fff; +} +.rst-versions .rst-current-version.rst-active-old-version { + background-color: #F1C40F; + color: #000; +} +.rst-versions.shift-up .rst-other-versions { + display: block; +} +.rst-versions .rst-other-versions { + font-size: 90%; + padding: 12px; + color: gray; + display: none; +} +.rst-versions .rst-other-versions hr { + display: block; + height: 1px; + border: 0; + margin: 20px 0; + padding: 0; + border-top: solid 1px #413d3d; +} +.rst-versions .rst-other-versions dd { + display: inline-block; + margin: 0; +} +.rst-versions .rst-other-versions dd a { + display: inline-block; + padding: 6px; + color: #fcfcfc; +} +.rst-versions.rst-badge { + width: auto; + bottom: 20px; + right: 20px; + left: auto; + border: none; + max-width: 300px; +} +.rst-versions.rst-badge .icon-book { + float: none; +} +.rst-versions.rst-badge .fa-book, .rst-versions.rst-badge .icon-book { + float: none; +} +.rst-versions.rst-badge.shift-up .rst-current-version { + text-align: right; +} +.rst-versions.rst-badge.shift-up .rst-current-version .fa-book, .rst-versions.rst-badge.shift-up .rst-current-version .icon-book { + float: left; +} +.rst-versions.rst-badge.shift-up .rst-current-version .icon-book { + float: left; +} +.rst-versions.rst-badge .rst-current-version { + width: auto; + height: 30px; + line-height: 30px; + padding: 0 6px; + display: block; + text-align: center; +} + +@media screen and (max-width: 768px) { + .rst-versions { + width: 85%; + display: none; + } + .rst-versions.shift { + display: block; + } + + img { + width: 100%; + height: auto; + } +} +.rst-content img { + max-width: 100%; + height: auto !important; +} +.rst-content div.figure { + margin-bottom: 24px; +} +.rst-content div.figure p.caption { + font-style: italic; +} +.rst-content div.figure.align-center { + text-align: center; +} +.rst-content .section > img, .rst-content .section > a > img { + margin-bottom: 24px; +} +.rst-content blockquote { + margin-left: 24px; + line-height: 24px; + margin-bottom: 24px; +} +.rst-content .note .last, .rst-content .attention .last, .rst-content .caution .last, .rst-content .danger .last, .rst-content .error .last, .rst-content .hint .last, .rst-content .important .last, .rst-content .tip .last, .rst-content .warning .last, .rst-content .seealso .last, .rst-content .admonition-todo .last { + margin-bottom: 0; +} +.rst-content .admonition-title:before { + margin-right: 4px; +} +.rst-content .admonition table { + border-color: rgba(0, 0, 0, 0.1); +} +.rst-content .admonition table td, .rst-content .admonition table th { + background: transparent !important; + border-color: rgba(0, 0, 0, 0.1) !important; +} +.rst-content .section ol.loweralpha, .rst-content .section ol.loweralpha li { + list-style: lower-alpha; +} +.rst-content .section ol.upperalpha, .rst-content .section ol.upperalpha li { + list-style: upper-alpha; +} +.rst-content .section ol p, .rst-content .section ul p { + margin-bottom: 12px; +} +.rst-content .line-block { + margin-left: 24px; +} +.rst-content .topic-title { + font-weight: bold; + margin-bottom: 12px; +} +.rst-content .toc-backref { + color: #404040; +} +.rst-content .align-right { + float: right; + margin: 0px 0px 24px 24px; +} +.rst-content .align-left { + float: left; + margin: 0px 24px 24px 0px; +} +.rst-content .align-center { + margin: auto; + display: block; +} +.rst-content h1 .headerlink, .rst-content h2 .headerlink, .rst-content .toctree-wrapper p.caption .headerlink, .rst-content h3 .headerlink, .rst-content h4 .headerlink, .rst-content h5 .headerlink, .rst-content h6 .headerlink, .rst-content dl dt .headerlink, .rst-content p.caption .headerlink { + display: none; + visibility: hidden; + font-size: 14px; +} +.rst-content h1 .headerlink:after, .rst-content h2 .headerlink:after, .rst-content .toctree-wrapper p.caption .headerlink:after, .rst-content h3 .headerlink:after, .rst-content h4 .headerlink:after, .rst-content h5 .headerlink:after, .rst-content h6 .headerlink:after, .rst-content dl dt .headerlink:after, .rst-content p.caption .headerlink:after { + visibility: visible; + content: ""; + font-family: FontAwesome; + display: inline-block; +} +.rst-content h1:hover .headerlink, .rst-content h2:hover .headerlink, .rst-content .toctree-wrapper p.caption:hover .headerlink, .rst-content h3:hover .headerlink, .rst-content h4:hover .headerlink, .rst-content h5:hover .headerlink, .rst-content h6:hover .headerlink, .rst-content dl dt:hover .headerlink, .rst-content p.caption:hover .headerlink { + display: inline-block; +} +.rst-content .sidebar { + float: right; + width: 40%; + display: block; + margin: 0 0 24px 24px; + padding: 24px; + background: #f3f6f6; + border: solid 1px #e1e4e5; +} +.rst-content .sidebar p, .rst-content .sidebar ul, .rst-content .sidebar dl { + font-size: 90%; +} +.rst-content .sidebar .last { + margin-bottom: 0; +} +.rst-content .sidebar .sidebar-title { + display: block; + font-family: "Roboto Slab", "ff-tisa-web-pro", "Georgia", Arial, sans-serif; + font-weight: bold; + background: #e1e4e5; + padding: 6px 12px; + margin: -24px; + margin-bottom: 24px; + font-size: 100%; +} +.rst-content .highlighted { + background: #F1C40F; + display: inline-block; + font-weight: bold; + padding: 0 6px; +} +.rst-content .footnote-reference, .rst-content .citation-reference { + vertical-align: super; + font-size: 90%; +} +.rst-content table.docutils.citation, .rst-content table.docutils.footnote { + background: none; + border: none; + color: #999; +} +.rst-content table.docutils.citation td, .rst-content table.docutils.citation tr, .rst-content table.docutils.footnote td, .rst-content table.docutils.footnote tr { + border: none; + background-color: transparent !important; + white-space: normal; +} +.rst-content table.docutils.citation td.label, .rst-content table.docutils.footnote td.label { + padding-left: 0; + padding-right: 0; + vertical-align: top; +} +.rst-content table.docutils.citation tt, .rst-content table.docutils.citation code, .rst-content table.docutils.footnote tt, .rst-content table.docutils.footnote code { + color: #555; +} +.rst-content table.field-list { + border: none; +} +.rst-content table.field-list td { + border: none; + padding-top: 5px; +} +.rst-content table.field-list td > strong { + display: inline-block; + margin-top: 3px; +} +.rst-content table.field-list .field-name { + padding-right: 10px; + text-align: left; + white-space: nowrap; +} +.rst-content table.field-list .field-body { + text-align: left; + padding-left: 0; +} +.rst-content tt, .rst-content tt, .rst-content code { + color: #000; +} +.rst-content tt big, .rst-content tt em, .rst-content tt big, .rst-content code big, .rst-content tt em, .rst-content code em { + font-size: 100% !important; + line-height: normal; +} +.rst-content tt.literal, .rst-content tt.literal, .rst-content code.literal { + color: #E74C3C; +} +.rst-content tt.xref, a .rst-content tt, .rst-content tt.xref, .rst-content code.xref, a .rst-content tt, a .rst-content code { + font-weight: bold; + color: #404040; +} +.rst-content a tt, .rst-content a tt, .rst-content a code { + color: #2980B9; +} +.rst-content dl { + margin-bottom: 24px; +} +.rst-content dl dt { + font-weight: bold; +} +.rst-content dl p, .rst-content dl table, .rst-content dl ul, .rst-content dl ol { + margin-bottom: 12px !important; +} +.rst-content dl dd { + margin: 0 0 12px 24px; +} +.rst-content dl:not(.docutils) { + margin-bottom: 24px; +} +.rst-content dl:not(.docutils) dt { + display: inline-block; + margin: 6px 0; + font-size: 90%; + line-height: normal; + background: #e7f2fa; + color: #2980B9; + border-top: solid 3px #6ab0de; + padding: 6px; + position: relative; +} +.rst-content dl:not(.docutils) dt:before { + color: #6ab0de; +} +.rst-content dl:not(.docutils) dt .headerlink { + color: #404040; + font-size: 100% !important; +} +.rst-content dl:not(.docutils) dl dt { + margin-bottom: 6px; + border: none; + border-left: solid 3px #cccccc; + background: #f0f0f0; + color: gray; +} +.rst-content dl:not(.docutils) dl dt .headerlink { + color: #404040; + font-size: 100% !important; +} +.rst-content dl:not(.docutils) dt:first-child { + margin-top: 0; +} +.rst-content dl:not(.docutils) tt, .rst-content dl:not(.docutils) tt, .rst-content dl:not(.docutils) code { + font-weight: bold; +} +.rst-content dl:not(.docutils) tt.descname, .rst-content dl:not(.docutils) tt.descclassname, .rst-content dl:not(.docutils) tt.descname, .rst-content dl:not(.docutils) code.descname, .rst-content dl:not(.docutils) tt.descclassname, .rst-content dl:not(.docutils) code.descclassname { + background-color: transparent; + border: none; + padding: 0; + font-size: 100% !important; +} +.rst-content dl:not(.docutils) tt.descname, .rst-content dl:not(.docutils) tt.descname, .rst-content dl:not(.docutils) code.descname { + font-weight: bold; +} +.rst-content dl:not(.docutils) .optional { + display: inline-block; + padding: 0 4px; + color: #000; + font-weight: bold; +} +.rst-content dl:not(.docutils) .property { + display: inline-block; + padding-right: 8px; +} +.rst-content .viewcode-link, .rst-content .viewcode-back { + display: inline-block; + color: #27AE60; + font-size: 80%; + padding-left: 24px; +} +.rst-content .viewcode-back { + display: block; + float: right; +} +.rst-content p.rubric { + margin-bottom: 12px; + font-weight: bold; +} +.rst-content tt.download, .rst-content code.download { + background: inherit; + padding: inherit; + font-family: inherit; + font-size: inherit; + color: inherit; + border: inherit; + white-space: inherit; +} +.rst-content tt.download span:first-child:before, .rst-content code.download span:first-child:before { + margin-right: 4px; +} + +@media screen and (max-width: 480px) { + .rst-content .sidebar { + width: 100%; + } +} +span[id*='MathJax-Span'] { + color: #404040; +} + +.math { + text-align: center; +} + +@font-face { + font-family: "Inconsolata"; + font-style: normal; + font-weight: 400; + src: local("Inconsolata"), url(../fonts/Inconsolata.ttf) format("truetype"); +} +@font-face { + font-family: "Inconsolata"; + font-style: normal; + font-weight: 700; + src: local("Inconsolata Bold"), local("Inconsolata-Bold"), url(../fonts/Inconsolata-Bold.ttf) format("truetype"); +} +@font-face { + font-family: "Lato"; + font-style: normal; + font-weight: 400; + src: local("Lato Regular"), local("Lato-Regular"), url(../fonts/Lato-Regular.ttf) format("truetype"); +} +@font-face { + font-family: "Lato"; + font-style: normal; + font-weight: 700; + src: local("Lato Bold"), local("Lato-Bold"), url(../fonts/Lato-Bold.ttf) format("truetype"); +} +@font-face { + font-family: "Roboto Slab"; + font-style: normal; + font-weight: 400; + src: local("Roboto Slab Regular"), local("RobotoSlab-Regular"), url(../fonts/RobotoSlab-Regular.ttf) format("truetype"); +} +@font-face { + font-family: "Roboto Slab"; + font-style: normal; + font-weight: 700; + src: local("Roboto Slab Bold"), local("RobotoSlab-Bold"), url(../fonts/RobotoSlab-Bold.ttf) format("truetype"); +} + +/*# sourceMappingURL=theme.css.map */ diff --git a/doc/_themes/lammps_theme/static/css/theme.css.map b/doc/_themes/lammps_theme/static/css/theme.css.map new file mode 100644 index 00000000..7e94d024 --- /dev/null +++ b/doc/_themes/lammps_theme/static/css/theme.css.map @@ -0,0 +1,7 @@ +{ +"version": 3, +"mappings": ";AACE,CAAE;ECQI,kBAAoB,EDPJ,UAAU;ECY1B,eAAiB,EDZD,UAAU;EC2B1B,UAAY,ED3BI,UAAU;;;AEFlC,iFAAiF;EAC/E,OAAO,EAAE,KAAK;;;AAEhB,oBAAoB;EAClB,OAAO,EAAE,YAAY;EACrB,QAAQ,EAAE,MAAM;EAChB,KAAK,EAAE,CAAC;;;AAEV,qBAAqB;EACnB,OAAO,EAAE,IAAI;;;AAEf,QAAQ;EACN,OAAO,EAAE,IAAI;;;AAEf,CAAC;EDLO,kBAAoB,ECMd,UAAU;EDDhB,eAAiB,ECCX,UAAU;EDchB,UAAY,ECdN,UAAU;;;AAExB,IAAI;EACF,SAAS,EAAE,IAAI;EACf,wBAAwB,EAAE,IAAI;EAC9B,oBAAoB,EAAE,IAAI;;;AAE5B,IAAI;EACF,MAAM,EAAE,CAAC;;;AAEX,iBAAiB;EACf,OAAO,EAAE,CAAC;;;AAEZ,WAAW;EACT,aAAa,EAAE,UAAU;;;AAE3B,SAAS;EACP,WAAW,EAAE,IAAI;;;AAEnB,UAAU;EACR,MAAM,EAAE,CAAC;;;AAEX,GAAG;EACD,UAAU,EAAE,MAAM;;;AAGpB,GAAG;EACD,UAAU,EAAE,IAAI;EAChB,KAAK,EAAE,IAAI;EACX,eAAe,EAAE,IAAI;;;AAEvB,IAAI;EACF,UAAU,EAAE,IAAI;EAChB,KAAK,EAAE,IAAI;EACX,UAAU,EAAE,MAAM;EAClB,WAAW,EAAE,IAAI;;;AAEnB,wDAAoB;EAClB,WAAW,EAAE,gBAAS;EACtB,YAAY,EAAE,wBAAa;EAC3B,SAAS,EAAE,GAAG;;;AAEhB,GAAG;EACD,WAAW,EAAE,GAAG;;;AAElB,CAAC;EACC,MAAM,EAAE,IAAI;;;AAEd,iBAAiB;EACf,OAAO,EAAE,EAAE;EACX,OAAO,EAAE,IAAI;;;AAEf,KAAK;EACH,SAAS,EAAE,GAAG;;;AAEhB,QAAQ;EACN,SAAS,EAAE,GAAG;EACd,WAAW,EAAE,CAAC;EACd,QAAQ,EAAE,QAAQ;EAClB,cAAc,EAAE,QAAQ;;;AAE1B,GAAG;EACD,GAAG,EAAE,MAAM;;;AAEb,GAAG;EACD,MAAM,EAAE,OAAO;;;AAEjB,UAAU;EACR,MAAM,EAAE,CAAC;EACT,OAAO,EAAE,CAAC;EACV,UAAU,EAAE,IAAI;EAChB,gBAAgB,EAAE,IAAI;;;AAExB,EAAE;EACA,UAAU,EAAE,IAAI;;;AAElB,EAAE;EACA,MAAM,EAAE,CAAC;;;AAEX,GAAG;EACD,MAAM,EAAE,CAAC;EACT,sBAAsB,EAAE,OAAO;EAC/B,cAAc,EAAE,MAAM;EACtB,SAAS,EAAE,IAAI;;;AAEjB,cAAc;EACZ,QAAQ,EAAE,MAAM;;;AAElB,MAAM;EACJ,MAAM,EAAE,CAAC;;;AAEX,IAAI;EACF,MAAM,EAAE,CAAC;;;AAEX,QAAQ;EACN,MAAM,EAAE,CAAC;EACT,MAAM,EAAE,CAAC;EACT,OAAO,EAAE,CAAC;;;AAEZ,KAAK;EACH,MAAM,EAAE,OAAO;;;AAEjB,MAAM;EACJ,MAAM,EAAE,CAAC;EACT,YAAY,EAAE,IAAI;EAClB,OAAO,EAAE,CAAC;EACV,WAAW,EAAE,MAAM;;;AAErB,+BAA+B;EAC7B,SAAS,EAAE,IAAI;EACf,MAAM,EAAE,CAAC;EACT,cAAc,EAAE,QAAQ;EACxB,eAAe,EAAE,MAAM;;;AAEzB,aAAa;EACX,WAAW,EAAE,MAAM;;;AAErB,uEAAuE;EACrE,MAAM,EAAE,OAAO;EACf,kBAAkB,EAAE,MAAM;EAC1B,SAAS,EAAE,OAAO;;;AAEpB,iCAAiC;EAC/B,MAAM,EAAE,OAAO;;;AAEjB,2CAA2C;EACzC,UAAU,EAAE,UAAU;EACtB,OAAO,EAAE,CAAC;EACV,MAAM,EAAE,IAAI;EACZ,OAAO,EAAE,IAAI;;;AAEf,oBAAoB;EAClB,kBAAkB,EAAE,SAAS;EAC7B,eAAe,EAAE,WAAW;EAC5B,kBAAkB,EAAE,WAAW;EAC/B,UAAU,EAAE,WAAW;;;AAEzB,mGAAmG;EACjG,kBAAkB,EAAE,IAAI;;;AAE1B,iDAAiD;EAC/C,MAAM,EAAE,CAAC;EACT,OAAO,EAAE,CAAC;;;AAEZ,QAAQ;EACN,QAAQ,EAAE,IAAI;EACd,cAAc,EAAE,GAAG;EACnB,MAAM,EAAE,QAAQ;;;AAElB,KAAK;EACH,eAAe,EAAE,QAAQ;EACzB,cAAc,EAAE,CAAC;;;AAEnB,EAAE;EACA,cAAc,EAAE,GAAG;;;AAErB,YAAY;EACV,MAAM,EAAE,OAAO;EACf,UAAU,EAAE,IAAI;EAChB,KAAK,EAAE,KAAK;EACZ,OAAO,EAAE,OAAO;;;AAElB,GAAG;EACD,OAAO,EAAE,KAAK;EACd,MAAM,EAAE,CAAC;EACT,WAAW,EAAE,MAAM;EACnB,QAAQ,EAAE,MAAM;EAChB,gBAAgB,EAAE,WAAW;EAC7B,iBAAiB,EAAE,SAAS;EAC5B,UAAU,EAAE,IAAI;EAChB,SAAS,EAAE,GAAG;EACd,YAAY,EAAE,CAAC;;;AAEjB,MAAM;EACJ,OAAO,EAAE,IAAI;;;AAEf,OAAO;EACL,OAAO,EAAE,eAAe;EACxB,UAAU,EAAE,MAAM;;;AAEpB,eAAe;EACb,MAAM,EAAE,CAAC;EACT,IAAI,EAAE,aAAa;EACnB,MAAM,EAAE,GAAG;EACX,MAAM,EAAE,IAAI;EACZ,QAAQ,EAAE,MAAM;EAChB,OAAO,EAAE,CAAC;EACV,QAAQ,EAAE,QAAQ;EAClB,KAAK,EAAE,GAAG;;;AAEZ,iEAAiE;EAC/D,IAAI,EAAE,IAAI;EACV,MAAM,EAAE,IAAI;EACZ,MAAM,EAAE,CAAC;EACT,QAAQ,EAAE,OAAO;EACjB,QAAQ,EAAE,MAAM;EAChB,KAAK,EAAE,IAAI;;;AAEb,UAAU;EACR,UAAU,EAAE,MAAM;;;AAEpB,SAAS;EACP,QAAQ,EAAE,QAAQ;;;AAEpB,UAAU;EACR,SAAS,EAAE,IAAI;;;AAEjB,YAAY;EACV,mBAAmB;IACjB,UAAU,EAAE,eAAe;;;EAC7B,CAAC;IACC,UAAU,EAAE,eAAe;IAC3B,WAAW,EAAE,eAAe;IAC5B,MAAM,EAAE,eAAe;IACvB,UAAU,EAAE,eAAe;;;EAC7B,YAAY;IACV,eAAe,EAAE,SAAS;;;EAC5B,6DAA6D;IAC3D,OAAO,EAAE,EAAE;;;EACb,eAAe;IACb,iBAAiB,EAAE,KAAK;;;EAC1B,KAAK;IACH,OAAO,EAAE,kBAAkB;;;EAC7B,OAAO;IACL,iBAAiB,EAAE,KAAK;;;EAC1B,GAAG;IACD,SAAS,EAAE,eAAe;;;;IAE1B,MAAM,EAAE,KAAK;;EAEf,kDAAS;IACP,OAAO,EAAE,CAAC;IACV,MAAM,EAAE,CAAC;;;EACX,+CAAM;IACJ,gBAAgB,EAAE,KAAK;;;AChM3B,woDAAY;EACV,sBAAsB,EAAE,WAAW;;;AAqDrC,SAAS;EARP,KAAK,EAAE,CAAC;;AACR,iCAAS;EAEP,OAAO,EAAE,KAAK;EACd,OAAO,EAAE,EAAE;;AACb,eAAO;EACL,KAAK,EAAE,IAAI;;;;;;;;;AC1Gf,UAUC;EATC,WAAW,EAAE,aAAa;EAC1B,GAAG,EAAE,+CAAgE;EACrE,GAAG,EAAE,ySAAmG;EAKxG,WAAW,EAAE,MAAM;EACnB,UAAU,EAAE,MAAM;;ACTpB,mgBAAmB;EACjB,OAAO,EAAE,YAAY;EACrB,IAAI,EAAE,uCAAuC;EAC7C,SAAS,EAAE,OAAO;EAClB,cAAc,EAAE,IAAI;EACpB,sBAAsB,EAAE,WAAW;EACnC,uBAAuB,EAAE,SAAS;;;;ACLpC,MAAsB;EACpB,SAAS,EAAE,SAAS;EACpB,WAAW,EAAE,MAAS;EACtB,cAAc,EAAE,IAAI;;;AAEtB,MAAsB;EAAE,SAAS,EAAE,GAAG;;;AACtC,MAAsB;EAAE,SAAS,EAAE,GAAG;;;AACtC,MAAsB;EAAE,SAAS,EAAE,GAAG;;;AACtC,MAAsB;EAAE,SAAS,EAAE,GAAG;;;ACVtC,MAAsB;EACpB,KAAK,EAAE,SAAW;EAClB,UAAU,EAAE,MAAM;;;ACDpB,MAAsB;EACpB,YAAY,EAAE,CAAC;EACf,WAAW,ECIU,SAAS;EDH9B,eAAe,EAAE,IAAI;;AACrB,WAAK;EAAE,QAAQ,EAAE,QAAQ;;;AAE3B,MAAsB;EACpB,QAAQ,EAAE,QAAQ;EAClB,IAAI,EAAE,UAAa;EACnB,KAAK,ECHgB,SAAS;EDI9B,GAAG,EAAE,SAAU;EACf,UAAU,EAAE,MAAM;;AAClB,YAAuB;EACrB,IAAI,EAAE,UAA0B;;;AEbpC,UAA0B;EACxB,OAAO,EAAE,gBAAgB;EACzB,MAAM,EAAE,iBAA4B;EACpC,aAAa,EAAE,IAAI;;;AAGrB,WAAY;EAAE,KAAK,EAAE,KAAK;;;AAC1B,UAAW;EAAE,KAAK,EAAE,IAAI;;;AAGtB,mqBAAY;EAAE,YAAY,EAAE,IAAI;;AAChC,mrBAAa;EAAE,WAAW,EAAE,IAAI;;;ACXlC,QAAwB;EACtB,iBAAiB,EAAE,0BAA0B;EACrC,SAAS,EAAE,0BAA0B;;;AAG/C,0BASC;EARC,EAAG;IACD,iBAAiB,EAAE,YAAY;IACvB,SAAS,EAAE,YAAY;;EAEjC,IAAK;IACH,iBAAiB,EAAE,cAAc;IACzB,SAAS,EAAE,cAAc;;;AAIrC,kBASC;EARC,EAAG;IACD,iBAAiB,EAAE,YAAY;IACvB,SAAS,EAAE,YAAY;;EAEjC,IAAK;IACH,iBAAiB,EAAE,cAAc;IACzB,SAAS,EAAE,cAAc;;;ACvBrC,aAA8B;ECU5B,MAAM,EAAE,wDAAmE;EAC3E,iBAAiB,EAAE,aAAgB;EAC/B,aAAa,EAAE,aAAgB;EAC3B,SAAS,EAAE,aAAgB;;;ADZrC,cAA8B;ECS5B,MAAM,EAAE,wDAAmE;EAC3E,iBAAiB,EAAE,cAAgB;EAC/B,aAAa,EAAE,cAAgB;EAC3B,SAAS,EAAE,cAAgB;;;ADXrC,cAA8B;ECQ5B,MAAM,EAAE,wDAAmE;EAC3E,iBAAiB,EAAE,cAAgB;EAC/B,aAAa,EAAE,cAAgB;EAC3B,SAAS,EAAE,cAAgB;;;ADTrC,mBAAmC;ECajC,MAAM,EAAE,wDAAmE;EAC3E,iBAAiB,EAAE,YAAoB;EACnC,aAAa,EAAE,YAAoB;EAC/B,SAAS,EAAE,YAAoB;;;ADfzC,iBAAmC;ECYjC,MAAM,EAAE,wDAAmE;EAC3E,iBAAiB,EAAE,YAAoB;EACnC,aAAa,EAAE,YAAoB;EAC/B,SAAS,EAAE,YAAoB;;;ADVzC;;;;uBAIuC;EACrC,MAAM,EAAE,IAAI;;;AEfd,SAAyB;EACvB,QAAQ,EAAE,QAAQ;EAClB,OAAO,EAAE,YAAY;EACrB,KAAK,EAAE,GAAG;EACV,MAAM,EAAE,GAAG;EACX,WAAW,EAAE,GAAG;EAChB,cAAc,EAAE,MAAM;;;AAExB,0BAAyD;EACvD,QAAQ,EAAE,QAAQ;EAClB,IAAI,EAAE,CAAC;EACP,KAAK,EAAE,IAAI;EACX,UAAU,EAAE,MAAM;;;AAEpB,YAA4B;EAAE,WAAW,EAAE,OAAO;;;AAClD,YAA4B;EAAE,SAAS,EAAE,GAAG;;;AAC5C,WAA2B;EAAE,KAAK,ELXZ,IAAI;;;;;AML1B,gBAAgC;EAAE,OAAO,ENwP1B,GAAO;;;AMvPtB,gBAAgC;EAAE,OAAO,ENkV1B,GAAO;;;AMjVtB,sCAAiC;EAAE,OAAO,ENyZ1B,GAAO;;;AMxZvB,qBAAqC;EAAE,OAAO,EN2K1B,GAAO;;;AM1K3B,gBAAgC;EAAE,OAAO,ENqQ1B,GAAO;;;AMpQtB,eAA+B;EAAE,OAAO,ENkc1B,GAAO;;;AMjcrB,iBAAiC;EAAE,OAAO,ENsc1B,GAAO;;;AMrcvB,eAA+B;EAAE,OAAO,EN0gB1B,GAAO;;;AMzgBrB,eAA+B;EAAE,OAAO,EN+M1B,GAAO;;;AM9MrB,mBAAmC;EAAE,OAAO,EN8d1B,GAAO;;;AM7dzB,aAA6B;EAAE,OAAO,EN4d1B,GAAO;;;AM3dnB,kBAAkC;EAAE,OAAO,EN6d1B,GAAO;;;AM5dxB,gBAAgC;EAAE,OAAO,EN+F1B,GAAO;;;AM9FtB;;gBAEgC;EAAE,OAAO,ENge1B,GAAO;;;AM/dtB,sBAAsC;EAAE,OAAO,EN6Y1B,GAAO;;;AM5Y5B,uBAAuC;EAAE,OAAO,EN2Y1B,GAAO;;;AM1Y7B,oBAAoC;EAAE,OAAO,ENqW1B,GAAO;;;AMpW1B,iBAAiC;EAAE,OAAO,ENwZ1B,GAAO;;;AMvZvB;cAC8B;EAAE,OAAO,ENmH1B,GAAO;;;AMlHpB,kBAAkC;EAAE,OAAO,ENoe1B,GAAO;;;AMnexB,kCAA+B;EAAE,OAAO,ENqP1B,GAAO;;;AMpPrB,iBAAiC;EAAE,OAAO,ENmL1B,GAAO;;;AMlLvB,kBAAkC;EAAE,OAAO,ENqG1B,GAAO;;;AMpGxB,eAA+B;EAAE,OAAO,ENqX1B,GAAO;;;AMpXrB,yHAAmC;EAAE,OAAO,ENyI1B,GAAO;;;AMxIzB,8BAA8C;EAAE,OAAO,ENG1B,GAAO;;;AMFpC,4BAA4C;EAAE,OAAO,ENK1B,GAAO;;;AMJlC,gBAAgC;EAAE,OAAO,ENmP1B,GAAO;;;AMlPtB,wBAAwC;EAAE,OAAO,ENkV1B,GAAO;;;AMjV9B;iBACiC;EAAE,OAAO,ENyW1B,GAAO;;;AMxWvB,kBAAkC;EAAE,OAAO,ENoW1B,GAAO;;;AMnWxB,mBAAmC;EAAE,OAAO,ENiR1B,GAAO;;;AMhRzB,eAA+B;EAAE,OAAO,ENoR1B,GAAO;;;AMnRrB,eAA+B;EAAE,OAAO,ENsL1B,GAAO;;;AMrLrB,qBAAqC;EAAE,OAAO,ENkO1B,GAAO;;;AMjO3B,qBAAqC;EAAE,OAAO,ENkf1B,GAAO;;;AMjf3B,sBAAsC;EAAE,OAAO,ENgf1B,GAAO;;;AM/e5B,oBAAoC;EAAE,OAAO,ENif1B,GAAO;;;AMhf1B,iBAAiC;EAAE,OAAO,ENiV1B,GAAO;;;AMhVvB,kBAAkC;EAAE,OAAO,ENU1B,GAAO;;;AMTxB,cAA8B;EAAE,OAAO,ENkb1B,GAAO;;;AMjbpB,eAA+B;EAAE,OAAO,ENkb1B,GAAO;;;AMjbrB,kCAA+B;EAAE,OAAO,ENyB1B,GAAO;;;AMxBrB,mBAAmC;EAAE,OAAO,ENyB1B,GAAO;;;AMxBzB,gBAAgC;EAAE,OAAO,ENwU1B,GAAO;;;AMvUtB,iBAAiC;EAAE,OAAO,ENqC1B,GAAO;;;AMpCvB,eAA+B;EAAE,OAAO,ENoL1B,GAAO;;;AMnLrB,eAA+B;EAAE,OAAO,ENiB1B,GAAO;;;AMhBrB,iBAAiC;EAAE,OAAO,ENqO1B,GAAO;;;AMpOvB,sBAAsC;EAAE,OAAO,EN+a1B,GAAO;;;AM9a5B,qBAAqC;EAAE,OAAO,EN+a1B,GAAO;;;AM9a3B,qBAAqC;EAAE,OAAO,EN3C1B,GAAO;;;AM4C3B,uBAAuC;EAAE,OAAO,EN9C1B,GAAO;;;AM+C7B,sBAAsC;EAAE,OAAO,EN5C1B,GAAO;;;AM6C5B,wBAAwC;EAAE,OAAO,EN/C1B,GAAO;;;AMgD9B,eAA+B;EAAE,OAAO,ENwP1B,GAAO;;;AMvPrB;kBACkC;EAAE,OAAO,EN0R1B,GAAO;;;AMzRxB,iBAAiC;EAAE,OAAO,ENoN1B,GAAO;;;AMnNvB,uBAAuC;EAAE,OAAO,ENqd1B,GAAO;;;AMpd7B;;oBAEoC;EAAE,OAAO,ENsS1B,GAAO;;;AMrS1B,iBAAiC;EAAE,OAAO,EN+R1B,GAAO;;;AM9RvB,qBAAqC;EAAE,OAAO,EN+P1B,GAAO;;;AM9P3B,iBAAiC;EAAE,OAAO,EN7D1B,GAAO;;;AM8DvB,eAA+B;EAAE,OAAO,EN4a1B,GAAO;;;AM3arB;0BAC0C;EAAE,OAAO,EN4R1B,GAAO;;;AM3RhC,yBAAyC;EAAE,OAAO,EN2V1B,GAAO;;;AM1V/B,yBAAyC;EAAE,OAAO,ENqC1B,GAAO;;;AMpC/B,iBAAiC;EAAE,OAAO,ENlC1B,GAAO;;;AMmCvB,wBAAwC;EAAE,OAAO,ENmY1B,GAAO;;;AMlY9B,wBAAwC;EAAE,OAAO,ENkH1B,GAAO;;;AMjH9B,mBAAmC;EAAE,OAAO,EN9B1B,GAAO;;;AM+BzB,eAA+B;EAAE,OAAO,ENgS1B,GAAO;;;AM/RrB,gBAAgC;EAAE,OAAO,EN+Q1B,GAAO;;;AM9QtB,eAA+B;EAAE,OAAO,ENiY1B,GAAO;;;AMhYrB,kBAAkC;EAAE,OAAO,ENqJ1B,GAAO;;;AMpJxB,uBAAuC;EAAE,OAAO,EN6G1B,GAAO;;;AM5G7B,uBAAuC;EAAE,OAAO,EN4X1B,GAAO;;;AM3X7B,gBAAgC;EAAE,OAAO,ENoF1B,GAAO;;;AMnFtB,uBAAuC;EAAE,OAAO,EN+B1B,GAAO;;;AM9B7B,wBAAwC;EAAE,OAAO,EN+B1B,GAAO;;;AM9B9B,sBAAsC;EAAE,OAAO,EN4R1B,GAAO;;;AM3R5B,uBAAuC;EAAE,OAAO,ENkP1B,GAAO;;;AMjP7B,+FAAuC;EAAE,OAAO,ENsZ1B,GAAO;;;AMrZ7B,gGAAuC;EAAE,OAAO,ENiB1B,GAAO;;;AMhB7B,0BAA0C;EAAE,OAAO,ENiS1B,GAAO;;;AMhShC,sBAAsC;EAAE,OAAO,ENuL1B,GAAO;;;AMtL5B,qBAAqC;EAAE,OAAO,ENuD1B,GAAO;;;AMtD3B,yBAAyC;EAAE,OAAO,ENkZ1B,GAAO;;;AMjZ/B,yBAAyC;EAAE,OAAO,ENa1B,GAAO;;;AMZ/B,cAA8B;EAAE,OAAO,ENhD1B,GAAO;;;AMiDpB,qBAAqC;EAAE,OAAO,EN5D1B,GAAO;;;AM6D3B,sBAAsC;EAAE,OAAO,EN5D1B,GAAO;;;AM6D5B,mBAAmC;EAAE,OAAO,EN5D1B,GAAO;;;AM6DzB,qBAAqC;EAAE,OAAO,ENhE1B,GAAO;;;AMiE3B;gBACgC;EAAE,OAAO,ENyT1B,GAAO;;;AMxTtB,iBAAiC;EAAE,OAAO,EN+E1B,GAAO;;;AM9EvB,mBAAmC;EAAE,OAAO,ENuC1B,GAAO;;;AMtCzB,eAA+B;EAAE,OAAO,ENyQ1B,GAAO;;;AMxQrB,gBAAgC;EAAE,OAAO,EN+N1B,GAAO;;;AM9NtB,mBAAmC;EAAE,OAAO,EN/D1B,GAAO;;;AMgEzB,mNAA6C;EAAE,OAAO,ENwE1B,GAAO;;;AMvEnC,eAA+B;EAAE,OAAO,ENmI1B,GAAO;;;AMlIrB,eAA+B;EAAE,OAAO,ENqL1B,GAAO;;;AMpLrB,kCAA+B;EAAE,OAAO,ENyG1B,GAAO;;;AMxGrB,cAA8B;EAAE,OAAO,ENyE1B,GAAO;;;AMxEpB,oBAAoC;EAAE,OAAO,ENyE1B,GAAO;;;AMxE1B;+BAC+C;EAAE,OAAO,ENkE1B,GAAO;;;AMjErC,gBAAgC;EAAE,OAAO,ENyP1B,GAAO;;;AMxPtB,mBAAmC;EAAE,OAAO,ENlC1B,GAAO;;;AMmCzB,iBAAiC;EAAE,OAAO,EN0Q1B,GAAO;;;AMzQvB,kBAAkC;EAAE,OAAO,ENmB1B,GAAO;;;AMlBxB,iBAAiC;EAAE,OAAO,ENqM1B,GAAO;;;AMpMvB,qBAAqC;EAAE,OAAO,ENH1B,GAAO;;;AMI3B,uBAAuC;EAAE,OAAO,ENP1B,GAAO;;;AMQ7B,kBAAkC;EAAE,OAAO,ENiR1B,GAAO;;;AMhRxB,wBAAwC;EAAE,OAAO,EN2S1B,GAAO;;;AM1S9B,iBAAiC;EAAE,OAAO,ENoG1B,GAAO;;;AMnGvB,sBAAsC;EAAE,OAAO,ENqG1B,GAAO;;;AMpG5B,mBAAmC;EAAE,OAAO,ENpF1B,GAAO;;;AMqFzB,mBAAmC;EAAE,OAAO,ENtF1B,GAAO;;;AMuFzB;oBACoC;EAAE,OAAO,ENhF1B,GAAO;;;AMiF1B,yBAAyC;EAAE,OAAO,ENkY1B,GAAO;;;AMjY/B,0BAA0C;EAAE,OAAO,ENyD1B,GAAO;;;AMxDhC,uBAAuC;EAAE,OAAO,EN/C1B,GAAO;;;AMgD7B,cAA8B;EAAE,OAAO,ENsJ1B,GAAO;;;AMrJpB;eAC+B;EAAE,OAAO,ENA1B,GAAO;;;AMCrB,mBAAmC;EAAE,OAAO,ENG1B,GAAO;;;AMFzB,sBAAsC;EAAE,OAAO,ENiW1B,GAAO;;;AMhW5B,wBAAwC;EAAE,OAAO,EN+V1B,GAAO;;;AM9V9B,oBAAoC;EAAE,OAAO,EN2T1B,GAAO;;;AM1T1B,kBAAkC;EAAE,OAAO,EN4H1B,GAAO;;;AM3HxB,mBAAmC;EAAE,OAAO,EN2R1B,GAAO;;;AM1RzB,0BAA0C;EAAE,OAAO,ENiK1B,GAAO;;;AMhKhC,qBAAqC;EAAE,OAAO,ENwV1B,GAAO;;;AMvV3B,wBAAwC;EAAE,OAAO,ENsC1B,GAAO;;;AMrC9B,kBAAkC;EAAE,OAAO,ENsR1B,GAAO;;;AMrRxB,iBAAiC;EAAE,OAAO,ENyW1B,GAAO;;;AMxWvB,wBAAwC;EAAE,OAAO,ENiG1B,GAAO;;;AMhG9B,iBAAiC;EAAE,OAAO,ENyX1B,GAAO;;;AMxXvB,kBAAkC;EAAE,OAAO,EN+I1B,GAAO;;;AM9IxB,gBAAgC;EAAE,OAAO,EN6M1B,GAAO;;;AM5MtB,mBAAmC;EAAE,OAAO,EN2S1B,GAAO;;;AM1SzB,qBAAqC;EAAE,OAAO,ENjF1B,GAAO;;;AMkF3B,uBAAuC;EAAE,OAAO,EN2M1B,GAAO;;;AM1M7B,kBAAkC;EAAE,OAAO,ENyW1B,GAAO;;;AMxWxB,mBAAmC;EAAE,OAAO,ENgC1B,GAAO;;;AM/BzB,sCAAiC;EAAE,OAAO,ENsF1B,GAAO;;;AMrFvB,iBAAiC;EAAE,OAAO,EN6W1B,GAAO;;;AM5WvB,sBAAsC;EAAE,OAAO,ENb1B,GAAO;;;AMc5B,cAA8B;EAAE,OAAO,ENmP1B,GAAO;;;AMlPpB,gBAAgC;EAAE,OAAO,ENoG1B,GAAO;;;AMnGtB,mBAAmC;EAAE,OAAO,ENpF1B,GAAO;;;AMqFzB,eAA+B;EAAE,OAAO,EN1G1B,GAAO;;;AM2GrB,sBAAsC;EAAE,OAAO,EN7D1B,GAAO;;;AM8D5B,uBAAuC;EAAE,OAAO,EN8F1B,GAAO;;;AM7F7B,sBAAsC;EAAE,OAAO,EN4F1B,GAAO;;;AM3F5B,oBAAoC;EAAE,OAAO,EN6F1B,GAAO;;;AM5F1B,sBAAsC;EAAE,OAAO,ENyF1B,GAAO;;;AMxF5B,4DAA4C;EAAE,OAAO,EN5I1B,GAAO;;;AM6IlC,8DAA6C;EAAE,OAAO,ENxI1B,GAAO;;;AMyInC,0BAA0C;EAAE,OAAO,ENxI1B,GAAO;;;AMyIhC,4BAA4C;EAAE,OAAO,ENhJ1B,GAAO;;;AMiJlC,gBAAgC;EAAE,OAAO,EN2E1B,GAAO;;;AM1EtB,iBAAiC;EAAE,OAAO,ENqX1B,GAAO;;;AMpXvB,gBAAgC;EAAE,OAAO,ENgT1B,GAAO;;;AM/StB,iBAAiC;EAAE,OAAO,ENuC1B,GAAO;;;AMtCvB,oBAAoC;EAAE,OAAO,ENxG1B,GAAO;;;AMyG1B,qBAAqC;EAAE,OAAO,ENzI1B,GAAO;;;AM0I3B;gBACgC;EAAE,OAAO,EN8V1B,GAAO;;;AM7VtB;;iBAC+B;EAAE,OAAO,ENwH1B,GAAO;;;AMvHrB,gBAAgC;EAAE,OAAO,ENxD1B,GAAO;;;AMyDtB,gBAAgC;EAAE,OAAO,ENsC1B,GAAO;;;AMrCtB;mBACmC;EAAE,OAAO,EN+N1B,GAAO;;;AM9NzB;kBACkC;EAAE,OAAO,ENyB1B,GAAO;;;AMxBxB,oBAAoC;EAAE,OAAO,EN8J1B,GAAO;;;AM7J1B;mBACmC;EAAE,OAAO,ENiC1B,GAAO;;;AMhCzB,iBAAiC;EAAE,OAAO,ENkQ1B,GAAO;;;AMjQvB;;eAE+B;EAAE,OAAO,EN9I1B,GAAO;;;AM+IrB,kBAAkC;EAAE,OAAO,ENiH1B,GAAO;;;AMhHxB,kBAAkC;EAAE,OAAO,EN+G1B,GAAO;;;AM9GxB,wBAAwC;EAAE,OAAO,EN4Q1B,GAAO;;;AM3Q9B,oBAAoC;EAAE,OAAO,ENgU1B,GAAO;;;AM/T1B,gBAAgC;EAAE,OAAO,ENkR1B,GAAO;;;AMjRtB,gBAAgC;EAAE,OAAO,ENmH1B,GAAO;;;AMlHtB,gBAAgC;EAAE,OAAO,ENmT1B,GAAO;;;AMlTtB,oBAAoC;EAAE,OAAO,ENgK1B,GAAO;;;AM/J1B,2BAA2C;EAAE,OAAO,ENgK1B,GAAO;;;AM/JjC,6BAA6C;EAAE,OAAO,EN8C1B,GAAO;;;AM7CnC,sBAAsC;EAAE,OAAO,EN4C1B,GAAO;;;AM3C5B,gBAAgC;EAAE,OAAO,ENgI1B,GAAO;;;AM/HtB,0EAAqC;EAAE,OAAO,ENxH1B,GAAO;;;AMyH3B,mBAAmC;EAAE,OAAO,ENlH1B,GAAO;;;AMmHzB,qBAAqC;EAAE,OAAO,ENzH1B,GAAO;;;AM0H3B,sBAAsC;EAAE,OAAO,ENzH1B,GAAO;;;AM0H5B,kBAAkC;EAAE,OAAO,EN3E1B,GAAO;;;AM4ExB;eAC+B;EAAE,OAAO,EN4N1B,GAAO;;;AM3NrB;oBACoC;EAAE,OAAO,ENgO1B,GAAO;;;AM/N1B;mBACmC;EAAE,OAAO,EN6N1B,GAAO;;;AM5NzB,mBAAmC;EAAE,OAAO,EN/C1B,GAAO;;;AMgDzB,mBAAmC;EAAE,OAAO,ENmF1B,GAAO;;;AMlFzB;eAC+B;EAAE,OAAO,EN0S1B,GAAO;;;AMzSrB;gBACgC;EAAE,OAAO,ENW1B,GAAO;;;AMVtB;qBACqC;EAAE,OAAO,EN0P1B,GAAO;;;AMzP3B,oBAAoC;EAAE,OAAO,ENxF1B,GAAO;;;AMyF1B,qBAAqC;EAAE,OAAO,ENvF1B,GAAO;;;AMwF3B;eAC+B;EAAE,OAAO,ENlK1B,GAAO;;;AMmKrB,kBAAkC;EAAE,OAAO,ENoM1B,GAAO;;;AMnMxB,mBAAmC;EAAE,OAAO,EN8R1B,GAAO;;;AM7RzB;oBACoC;EAAE,OAAO,EN9G1B,GAAO;;;AM+G1B,sBAAsC;EAAE,OAAO,ENiE1B,GAAO;;;AMhE5B,mBAAmC;EAAE,OAAO,EN1D1B,GAAO;;;AM2DzB,yBAAyC;EAAE,OAAO,EN7G1B,GAAO;;;AM8G/B,uBAAuC;EAAE,OAAO,EN7G1B,GAAO;;;AM8G7B,kBAAkC;EAAE,OAAO,ENkS1B,GAAO;;;AMjSxB,sBAAsC;EAAE,OAAO,ENgO1B,GAAO;;;AM/N5B,mBAAmC;EAAE,OAAO,ENqO1B,GAAO;;;AMpOzB,iBAAiC;EAAE,OAAO,ENxL1B,GAAO;;;AMyLvB,iBAAiC;EAAE,OAAO,EN7G1B,GAAO;;;AM8GvB,kBAAkC;EAAE,OAAO,EN3F1B,GAAO;;;AM4FxB,sBAAsC;EAAE,OAAO,ENpC1B,GAAO;;;AMqC5B,qBAAqC;EAAE,OAAO,ENzK1B,GAAO;;;AM0K3B,qBAAqC;EAAE,OAAO,ENqB1B,GAAO;;;AMpB3B,oBAAoC;EAAE,OAAO,EN3O1B,GAAO;;;AM4O1B,iBAAiC;EAAE,OAAO,EN4E1B,GAAO;;;AM3EvB,sBAAsC;EAAE,OAAO,ENxD1B,GAAO;;;AMyD5B,eAA+B;EAAE,OAAO,ENrM1B,GAAO;;;AMsMrB,mBAAmC;EAAE,OAAO,ENG1B,GAAO;;;AMFzB,sBAAsC;EAAE,OAAO,ENuH1B,GAAO;;;AMtH5B,4BAA4C;EAAE,OAAO,EN5O1B,GAAO;;;AM6OlC,6BAA6C;EAAE,OAAO,EN5O1B,GAAO;;;AM6OnC,0BAA0C;EAAE,OAAO,EN5O1B,GAAO;;;AM6OhC,4BAA4C;EAAE,OAAO,ENhP1B,GAAO;;;AMiPlC,qBAAqC;EAAE,OAAO,EN5O1B,GAAO;;;AM6O3B,sBAAsC;EAAE,OAAO,EN5O1B,GAAO;;;AM6O5B,mBAAmC;EAAE,OAAO,EN5O1B,GAAO;;;AM6OzB,qBAAqC;EAAE,OAAO,ENhP1B,GAAO;;;AMiP3B,kBAAkC;EAAE,OAAO,ENxG1B,GAAO;;;AMyGxB,iBAAiC;EAAE,OAAO,ENyB1B,GAAO;;;AMxBvB,iBAAiC;EAAE,OAAO,ENmN1B,GAAO;;;AMlNvB;iBACiC;EAAE,OAAO,ENmE1B,GAAO;;;AMlEvB,mBAAmC;EAAE,OAAO,ENlJ1B,GAAO;;;AMmJzB,qBAAqC;EAAE,OAAO,ENiH1B,GAAO;;;AMhH3B,sBAAsC;EAAE,OAAO,ENiH1B,GAAO;;;AMhH5B,kBAAkC;EAAE,OAAO,ENiL1B,GAAO;;;AMhLxB,iBAAiC;EAAE,OAAO,ENvJ1B,GAAO;;;AMwJvB;gBACgC;EAAE,OAAO,ENyH1B,GAAO;;;AMxHtB,qBAAqC;EAAE,OAAO,EN9B1B,GAAO;;;AM+B3B,mBAAmC;EAAE,OAAO,ENjD1B,GAAO;;;AMkDzB,wBAAwC;EAAE,OAAO,ENhD1B,GAAO;;;AMiD9B,kBAAkC;EAAE,OAAO,EN2J1B,GAAO;;;AM1JxB,kBAAkC;EAAE,OAAO,EN9C1B,GAAO;;;AM+CxB,gBAAgC;EAAE,OAAO,EN+C1B,GAAO;;;AM9CtB,kBAAkC;EAAE,OAAO,EN9C1B,GAAO;;;AM+CxB,qBAAqC;EAAE,OAAO,ENI1B,GAAO;;;AMH3B,iBAAiC;EAAE,OAAO,EN9D1B,GAAO;;;AM+DvB,yBAAyC;EAAE,OAAO,ENhE1B,GAAO;;;AMiE/B,mBAAmC;EAAE,OAAO,ENsM1B,GAAO;;;AMrMzB,eAA+B;EAAE,OAAO,EN1J1B,GAAO;;;AM2JrB;oBACoC;EAAE,OAAO,EN4G1B,GAAO;;;AM3G1B;;sBAEsC;EAAE,OAAO,ENwK1B,GAAO;;;AMvK5B,yBAAyC;EAAE,OAAO,ENmB1B,GAAO;;;AMlB/B,eAA+B;EAAE,OAAO,ENjJ1B,GAAO;;;AMkJrB,oBAAoC;EAAE,OAAO,ENjK1B,GAAO;;;AMkK1B;uBACuC;EAAE,OAAO,EN9L1B,GAAO;;;AM+L7B,mBAAmC;EAAE,OAAO,ENmF1B,GAAO;;;AMlFzB,eAA+B;EAAE,OAAO,ENvB1B,GAAO;;;AMwBrB,sBAAsC;EAAE,OAAO,ENvH1B,GAAO;;;AMwH5B,sBAAsC;EAAE,OAAO,EN6K1B,GAAO;;;AM5K5B,oBAAoC;EAAE,OAAO,ENyK1B,GAAO;;;AMxK1B,iBAAiC;EAAE,OAAO,EN9H1B,GAAO;;;AM+HvB,uBAAuC;EAAE,OAAO,EN0E1B,GAAO;;;AMzE7B,qBAAqC;EAAE,OAAO,ENwB1B,GAAO;;;AMvB3B,2BAA2C;EAAE,OAAO,ENwB1B,GAAO;;;AMvBjC,iBAAiC;EAAE,OAAO,ENqH1B,GAAO;;;AMpHvB,qBAAqC;EAAE,OAAO,EN9N1B,GAAO;;;AM+N3B,4BAA4C;EAAE,OAAO,EN1F1B,GAAO;;;AM2FlC,iBAAiC;EAAE,OAAO,EN2F1B,GAAO;;;AM1FvB,iBAAiC;EAAE,OAAO,ENc1B,GAAO;;;AMbvB,8BAA8C;EAAE,OAAO,ENtM1B,GAAO;;;AMuMpC,+BAA+C;EAAE,OAAO,ENtM1B,GAAO;;;AMuMrC,4BAA4C;EAAE,OAAO,ENtM1B,GAAO;;;AMuMlC,8BAA8C;EAAE,OAAO,EN1M1B,GAAO;;;AM2MpC,gBAAgC;EAAE,OAAO,EN7C1B,GAAO;;;AM8CtB,eAA+B;EAAE,OAAO,ENtK1B,GAAO;;;AMuKrB,iBAAiC;EAAE,OAAO,EN9S1B,GAAO;;;AM+SvB,qBAAqC;EAAE,OAAO,EN+M1B,GAAO;;;AM9M3B,mBAAmC;EAAE,OAAO,EN/O1B,GAAO;;;AMgPzB,qBAAqC;EAAE,OAAO,ENtJ1B,GAAO;;;AMuJ3B,qBAAqC;EAAE,OAAO,ENtJ1B,GAAO;;;AMuJ3B,qBAAqC;EAAE,OAAO,ENmF1B,GAAO;;;AMlF3B,sBAAsC;EAAE,OAAO,EN6C1B,GAAO;;;AM5C5B,iBAAiC;EAAE,OAAO,EN0K1B,GAAO;;;AMzKvB,uBAAuC;EAAE,OAAO,ENO1B,GAAO;;;AMN7B,4IAAyC;EAAE,OAAO,ENO1B,GAAO;;;AMN/B,mBAAmC;EAAE,OAAO,EN/B1B,GAAO;;;AMgCzB,qBAAqC;EAAE,OAAO,ENjC1B,GAAO;;;AMkC3B,uBAAuC;EAAE,OAAO,EN3N1B,GAAO;;;AM4N7B,wBAAwC;EAAE,OAAO,ENyB1B,GAAO;;;AMxB9B,+BAA+C;EAAE,OAAO,ENlJ1B,GAAO;;;AMmJrC,uBAAuC;EAAE,OAAO,ENuF1B,GAAO;;;AMtF7B,kBAAkC;EAAE,OAAO,EN9L1B,GAAO;;;AM+LxB;8BAC8C;EAAE,OAAO,ENnP1B,GAAO;;;AMoPpC;4BAC4C;EAAE,OAAO,ENlP1B,GAAO;;;AMmPlC;+BAC+C;EAAE,OAAO,ENrP1B,GAAO;;;AMsPrC;cAC8B;EAAE,OAAO,ENpK1B,GAAO;;;AMqKpB,cAA8B;EAAE,OAAO,ENzG1B,GAAO;;;AM0GpB;cAC8B;EAAE,OAAO,ENwL1B,GAAO;;;AMvLpB;cAC8B;EAAE,OAAO,ENrE1B,GAAO;;;AMsEpB;;;cAG8B;EAAE,OAAO,ENnE1B,GAAO;;;AMoEpB;;cAE8B;EAAE,OAAO,ENqD1B,GAAO;;;AMpDpB;cAC8B;EAAE,OAAO,ENpE1B,GAAO;;;AMqEpB;cAC8B;EAAE,OAAO,EN1R1B,GAAO;;;AM2RpB,eAA+B;EAAE,OAAO,ENlK1B,GAAO;;;AMmKrB,oBAAoC;EAAE,OAAO,ENtJ1B,GAAO;;;AMuJ1B,yBAAyC;EAAE,OAAO,EN4E1B,GAAO;;;AM3E/B,0BAA0C;EAAE,OAAO,EN4E1B,GAAO;;;AM3EhC,0BAA0C;EAAE,OAAO,EN4E1B,GAAO;;;AM3EhC,2BAA2C;EAAE,OAAO,EN4E1B,GAAO;;;AM3EjC,2BAA2C;EAAE,OAAO,EN+E1B,GAAO;;;AM9EjC,4BAA4C;EAAE,OAAO,EN+E1B,GAAO;;;AM9ElC,oBAAoC;EAAE,OAAO,EN+H1B,GAAO;;;AM9H1B,sBAAsC;EAAE,OAAO,EN2H1B,GAAO;;;AM1H5B,yBAAyC;EAAE,OAAO,EN4L1B,GAAO;;;AM3L/B,kBAAkC;EAAE,OAAO,ENyL1B,GAAO;;;AMxLxB,eAA+B;EAAE,OAAO,ENmL1B,GAAO;;;AMlLrB,sBAAsC;EAAE,OAAO,ENmL1B,GAAO;;;AMlL5B,uBAAuC;EAAE,OAAO,ENuL1B,GAAO;;;AMtL7B,kBAAkC;EAAE,OAAO,EN/M1B,GAAO;;;AMgNxB,yBAAyC;EAAE,OAAO,ENgF1B,GAAO;;;AM/E/B,oBAAoC;EAAE,OAAO,ENjG1B,GAAO;;;AMkG1B,iBAAiC;EAAE,OAAO,ENxJ1B,GAAO;;;AMyJvB,cAA8B;EAAE,OAAO,ENhX1B,GAAO;;;AMiXpB,4CAAoC;EAAE,OAAO,ENzT1B,GAAO;;;AM0T1B,2BAA2C;EAAE,OAAO,ENzT1B,GAAO;;;AM0TjC,iBAAiC;EAAE,OAAO,ENqI1B,GAAO;;;AMpIvB,wBAAwC;EAAE,OAAO,ENqI1B,GAAO;;;AMpI9B,0BAA0C;EAAE,OAAO,ENrE1B,GAAO;;;AMsEhC,wBAAwC;EAAE,OAAO,ENnE1B,GAAO;;;AMoE9B,0BAA0C;EAAE,OAAO,ENtE1B,GAAO;;;AMuEhC,2BAA2C;EAAE,OAAO,ENtE1B,GAAO;;;AMuEjC,gBAAgC;EAAE,OAAO,ENxW1B,GAAO;;;AMyWtB,kBAAkC;EAAE,OAAO,EN8J1B,GAAO;;;AM7JxB,kBAAkC;EAAE,OAAO,ENpX1B,GAAO;;;AMqXxB,gBAAgC;EAAE,OAAO,ENnF1B,GAAO;;;AMoFtB,mBAAmC;EAAE,OAAO,ENjO1B,GAAO;;;AMkOzB,gBAAgC;EAAE,OAAO,ENsC1B,GAAO;;;AMrCtB,qBAAqC;EAAE,OAAO,ENhK1B,GAAO;;;AMiK3B,iBAAiC;EAAE,OAAO,ENmH1B,GAAO;;;AMlHvB,iBAAiC;EAAE,OAAO,ENxM1B,GAAO;;;AMyMvB,eAA+B;EAAE,OAAO,ENzE1B,GAAO;;;AM0ErB,iBAAiC;EAAE,OAAO,ENrJ1B,GAAO;;;AMsJvB,gBAAgC;EAAE,OAAO,EN2E1B,GAAO;;;AM1EtB,iBAAiC;EAAE,OAAO,EN7D1B,GAAO;;;AM8DvB,kBAAkC;EAAE,OAAO,ENpX1B,GAAO;;;AMqXxB,cAA8B;EAAE,OAAO,ENpU1B,GAAO;;;AMqUpB,aAA6B;EAAE,OAAO,ENsI1B,GAAO;;;AMrInB,gBAAgC;EAAE,OAAO,EN2I1B,GAAO;;;AM1ItB,iBAAiC;EAAE,OAAO,ENX1B,GAAO;;;AMYvB,oBAAoC;EAAE,OAAO,EN5D1B,GAAO;;;AM6D1B,yBAAyC;EAAE,OAAO,ENgD1B,GAAO;;;AM/C/B,+BAA+C;EAAE,OAAO,ENrX1B,GAAO;;;AMsXrC,8BAA8C;EAAE,OAAO,ENvX1B,GAAO;;;AMwXpC;8BAC8C;EAAE,OAAO,EN5T1B,GAAO;;;AM6TpC,uBAAuC;EAAE,OAAO,ENvP1B,GAAO;;;AMwP7B,qBAAqC;EAAE,OAAO,ENoI1B,GAAO;;;AMnI3B,uBAAuC;EAAE,OAAO,ENyH1B,GAAO;;;AMxH7B;cAC8B;EAAE,OAAO,ENiG1B,GAAO;;;AMhGpB,yEAAwC;EAAE,OAAO,ENzC1B,GAAO;;;AM0C9B,wBAAwC;EAAE,OAAO,EN+B1B,GAAO;;;AM9B9B,gBAAgC;EAAE,OAAO,ENa1B,GAAO;;;AMZtB,0BAA0C;EAAE,OAAO,ENnP1B,GAAO;;;AMoPhC,oBAAoC;EAAE,OAAO,ENgI1B,GAAO;;;AM/H1B,iBAAiC;EAAE,OAAO,EN9E1B,GAAO;;;AM+EvB;;qBAEqC;EAAE,OAAO,ENmG1B,GAAO;;;AMlG3B;yBACyC;EAAE,OAAO,EN3K1B,GAAO;;;AM4K/B,gBAAgC;EAAE,OAAO,EN6H1B,GAAO;;;AM5HtB,iBAAiC;EAAE,OAAO,ENjL1B,GAAO;;;AMkLvB,iBAAiC;EAAE,OAAO,ENxC1B,GAAO;;;AMyCvB,wBAAwC;EAAE,OAAO,ENxC1B,GAAO;;;AMyC9B,6BAA6C;EAAE,OAAO,ENuC1B,GAAO;;;AMtCnC,sBAAsC;EAAE,OAAO,ENqC1B,GAAO;;;AMpC5B,oBAAoC;EAAE,OAAO,ENlR1B,GAAO;;;AMmR1B,eAA+B;EAAE,OAAO,ENhR1B,GAAO;;;AMiRrB,qBAAqC;EAAE,OAAO,ENxE1B,GAAO;;;AMyE3B,yBAAyC;EAAE,OAAO,ENxE1B,GAAO;;;AMyE/B,iBAAiC;EAAE,OAAO,EN7Q1B,GAAO;;;AM8QvB,iBAAiC;EAAE,OAAO,EN3J1B,GAAO;;;AM4JvB,mBAAmC;EAAE,OAAO,ENtJ1B,GAAO;;;AMuJzB,cAA8B;EAAE,OAAO,ENtP1B,GAAO;;;AMuPpB,mBAAmC;EAAE,OAAO,EN3W1B,GAAO;;;AM4WzB,gBAAgC;EAAE,OAAO,ENjU1B,GAAO;;;AMkUtB,cAA8B;EAAE,OAAO,EN1F1B,GAAO;;;AM2FpB,gBAAgC;EAAE,OAAO,ENM1B,GAAO;;;AMLtB,eAA+B;EAAE,OAAO,ENrS1B,GAAO;;;AMsSrB,gBAAgC;EAAE,OAAO,ENrS1B,GAAO;;;AMsStB,kBAAkC;EAAE,OAAO,ENtY1B,GAAO;;;AMuYxB,yBAAyC;EAAE,OAAO,ENtY1B,GAAO;;;AMuY/B,gBAAgC;EAAE,OAAO,ENa1B,GAAO;;;AMZtB,uBAAuC;EAAE,OAAO,ENa1B,GAAO;;;AMZ7B,kBAAkC;EAAE,OAAO,EN/D1B,GAAO;;;AMgExB;cAC8B;EAAE,OAAO,EN5W1B,GAAO;;;AM6WpB;eAC+B;EAAE,OAAO,EN2B1B,GAAO;;;AM1BrB,eAA+B;EAAE,OAAO,ENoD1B,GAAO;;;AMnDrB,kBAAkC;EAAE,OAAO,ENN1B,GAAO;;;AMOxB,qBAAqC;EAAE,OAAO,ENzS1B,GAAO;;;AM0S3B,qBAAqC;EAAE,OAAO,ENZ1B,GAAO;;;AMa3B,mBAAmC;EAAE,OAAO,EN/S1B,GAAO;;;AMgTzB,qBAAqC;EAAE,OAAO,ENhQ1B,GAAO;;;AMiQ3B,sBAAsC;EAAE,OAAO,ENzP1B,GAAO;;;AM0P5B,uBAAuC;EAAE,OAAO,ENtQ1B,GAAO;;;AMuQ7B,4BAA4C;EAAE,OAAO,ENhQ1B,GAAO;;;AMiQlC;;uBAEuC;EAAE,OAAO,ENzQ1B,GAAO;;;AM0Q7B;yBACyC;EAAE,OAAO,EN/Q1B,GAAO;;;AMgR/B;uBACuC;EAAE,OAAO,ENhR1B,GAAO;;;AMiR7B;uBACuC;EAAE,OAAO,ENrQ1B,GAAO;;;AMsQ7B,sBAAsC;EAAE,OAAO,ENlR1B,GAAO;;;AMmR5B,eAA+B;EAAE,OAAO,EN4D1B,GAAO;;;AM3DrB,kBAAkC;EAAE,OAAO,ENrV1B,GAAO;;;AMsVxB,mBAAmC;EAAE,OAAO,ENhM1B,GAAO;;;AMiMzB;;;;oBAIoC;EAAE,OAAO,ENtL1B,GAAO;;;AMuL1B,yBAAyC;EAAE,OAAO,ENvW1B,GAAO;;;AMwW/B;gBACgC;EAAE,OAAO,ENlG1B,GAAO;;;AMmGtB;iBACiC;EAAE,OAAO,EN1T1B,GAAO;;;AM2TvB,qBAAqC;EAAE,OAAO,ENpP1B,GAAO;;;AMqP3B,cAA8B;EAAE,OAAO,ENtP1B,GAAO;;;AMuPpB,sBAAsC;EAAE,OAAO,ENxO1B,GAAO;;;AMyO5B,wBAAwC;EAAE,OAAO,ENR1B,GAAO;;;AMS9B,aAA6B;EAAE,OAAO,ENjH1B,GAAO;;;AMkHnB;iBACiC;EAAE,OAAO,ENiD1B,GAAO;;;AMhDvB;sBACsC;EAAE,OAAO,ENrJ1B,GAAO;;;AMsJ5B;wBACwC;EAAE,OAAO,ENtJ1B,GAAO;;;AMuJ9B,kBAAkC;EAAE,OAAO,ENvO1B,GAAO;;;AMwOxB,sBAAsC;EAAE,OAAO,ENvX1B,GAAO;;;AMwX5B,iBAAiC;EAAE,OAAO,EN7O1B,GAAO;;;AM8OvB,oBAAoC;EAAE,OAAO,ENxJ1B,GAAO;;;AMyJ1B,kBAAkC;EAAE,OAAO,ENvE1B,GAAO;;;AMwExB,oBAAoC;EAAE,OAAO,ENtF1B,GAAO;;;AMuF1B,2BAA2C;EAAE,OAAO,ENtF1B,GAAO;;;AMuFjC,eAA+B;EAAE,OAAO,ENnb1B,GAAO;;;AMobrB;mBACmC;EAAE,OAAO,ENjR1B,GAAO;;;AMkRzB,cAA8B;EAAE,OAAO,ENI1B,GAAO;;;AMHpB,qBAAqC;EAAE,OAAO,EN9b1B,GAAO;;;AM+b3B,eAA+B;EAAE,OAAO,EN5I1B,GAAO;;;AM6IrB,qBAAqC;EAAE,OAAO,EN/E1B,GAAO;;;AMgF3B,iBAAiC;EAAE,OAAO,ENI1B,GAAO;;;AMHvB,eAA+B;EAAE,OAAO,ENuC1B,GAAO;;;AMtCrB,sBAAsC;EAAE,OAAO,EN7K1B,GAAO;;;AM8K5B,eAA+B;EAAE,OAAO,EN6B1B,GAAO;;;AM5BrB,qBAAqC;EAAE,OAAO,ENjb1B,GAAO;;;AMkb3B,iBAAiC;EAAE,OAAO,ENpK1B,GAAO;;;AMqKvB,wBAAwC;EAAE,OAAO,ENzQ1B,GAAO;;;AM0Q9B,kBAAkC;EAAE,OAAO,ENha1B,GAAO;;;AMiaxB,wBAAwC;EAAE,OAAO,ENpa1B,GAAO;;;AMqa9B,sBAAsC;EAAE,OAAO,ENta1B,GAAO;;;AMua5B,kBAAkC;EAAE,OAAO,ENxa1B,GAAO;;;AMyaxB,oBAAoC;EAAE,OAAO,ENta1B,GAAO;;;AMua1B,oBAAoC;EAAE,OAAO,ENta1B,GAAO;;;AMua1B,qBAAqC;EAAE,OAAO,ENjd1B,GAAO;;;AMkd3B,uBAAuC;EAAE,OAAO,ENjd1B,GAAO;;;AMkd7B,gBAAgC;EAAE,OAAO,ENtB1B,GAAO;;;AMuBtB,oBAAoC;EAAE,OAAO,EN9X1B,GAAO;;;AM+X1B,aAA6B;EAAE,OAAO,ENne1B,GAAO;;;AMoenB,qBAAqC;EAAE,OAAO,ENtV1B,GAAO;;;AMuV3B,sBAAsC;EAAE,OAAO,EN1L1B,GAAO;;;AM2L5B,wBAAwC;EAAE,OAAO,ENpd1B,GAAO;;;AMqd9B,qBAAqC;EAAE,OAAO,ENzf1B,GAAO;;;AM0f3B,oBAAoC;EAAE,OAAO,EN7K1B,GAAO;;;AM8K1B,qBAAqC;EAAE,OAAO,ENzO1B,GAAO;;;AM0O3B,iBAAiC;EAAE,OAAO,ENtP1B,GAAO;;;AMuPvB,wBAAwC;EAAE,OAAO,ENtP1B,GAAO;;;AMuP9B,qBAAqC;EAAE,OAAO,ENrC1B,GAAO;;;AMsC3B,oBAAoC;EAAE,OAAO,ENrC1B,GAAO;;;AMsC1B,kBAAkC;EAAE,OAAO,EN9d1B,GAAO;;;AM+dxB,cAA8B;EAAE,OAAO,EN5c1B,GAAO;;;AM6cpB,kBAAkC;EAAE,OAAO,ENtQ1B,GAAO;;;AMuQxB,oBAAoC;EAAE,OAAO,EN9gB1B,GAAO;;;AM+gB1B,aAA6B;EAAE,OAAO,EN/b1B,GAAO;;;AMgcnB;;cAE8B;EAAE,OAAO,ENpR1B,GAAO;;;AMqRpB,mBAAmC;EAAE,OAAO,EN/N1B,GAAO;;;AOtUzB,4xBAAK;EACH,WAAW,EAAE,OAAO;;AACpB,+6BAAQ;EACN,WAAW,EC+BuB,aAAa;ED9B/C,OAAO,EAAE,YAAY;EACrB,UAAU,EAAE,MAAM;EAClB,WAAW,EAAE,MAAM;EACnB,WAAW,EAAE,CAAC;EACd,eAAe,EAAE,OAAO;;;AAM5B,28BAAkB;EAChB,OAAO,EAAE,YAAY;EACrB,eAAe,EAAE,OAAO;;;AAGxB,syEAAgB;EACd,OAAO,EAAE,MAAM;;AACf,8zEAAuB;EACrB,WAAW,EAAE,KAAI;;AACnB,0wEAAsB;EACpB,OAAO,EAAE,YAAY;;;AAE3B,wjBAA2B;EACzB,OAAO,EAAE,GAAE;EfpBL,kBAAoB,EAAE,qBAAM;EAK5B,eAAiB,EAAE,qBAAM;EAezB,UAAY,EAAE,qBAAM;;;AeE5B,4oBAAiC;EAC/B,OAAO,EAAE,CAAC;;;AAGV,4uCAAuB;EACrB,SAAS,EAAE,IAAI;EACf,cAAc,EAAE,IAAI;;;AEpBxB,qQAAS;EACP,OAAO,EAAE,IAAqB;EAC9B,WAAW,EDayB,IAAI;ECZxC,aAAa,EDYuB,IAAI;ECXxC,UAAU,EAAE,OAAmB;;;AAEjC,+CAAe;EACb,KAAK,EDkC+B,IAAM;ECjC1C,WAAW,EAAE,IAAI;EACjB,OAAO,EAAE,KAAK;EACd,KAAK,ED+B+B,IAAM;EC9B1C,UAAU,EAAE,OAAkB;EAC9B,MAAM,EAAE,KAAsB;EAC9B,OAAO,EAAE,QAA2C;EACpD,aAAa,EAAE,IAAqB;;;AAEtC,qaAAyB;EACvB,UAAU,EAAE,OAAkB;;AAC9B,2yCAAe;EACb,UAAU,EAAE,OAAiB;;;AACjC,6YAA0B;EACxB,UAAU,EAAE,OAAmB;;AAC/B,4vCAAe;EACb,UAAU,EAAE,OAAoB;;;AAEpC,iZAAuB;EACrB,UAAU,EAAE,OAAmB;;AAC/B,iwCAAe;EACb,UAAU,EAAE,OAAkB;;;AAElC,8ZAA0B;EACxB,UAAU,EAAE,OAAuB;;AACnC,8xCAAe;EACb,UAAU,EAAE,OAAqB;;;AAErC,idAA0B;EACxB,UAAU,EDmB0B,OAAmB;;AClBvD,o4CAAe;EACb,KAAK,ECjD6B,OAAW;EDkD7C,UAAU,EDJwB,OAAmB;;ACKvD,yeAAC;EACC,KAAK,EDsB6B,OAAW;;;ACpBjD,iaAAsB;EACpB,aAAa,EAAE,CAAC;;;AAsBlB,kBAAkB;EAChB,QAAQ,EAAE,KAAK;EACf,MAAM,EAAE,GAAG;EACX,IAAI,EAAE,CAAC;EACP,OAAO,EDG6B,GAAG;;ACFvC,qBAAE;EACA,OAAO,EAAE,KAAK;EACd,KAAK,EDT6B,KAAK;ECUvC,UAAU,EAAE,WAAW;EACvB,KAAK,EDlC6B,IAAM;ECmCxC,UAAU,EAAE,MAAM;EAClB,UAAU,EAAE,8BAA0B;EACtC,OAAO,EAAE,MAAmB;EAC5B,SAAS,EAAE,GAAG;EACd,OAAO,EAAE,CAAC;EACV,MAAM,EAAE,CAAC;EACT,WAAW,EAAE,IAAI;EACjB,QAAQ,EAAE,MAAM;EjB3FZ,kBAAoB,EAAE,gBAAM;EAK5B,eAAiB,EAAE,gBAAM;EAezB,UAAY,EAAE,gBAAM;;AiByExB,0CAAsB;EACpB,UAAU,EDhCsB,OAAM;;ACiCxC,uCAAmB;EACjB,UAAU,EDzBsB,OAAW;;AC0B7C,0CAAsB;EACpB,UAAU,EDnFsB,OAAO;;ACoFzC,yCAAqB;EACnB,UAAU,EDtEsB,OAAI;;ACuEtC,wBAAI;EACF,OAAO,EAAE,CAAC;EACV,MAAM,EAAE,IAAI;;;AEhFd,oCAAsB;EFmFxB,kBAAkB;IAChB,MAAM,EAAE,IAAI;IACZ,GAAG,EAAE,CAAC;IACN,KAAK,EAAE,IAAI;;EACX,qBAAE;IACA,KAAK,EAAE,IAAI;;;AG3FjB,MAAM;EACJ,SAAS,EAAE,IAAI;EACf,MAAM,EAAE,CAAC;EACT,cAAc,EAAE,QAAQ;EACxB,eAAe,EAAE,MAAM;EACvB,MAAM,EAAE,OAAO;EACf,WAAW,EAAE,MAAM;EACnB,kBAAkB,EAAE,MAAM;EAC1B,SAAS,EAAE,OAAO;;;AACpB,iDAAiD;EAC/C,MAAM,EAAE,CAAC;EACT,OAAO,EAAE,CAAC;;;AACZ,gBAAgB;EACd,MAAM,EAAE,OAAO;;;AAEjB,IAAI;;EAEF,OAAO,EAAE,YAAY;EACrB,aAAa,EAAE,GAAG;EAClB,WAAW,EAAE,MAAM;EACnB,WAAW,EAAE,MAAM;EACnB,UAAU,EAAE,MAAM;EAClB,MAAM,EAAE,OAAO;EACf,SAAS,EAAE,IAAI;EACf,OAAO,EAAE,iBAA6F;EACtG,KAAK,EJI+B,IAAM;EIH1C,MAAM,EAAE,4BAAyB;EACjC,gBAAgB,EJeoB,OAAM;EId1C,eAAe,EAAE,IAAI;EACrB,WAAW,EAAE,MAAM;EACnB,WAAW,EFnDyB,2DAAM;EEoD1C,UAAU,EAAE,0FAA8C;EAC1D,YAAY,EAAE,KAAK;EACnB,cAAc,EAAE,MAAM;EACtB,QAAQ,EAAE,MAAM;EAChB,IAAI,EAAE,CAAC;EACP,iBAAiB,EAAE,IAAI;EpBxDjB,mBAAoB,EoByDb,IAAI;EpBpDX,gBAAiB,EoBoDV,IAAI;EpB/CX,eAAgB,EoB+CT,IAAI;EpBrCX,WAAY,EoBqCL,IAAI;EpBzDX,kBAAoB,EAAE,eAAM;EAK5B,eAAiB,EAAE,eAAM;EAezB,UAAY,EAAE,eAAM;;;AoByC5B,UAAU;EACR,UAAU,EAAE,OAAwB;EACpC,KAAK,EJd+B,IAAM;;;AIiB1C,UAAO;EACL,UAAU,EAAE,OAAqC;EACjD,KAAK,EJnB6B,IAAM;;AIoB1C,UAAO;EACL,UAAU,EAAE,OAAqC;EACjD,OAAO,EAAE,CAAC;;AACZ,WAAQ;EACN,UAAU,EAAE,oFAAyC;EACrD,OAAO,EAAE,iBAA6F;;AACxG,YAAS;EACP,KAAK,EJ3B6B,IAAM;;AI4B1C,aAAU;EACR,gBAAgB,EAAE,IAAI;EACtB,MAAM,EAAE,2DAA2D;EACnE,MAAM,EAAE,iBAAmB;EAC3B,OAAO,EAAE,GAAG;EACZ,MAAM,EAAE,WAAW;EACnB,UAAU,EAAE,IAAI;;;AAEpB,aAAa;EACX,gBAAgB,EAAE,IAAI;EACtB,MAAM,EAAE,2DAA2D;EACnE,MAAM,EAAE,iBAAmB;EAC3B,OAAO,EAAE,GAAG;EACZ,MAAM,EAAE,WAAW;EACnB,UAAU,EAAE,IAAI;;AAChB,8DAA0B;EACxB,gBAAgB,EAAE,IAAI;EACtB,MAAM,EAAE,2DAA2D;EACnE,MAAM,EAAE,iBAAmB;EAC3B,OAAO,EAAE,GAAI;EACb,MAAM,EAAE,WAAW;EACnB,UAAU,EAAE,IAAI;;;AAGpB,sBAAsB;EACpB,OAAO,EAAE,CAAC;EACV,MAAM,EAAE,CAAC;;;AAEX,UAAU;EACR,SAAS,EAAE,GAAG;;;AAEhB,SAAS;EACP,gBAAgB,EAAE,kBAAgB;;AAClC,eAAO;EACL,gBAAgB,EAAE,kBAA6B;;;AAEnD,YAAY;EACV,gBAAgB,EAAE,kBAA2C;EAC7D,KAAK,EAAE,kBAAsB;;AAC7B,kBAAO;EACL,gBAAgB,EAAE,kBAAuD;EACzE,KAAK,EFzH6B,OAAW;;AE0H/C,oBAAS;EACP,KAAK,EAAE,kBAAsB;;;AAEjC,YAAY;EACV,gBAAgB,EAAE,kBAAiB;;AACnC,kBAAO;EACL,gBAAgB,EAAE,kBAA6B;;;AAEnD,WAAW;EACT,gBAAgB,EAAE,kBAAe;;AACjC,iBAAO;EACL,gBAAgB,EAAE,kBAA4B;;;AAElD,YAAY;EACV,gBAAgB,EAAE,kBAAkB;;AACpC,kBAAO;EACL,gBAAgB,EAAE,kBAA+B;;;AACrD,WAAW;EACT,gBAAgB,EJvIoB,IAAI;;AIwIxC,iBAAO;EACL,gBAAgB,EAAE,kBAAoC;;;AAE1D,SAAS;EACP,gBAAgB,EAAE,sBAAsB;EACxC,KAAK,EJxE+B,OAAW;EIyE/C,UAAU,EAAE,IAAI;EAChB,YAAY,EAAE,sBAAsB;;AACpC,eAAO;EACL,gBAAgB,EAAE,sBAAsB;EACxC,KAAK,EAAE,kBAAoC;EAC3C,UAAU,EAAE,IAAI;;AAClB,gBAAQ;EACN,gBAAgB,EAAE,sBAAsB;EACxC,KAAK,EAAE,kBAAoC;EAC3C,UAAU,EAAE,IAAI;;AAClB,iBAAS;EACP,KAAK,EJnG6B,OAAO;;;AIqG7C,oCAAoC;EAClC,cAAc,EAAE,MAAM;;;AAExB,aAAa;EACX,aAAa,EJ1IuB,IAAI;EduExC,KAAK,EAAE,CAAC;;AACR,yCAAS;EAEP,OAAO,EAAE,KAAK;EACd,OAAO,EAAE,EAAE;;AACb,mBAAO;EACL,KAAK,EAAE,IAAI;;;AmB3Ff,YAAY;EACV,QAAQ,EAAE,QAAQ;EAClB,OAAO,EAAE,YAAY;;;AAIvB,qCAAqC;EACnC,OAAO,EAAE,KAAK;;;AAChB,iBAAiB;EACf,QAAQ,EAAE,QAAQ;EAClB,IAAI,EAAE,CAAC;EACP,OAAO,EAAE,IAAI;EACb,KAAK,EAAE,IAAI;EACX,GAAG,EAAE,IAAI;EACT,SAAS,EAAE,IAAI;EACf,UAAU,EL1B0B,OAAyB;EK2B7D,OAAO,ELmD6B,GAAG;EKlDvC,MAAM,EAAE,iBAAgC;EACxC,UAAU,EAAE,8BAA0B;EACtC,OAAO,EAAE,IAAqB;;AAC9B,0BAAQ;EACN,OAAO,EAAE,KAAK;EACd,KAAK,EAAE,IAAI;EACX,KAAK,EHnC6B,OAAW;EGoC7C,WAAW,EAAE,MAAM;EACnB,SAAS,EAAE,GAAG;EACd,OAAO,EAAE,MAAuB;EAChC,MAAM,EAAE,OAAO;;AACf,gCAAO;EACL,UAAU,ELiCsB,OAAW;EKhC3C,KAAK,ELU2B,IAAM;;AKT1C,8BAAY;EACV,UAAU,EAAE,iBAAgC;EAC5C,MAAM,EAAE,KAAuB;;AACjC,6BAAW;EACT,cAAc,EAAE,IAAqB;;AACrC,kDAAoB;EAClB,KAAK,EAAE,IAAI;;AACf,qCAAmB;EACjB,UAAU,EAAE,OAA4B;EACxC,cAAc,EAAE,SAAS;EACzB,WAAW,EAAE,GAAG;EAChB,SAAS,EAAE,GAAG;;AACd,2CAAO;EACL,UAAU,EAAE,OAA4B;;AAC1C,0CAAI;EACF,KAAK,ELN2B,IAAM;;;AKQ5C,6CAA6C;EAC3C,MAAM,EAAE,IAAI;EACZ,GAAG,EAAE,IAAI;EACT,IAAI,EAAE,IAAI;EACV,KAAK,EAAE,CAAC;;;AAGR,iDAAiB;EACf,UAAU,ELnEwB,OAAyB;EKoE3D,UAAU,EAAE,GAAG;;AACjB,mDAAmB;EACjB,OAAO,EAAE,QAA2C;;AACpD,yDAAO;EACL,UAAU,ELCsB,OAAW;EKA3C,KAAK,ELtB2B,IAAM;;;AKwB5C,+CAA+C;EAC7C,KAAK,EAAE,CAAC;EACR,IAAI,EAAE,IAAI;EACV,UAAU,EAAE,KAAK;;;AAGjB,yBAAQ;EACN,OAAO,EAAE,GAAG;EACZ,aAAa,EAAE,oBAA0B;EACzC,WAAW,EAAE,qBAAqB;EAClC,YAAY,EAAE,qBAAqB;EACnC,QAAQ,EAAE,QAAQ;EAClB,OAAO,EAAE,KAAK;EACd,GAAG,EAAE,IAAI;EACT,IAAI,EAAE,GAAG;EACT,WAAW,EAAE,IAAI;;AACnB,gDAA+B;EAC7B,IAAI,EAAE,IAAI;;;ACtEZ,uBAAM;EACJ,OAAO,EAAE,KAAK;;;AAEhB,oIAA+C;EAC7C,OAAO,EAAE,YAAY;EACrB,QAAQ,EAAE,MAAM;EAChB,KAAK,EAAE,CAAC;EACR,cAAc,EAAE,MAAM;;;AAItB,0CAAO;EACL,OAAO,EAAE,YAAY;EACrB,cAAc,EAAE,MAAM;EACtB,KAAK,EAAE,IAAI;EACX,MAAM,EAAE,YAA+C;EACvD,KAAK,EAAE,IAAI;;AACf,4BAAW;EACT,KAAK,EAAE,IAAI;;AACX,kCAAK;EACH,OAAO,EAAE,KAAK;;AAChB,mCAAM;EACJ,UAAU,EAAE,GAAqB;;;AAEvC,QAAQ;EACN,MAAM,EAAE,CAAC;EACT,MAAM,EAAE,CAAC;EACT,OAAO,EAAE,CAAC;;;AACZ,MAAM;EACJ,OAAO,EAAE,KAAK;EACd,KAAK,EAAE,IAAI;EACX,MAAM,EAAE,CAAC;EACT,OAAO,EAAE,CAAC;EACV,WAAW,EAAE,MAAM;EACnB,aAAa,EN/BuB,IAAI;EMgCxC,SAAS,EAAE,IAAI;EACf,YAAY,EAAE,IAAI;;;AACpB,KAAK;EACH,OAAO,EAAE,KAAK;EACd,MAAM,EAAE,cAAa;EACrB,KAAK,ENR+B,IAAU;EMS9C,SAAS,EAAE,GAAG;;;AAEhB,uBAAuB;EACrB,SAAS,EAAE,IAAI;EACf,MAAM,EAAE,CAAC;EACT,cAAc,EAAE,QAAQ;EACxB,eAAe,EAAE,MAAM;;;AAGzB,iBAAiB;EACf,aAAa,ENhDuB,IAAI;EduExC,KAAK,EAAE,CAAC;EqBrGR,SAAS,ECCC,IAAQ;EDChB,WAAI,EAAE,IAAI;EACV,YAAK,EAAE,IAAI;ErBkGb,KAAK,EAAE,CAAC;;AACR,iDAAS;EAEP,OAAO,EAAE,KAAK;EACd,OAAO,EAAE,EAAE;;AACb,uBAAO;EACL,KAAK,EAAE,IAAI;;AALb,iDAAS;EAEP,OAAO,EAAE,KAAK;EACd,OAAO,EAAE,EAAE;;AACb,uBAAO;EACL,KAAK,EAAE,IAAI;;;AoBzBf,yDAAyD;EACvD,OAAO,EAAE,IAAI;EACb,KAAK,EN/C+B,OAAI;;;AMoDxC,qGAA+C;EAC7C,cAAc,EAAE,IAAqB;;AACrC,0HAAM;EACJ,KAAK,EAAE,IAAI;;AAEX,mwEAAqP;EACnP,KAAK,EAAE,IAAI;;;AACnB,+BAA+B;EGlF3B,KAAK,EAAE,IAAsB;EAG3B,OAAO,EAAE,KAAK;EAed,YAAoB,EAAE,QAA+B;EACrD,KAAK,EAAE,IAAuC;ECnB5C,YAAoB,EAAE,CAAC;;ADqBzB,0CAAa;EACX,YAAoB,EAAE,CAAC;;;AHgE/B,iCAAiC;EGtF7B,KAAK,EAAE,IAAsB;EAG3B,OAAO,EAAE,KAAK;EAed,YAAoB,EAAE,QAA+B;EACrD,KAAK,EAAE,SAAuC;;AAE9C,4CAAa;EACX,YAAoB,EAAE,CAAC;;ACA7B,iDAAwB;EACtB,YAAoB,EAAE,CAAC;;AAEvB,mDAA0B;EACxB,KAAK,EALY,IAAkC;;;AJqEzD,iCAAiC;EG1F7B,KAAK,EAAE,IAAsB;EAG3B,OAAO,EAAE,KAAK;EAed,YAAoB,EAAE,QAA+B;EACrD,KAAK,EAAE,SAAuC;;AAE9C,4CAAa;EACX,YAAoB,EAAE,CAAC;;ACA7B,iDAAwB;EACtB,YAAoB,EAAE,CAAC;;AAEvB,mDAA0B;EACxB,KAAK,EALY,IAAkC;;;AJ0EzD,uDAAuD;EACrD,MAAM,EAAE,SAA2B;EACnC,SAAS,EAAE,GAAG;;;AAEhB,oBAAoB;EAClB,OAAO,EAAE,YAAY;EACrB,MAAM,EAAE,SAA2B;EACnC,SAAS,EAAE,GAAG;;;AAOZ,itBAAqP;EACnP,KAAK,EAAE,IAAI;;;AAIjB,uBAAuB;EACrB,OAAO,EAAE,YAAY;EACrB,YAAY,EAAE,KAAK;EACnB,KAAK,EAAE,IAAI;EACX,cAAc,EAAE,MAAM;EACtB,SAAS,EAAE,GAAG;;;AAEhB,gBAAgB;EACd,OAAO,EAAE,KAAK;EACd,KAAK,EN7H+B,IAAI;EM8HxC,SAAS,EAAE,GAAG;EACd,UAAU,EAAE,QAAO;EACnB,UAAU,EAAE,MAAM;;AAClB,kBAAC;EACC,SAAS,EAAE,OAAO;EAClB,UAAU,EAAE,MAAM;EAClB,aAAa,EAAE,GAAqB;;AACtC,6BAAY;EACV,aAAa,EAAE,CAAC;;;AA4DpB,KAAK;EACH,WAAW,EAAE,MAAM;;;AAGnB,+DAAmD;EACjD,kBAAkB,EAAE,MAAM;EAC1B,MAAM,EAAE,OAAO;EACf,WAAW,EJ/MuB,2DAAM;EIgNxC,SAAS,EAAE,OAAO;;AACpB,6SAAqP;EACnP,kBAAkB,EAAE,IAAI;EACxB,OAAO,EAAE,GAAqB;EAC9B,OAAO,EAAE,YAAY;EACrB,MAAM,EAAE,cAA6B;EACrC,SAAS,EAAE,GAAG;EACd,WAAW,EJvNuB,2DAAM;EIwNxC,UAAU,EAAE,oBAAmC;EAC/C,aAAa,EAAE,CAAC;EtBxNZ,kBAAoB,EAAE,kBAAM;EAK5B,eAAiB,EAAE,kBAAM;EAezB,UAAY,EAAE,kBAAM;;AsBuM1B,4BAAwB;EACtB,OAAO,EAAE,iBAAkB;;AAC7B,eAAW;EACT,MAAM,EAAE,OAAO;;AACjB,2CAAmC;EtB/N7B,kBAAoB,EsBgOZ,UAAU;EtB3NlB,eAAiB,EsB2NT,UAAU;EtB5MlB,UAAY,EsB4MJ,UAAU;EACtB,OAAO,EAAE,CAAC;EACV,YAAY,EAAE,QAAO;EACrB,OAAO,EAAE,IAAI;EACb,MAAM,EAAE,IAAI;;AACd,oBAAgB;EtBrOV,kBAAoB,EsBsOZ,UAAU;EtBjOlB,eAAiB,EsBiOT,UAAU;EtBlNlB,UAAY,EsBkNJ,UAAU;;AACtB,mGAA6D;EAC3D,kBAAkB,EAAE,IAAI;;AAC5B,iYAAyU;EACvU,OAAO,EAAE,CAAC;EACV,OAAO,EAAE,cAAc;EACvB,YAAY,ENxLsB,IAAU;;AMyL9C,oBAAgB;EACd,YAAY,EAAE,eAA8B;;AAC9C,iFAAqE;EACnE,OAAO,EAAE,gBAAsB;EAC/B,OAAO,EAAE,gBAAgB;;AAC3B,ybAAiY;EAC/X,MAAM,EAAE,WAAW;EACnB,gBAAgB,EAAE,OAAmC;;;AAEzD,iEAAiE;EAC/D,KAAK,ENzN+B,OAAI;EM0NxC,MAAM,EAAE,iBAAc;;;AACxB,mFAAmF;EACjF,YAAY,EN5NwB,OAAI;;;AM8NxC,2HAA+G;EAC7G,aAAa,EN/NqB,OAAI;;;AMiO1C,oBAAoB;EAClB,OAAO,EAAE,IAAqB;EAC9B,SAAS,EAAE,IAAI;;;AAKjB,QAAQ;EACN,QAAQ,EAAE,IAAI;EACd,cAAc,EAAE,GAAG;EACnB,KAAK,EAAE,IAAI;EACX,WAAW,EJ3QyB,2DAAM;;;AI4Q5C,gBAAgB;EACd,OAAO,EAAE,aAAgB;EACzB,OAAO,EAAE,YAAY;EACrB,MAAM,EAAE,cAA6B;EACrC,SAAS,EAAE,GAAG;EACd,UAAU,EAAE,oBAAmC;EtBhRzC,kBAAoB,EAAE,kBAAM;EAK5B,eAAiB,EAAE,kBAAM;EAezB,UAAY,EAAE,kBAAM;;;AsB+P5B,MAAM;EACJ,MAAM,EAAE,cAA6B;EACrC,gBAAgB,ENpOoB,IAAM;;AMqO1C,gBAAW;EACT,MAAM,EAAE,IAAI;;;AAChB,4BAA4B;EAC1B,OAAO,EAAE,CAAC;;;AACZ,2FAA2F;EACzF,MAAM,EAAE,WAAW;EACnB,gBAAgB,EAAE,OAAmC;;;AAKrD,+DAAuD;EACrD,MAAM,EAAE,WAAW;;;AACvB,uBAAuB;EACrB,MAAM,EAAE,KAAuB;EAE/B,KAAK,EJzS+B,OAAW;EI0S/C,OAAO,EAAE,KAAK;;AACd,mCAAK;EACH,cAAc,EAAE,QAAQ;;;AAI5B,uBAAuB;EACrB,OAAO,EAAE,YAAY;EACrB,QAAQ,EAAE,MAAM;EAChB,KAAK,EAAE,CAAC;EACR,cAAc,EAAE,MAAM;;;AAuBxB,kCAAkC;EAChC,WAAW,EAAE,MAAM;EACnB,OAAO,EAAE,GAAqB;;AAC9B,sEAAiB;EACf,WAAW,EAAE,IAAI;EACjB,OAAO,EAAE,KAAK;EACd,OAAO,EAAE,YAAY;EACrB,SAAS,EAAE,GAAG;EACd,gBAAgB,ENjRkB,OAAmB;EMkRrD,MAAM,EAAE,cAA6B;EACrC,KAAK,EN7U6B,IAAI;;;AM+U1C,kCAAkC;EAChC,WAAW,EAAE,CAAC;;;AAChB,kCAAkC;EAChC,YAAY,EAAE,CAAC;;;AAcjB,UAAU;EACR,KAAK,EAAE,IAAuB;EAC9B,MAAM,EAAE,IAAqB;EAC7B,MAAM,EAAE,MAAwB;EAChC,QAAQ,EAAE,QAAQ;EAClB,aAAa,EAAE,GAAG;EAClB,UAAU,ENrW0B,IAAI;EMsWxC,MAAM,EAAE,OAAO;EtB5WT,kBAAoB,EAAE,oBAAM;EAK5B,eAAiB,EAAE,oBAAM;EAezB,UAAY,EAAE,oBAAM;;AsB0V1B,iBAAQ;EACN,QAAQ,EAAE,QAAQ;EAClB,OAAO,EAAE,EAAE;EACX,OAAO,EAAE,KAAK;EACd,KAAK,EAAE,IAAI;EACX,MAAM,EAAE,IAAI;EACZ,aAAa,EAAE,GAAG;EAClB,UAAU,ENhXwB,IAAI;EMiXtC,IAAI,EAAE,IAAI;EACV,GAAG,EAAE,IAAI;EtBvXL,kBAAoB,EAAE,oBAAM;EAK5B,eAAiB,EAAE,oBAAM;EAezB,UAAY,EAAE,oBAAM;;AsBqW1B,gBAAO;EACL,OAAO,EAAE,OAAO;EAChB,QAAQ,EAAE,QAAQ;EAClB,IAAI,EAAE,IAAqB;EAC3B,OAAO,EAAE,KAAK;EACd,SAAS,EAAE,IAAI;EACf,KAAK,ENzX6B,IAAI;;;AM0X1C,iBAAiB;EACf,UAAU,EAAE,OAAmB;;AAC/B,wBAAQ;EACN,IAAI,EN5W8B,IAAI;EM6WtC,UAAU,ENtUwB,OAAM;;AMuU1C,uBAAO;EACL,OAAO,EAAE,MAAM;;;AAEnB,+CAA+C;EAC7C,MAAM,EAAE,WAAW;;;AAiDnB,2GAAyB;EACvB,KAAK,EN7Z6B,OAAI;;AM+ZtC,22BAAqP;EACnP,MAAM,EAAE,iBAAc;;AAC1B,iDAAQ;EACN,MAAM,EAAE,iBAAc;;;AAE1B,mBAAmB;EACjB,WAAW,EAAE,MAAM;;AACnB,qCAAiB;EACf,OAAO,EAAE,aAAgB;EACzB,OAAO,EAAE,YAAY;EACrB,SAAS,EAAE,GAAG;;;AAClB,gEAAgE;EAC9D,KAAK,EN3Y+B,OAAM;;;AM8Y5C,+DAA+D;EAC7D,KAAK,EN/a+B,OAAI;;;AMkb1C,gEAAgE;EAC9D,KAAK,ENlc+B,OAAO;;;AMqc7C,6DAA6D;EAC3D,KAAK,EN9Y+B,OAAW;;;AMoZjD,UAAU;EtB3dF,iBAAoB,EAAE,aAAM;EAK5B,cAAiB,EAAE,aAAM;EAKzB,aAAgB,EAAE,aAAM;EAKxB,YAAe,EAAE,aAAM;EAKvB,SAAY,EAAE,aAAM;;;AsByc5B,WAAW;EtB7dH,iBAAoB,EAAE,cAAM;EAK5B,cAAiB,EAAE,cAAM;EAKzB,aAAgB,EAAE,cAAM;EAKxB,YAAe,EAAE,cAAM;EAKvB,SAAY,EAAE,cAAM;;;AsB2c5B,WAAW;EtB/dH,iBAAoB,EAAE,cAAM;EAK5B,cAAiB,EAAE,cAAM;EAKzB,aAAgB,EAAE,cAAM;EAKxB,YAAe,EAAE,cAAM;EAKvB,SAAY,EAAE,cAAM;;;AsB6c5B,OAAO;EtBjeC,iBAAoB,EAAE,UAAM;EAK5B,cAAiB,EAAE,UAAM;EAKzB,aAAgB,EAAE,UAAM;EAKxB,YAAe,EAAE,UAAM;EAKvB,SAAY,EAAE,UAAM;;AsB+c1B,iBAAW;EtBneL,iBAAoB,EsBoeL,wBAAwB;EtB/dvC,cAAiB,EsB+dF,wBAAwB;EtB1dvC,aAAgB,EsB0dD,wBAAwB;EtBrdvC,YAAe,EsBqdA,wBAAwB;EtBhdvC,SAAY,EsBgdG,wBAAwB;;AAC7C,kBAAY;EtBreN,iBAAoB,EsBseL,yBAAyB;EtBjexC,cAAiB,EsBieF,yBAAyB;EtB5dxC,aAAgB,EsB4dD,yBAAyB;EtBvdxC,YAAe,EsBudA,yBAAyB;EtBldxC,SAAY,EsBkdG,yBAAyB;;AAC9C,kBAAY;EtBveN,iBAAoB,EsBweL,yBAAyB;EtBnexC,cAAiB,EsBmeF,yBAAyB;EtB9dxC,aAAgB,EsB8dD,yBAAyB;EtBzdxC,YAAe,EsBydA,yBAAyB;EtBpdxC,SAAY,EsBodG,yBAAyB;;;AAEhD,yCAAyC;EAErC,8BAAqB;IACnB,MAAM,EAAE,SAAS;;EAEjB,2aAAqP;IACnP,aAAa,EAAE,KAAK;IACpB,OAAO,EAAE,KAAK;;EAClB,cAAK;IACH,aAAa,EAAE,KAAK;IACpB,OAAO,EAAE,KAAK;;;EAEhB,8YAAqO;IACnO,aAAa,EAAE,CAAC;;;EAElB,wCAAuB;IACrB,aAAa,EAAE,KAAK;IACpB,UAAU,EAAE,IAAI;IAChB,OAAO,EAAE,KAAK;IACd,KAAK,EAAE,IAAI;;EACb,4BAAW;IACT,MAAM,EAAE,WAAW;;;EACvB,mEAAmE;IACjE,OAAO,EAAE,KAAK;IACd,SAAS,EAAE,GAAG;IACd,OAAO,EAAE,KAAuB;;;AH5ehC,oCAAsB;EQhC1B,YAAY;IAER,OAAO,EAAE,IAAI;;;;AR8Bb,oCAAsB;EQ5B1B,YAAY;IAER,OAAO,EAAE,IAAI;;;;AAEjB,WAAW;EACT,KAAK,EAAE,IAAI;;;AAEb,YAAY;EACV,KAAK,EAAE,KAAK;;;AAEd,WAAW;EACT,KAAK,EAAE,IAAI;;;AC4Cb,qEAAS;EACP,eAAe,EAAE,QAAQ;EACzB,cAAc,EAAE,CAAC;EACjB,WAAW,EAAE,IAAI;EACjB,aAAa,EZ/BuB,IAAI;;AYgCxC,6FAAO;EACL,KAAK,EAAE,IAAI;EACX,IAAI,EAAE,8BAAkB;EACxB,OAAO,EAAE,KAAK;EACd,UAAU,EAAE,MAAM;;AACpB,8JAAM;EACJ,SAAS,EZjByB,GAAG;EYkBrC,MAAM,EAAE,CAAC;EACT,QAAQ,EAAE,OAAO;EACjB,OAAO,EZnB2B,QAAmC;;AYoBvE,sOAA8B;EAC5B,iBAAiB,EAAE,CAAC;;AACtB,uFAAK;EACH,KAAK,EAAE,IAAI;EACX,UAAU,EAAE,IAAI;EAChB,cAAc,EAAE,MAAM;EACtB,WAAW,EAAE,MAAM;;AACnB,gGAAE;EACA,WAAW,EZnDqB,IAAI;EYoDpC,aAAa,EAAE,iBAA6B;;AAChD,8EAAE;EACA,gBAAgB,EAAE,WAAW;EAC7B,cAAc,EAAE,MAAM;;;AAE1B,oFAAc;EACZ,WAAW,EAAE,IAAuB;;AACpC,qHAAY;EACV,aAAa,EAAE,CAAC;;;AACpB,8HAA4B;EAC1B,KAAK,EAAE,EAAE;EACT,aAAa,EAAE,CAAC;;AAChB,4XAA0C;EACxC,MAAM,EAAE,CAAC;;;AAEb,mBAAmB;EACjB,KAAK,EZxD+B,IAAwB;EYyD5D,SAAS,EAAE,GAAG;;;AAChB,kBAAkB;EAChB,KAAK,EZ3D+B,IAAwB;EY4D5D,SAAS,EAAE,GAAG;;;AAIhB,6HAAyD;EACvD,gBAAgB,EZpCoB,OAAmB;;;AYsCzD,gBAAgB;EACd,gBAAgB,EZvCoB,OAAmB;;;;AY4CzD,mDAAsB;EACpB,MAAM,EAAE,iBAA6B;;AACrC,yDAAE;EACA,aAAa,EAAE,iBAA6B;EAC5C,WAAW,EAAE,iBAA6B;;AAC5C,qGAAwB;EACtB,mBAAmB,EAAE,CAAC;;;AAE1B,kBAAkB;EAChB,MAAM,EAAE,iBAA6B;;;AAGrC,0BAAE;EACA,aAAa,EAAE,iBAA6B;;AAC9C,gDAAwB;EACtB,mBAAmB,EAAE,CAAC;;;AAGxB,6CAAwB;EACtB,mBAAmB,EAAE,CAAC;;AACxB,gDAAM;EACJ,YAAY,EAAE,SAAS;EACvB,aAAa,EAAE,iBAA6B;;AAC9C,6CAAwB;EACtB,mBAAmB,EAAE,CAAC;;;;AAG1B,oBAAoB;EAClB,aAAa,EZhHuB,IAAI;EYiHxC,SAAS,EAAE,IAAI;EACf,QAAQ,EAAE,IAAI;;AACd,0BAAK;EACH,aAAa,EAAE,YAAY;;AAC3B,4DAAM;EACJ,WAAW,EAAE,MAAM;;;ACzIzB,CAAC;EACC,KAAK,EbkE+B,OAAW;EajE/C,eAAe,EAAE,IAAI;EACrB,MAAM,EAAE,OAAO;;AACf,OAAO;EACL,KAAK,EbgD6B,OAAwB;;Aa/C5D,SAAS;EACP,KAAK,Eb6C6B,OAAO;;;AanB7C,IAAI;EACF,MAAM,EAAE,IAAI;EACZ,UAAU,EAAE,MAAM;;;AAEpB,IAAI;EACF,WAAW,EX3CyB,2DAAM;EW4C1C,WAAW,EAAE,MAAM;EACnB,KAAK,EX/C+B,OAAW;EWgD/C,UAAU,EAAE,IAAI;EAChB,UAAU,EAAE,MAAM;EAClB,UAAU,EbnD0B,OAAO;;;AaqD7C,aAAa;EACX,UAAU,EAAE,IAAI;;;AAElB,eAAe;EACb,UAAU,EAAE,MAAM;;;AAEpB,cAAc;EACZ,UAAU,EAAE,KAAK;;;AAEnB,cAAc;EACZ,SAAS,EAAE,IAAI;;;AAEjB,eAAe;EACb,SAAS,EAAE,IAAI;;;AAEjB,qBAAqB;EACnB,SAAS,EAAE,GAAG;;;AAEhB,eAAe;EACb,eAAe,EAAE,YAAY;;;AAE/B,gBAAgB;EACd,KAAK,EAAE,kBAAkB;;;AAC3B,uBAAuB;EACrB,KAAK,EAAE,kBAAgC;;;AACzC,aAAa;EACX,KAAK,EAAE,kBAAgB;;;AACzB,oBAAoB;EAClB,KAAK,EAAE,kBAA8B;;;AACvC,gBAAgB;EACd,KAAK,EAAE,kBAAiB;;;AAC1B,uBAAuB;EACrB,KAAK,EAAE,kBAA+B;;;AACxC,eAAe;EACb,KAAK,EAAE,kBAAe;;;AACxB,sBAAsB;EACpB,KAAK,EAAE,kBAA6B;;;AACtC,gBAAgB;EACd,KAAK,EAAE,kBAAsB;;;AAC/B,uBAAuB;EACrB,KAAK,EAAE,kBAAoC;;;AAkB7C,uEAAyB;EACvB,UAAU,EAAE,CAAC;EACb,WAAW,EAAE,GAAG;EAChB,WAAW,EX9GyB,8DAAa;;;AWgHnD,CAAC;EACC,WAAW,Eb1FyB,IAAI;Ea2FxC,MAAM,EAAE,CAAC;EACT,SAAS,Eb/F2B,IAAI;EagGxC,aAAa,Eb7FuB,IAAI;;;Aa+F1C,EAAE;EACA,SAAS,EAAE,IAAI;;;AAEjB,2CAAE;EACA,SAAS,EAAE,IAAI;;;AAEjB,EAAE;EACA,SAAS,EAAE,IAAI;;;AAEjB,EAAE;EACA,SAAS,EAAE,IAAI;;;AAEjB,EAAE;EACA,SAAS,EAAE,IAAI;;;AAEjB,EAAE;EACA,SAAS,EAAE,IAAI;;;AAEjB,EAAE;EACA,OAAO,EAAE,KAAK;EACd,MAAM,EAAE,GAAG;EACX,MAAM,EAAE,CAAC;EACT,UAAU,EAAE,iBAA6B;EACzC,MAAM,EAAE,MAAmB;EAC3B,OAAO,EAAE,CAAC;;;AAEZ,wCAAI;EACF,WAAW,EAAE,MAAM;EACnB,SAAS,EAAE,IAAI;EACf,UAAU,EblG0B,IAAM;EamG1C,MAAM,EAAE,iBAAiC;EACzC,SAAS,EAAE,GAAG;EACd,OAAO,EAAE,KAAK;EACd,WAAW,EXrJyB,oNAAQ;EWsJ5C,KAAK,Eb1H+B,OAAI;Ea2HxC,UAAU,EAAE,IAAI;;AAChB,2CAAY;EACV,SAAS,EAAE,GAAG;;;AAmClB,2FAAmB;EACjB,UAAU,EAAE,IAAI;EAChB,WAAW,EbzKyB,IAAI;Ea0KxC,aAAa,Eb1KuB,IAAI;;Aa2KxC,uGAAE;EACA,UAAU,EAAE,IAAI;EAChB,WAAW,Eb7KuB,IAAI;;Aa8KtC,2JAAY;EACV,aAAa,EAAE,CAAC;;AAClB,mHAAE;EACA,aAAa,EAAE,CAAC;;AAClB,mHAAE;EACA,UAAU,EAAE,MAAM;;AAClB,+HAAE;EACA,UAAU,EAAE,MAAM;;AACtB,+HAAK;EACH,UAAU,EAAE,OAAO;;;AAEzB,oFAAsB;EACpB,UAAU,EAAE,OAAO;EACnB,WAAW,Eb3LyB,IAAI;Ea4LxC,aAAa,Eb5LuB,IAAI;;Aa6LxC,gGAAE;EACA,UAAU,EAAE,OAAO;EACnB,WAAW,Eb/LuB,IAAI;;AagMtC,oJAAY;EACV,aAAa,EAAE,CAAC;;AAClB,4GAAE;EACA,aAAa,EAAE,CAAC;;AAChB,wHAAE;EACA,UAAU,EAAE,IAAI;;;ACrOxB,kBAAkB;EAChB,MAAM,EAAE,iBAA6B;EACrC,aAAa,EAAE,IAAI;EACnB,OAAO,Ed6B6B,IAAI;Ec5BxC,WAAW,EAAE,IAAqB;EAClC,WAAW,EAAE,GAAG;EAChB,UAAU,EdoD0B,IAAM;EcnD1C,QAAQ,EAAE,QAAQ;;AAClB,wBAAO;EACL,OAAO,EAAE,SAAS;EAClB,QAAQ,EAAE,QAAQ;EAClB,GAAG,EAAE,GAAG;EACR,IAAI,EAAE,GAAG;EACT,UAAU,EdoDwB,OAAO;EcnDzC,KAAK,EAAE,KAAoB;EAC3B,OAAO,EAAE,QAA2C;;AACtD,2CAA0B;EACxB,MAAM,EAAE,iBAA6B;EACrC,aAAa,EdcqB,IAAI;;;AcZ1C,mHAAmC;EACjC,MAAM,EAAE,iBAA6B;EACrC,OAAO,EAAE,GAAG;EACZ,UAAU,EAAE,IAAI;EAChB,UAAU,EdkC0B,IAAM;EchC1C,MAAM,EAAE,YAAyB;;AACjC,mLAAuB;EACrB,MAAM,EAAE,IAAI;EACZ,UAAU,EAAE,IAAI;EAChB,MAAM,EAAE,CAAC;;;AAEb,+BAA+B;EAC7B,KAAK,EAAE,IAAI;;;AACb,cAAc;EACZ,YAAY,EAAE,iBAA0C;EACxD,MAAM,EAAE,CAAC;EACT,OAAO,EAAE,SAA2C;EACpD,WAAW,EZ3ByB,oNAAQ;EY4B5C,SAAS,EAAE,IAAI;EACf,WAAW,EAAE,GAAG;EAChB,KAAK,EdI+B,OAAwB;;;AcH9D,2BAA2B;EACzB,WAAW,EAAE,GAAG;EAChB,MAAM,EAAE,CAAC;EACT,OAAO,EAAE,SAA2C;EACpD,WAAW,EZnCyB,oNAAQ;EYoC5C,SAAS,EAAE,IAAI;EACf,WAAW,EAAE,GAAG;EAChB,OAAO,EAAE,KAAK;EACd,QAAQ,EAAE,IAAI;EACd,KAAK,EZ7C+B,OAAW;;;AYiDjD,YAAY;EACV,gJAAgE;IAC9D,WAAW,EAAE,QAAQ;;;ACzDzB,IAAI;EACF,gBAAgB,EAAE,OAAO;EACzB,MAAM,EAAE,OAAO;EACf,OAAO,EAAE,MAAM;EACf,OAAO,EAAE,KAAK;;;AAChB,EAAE;EACA,KAAK,EAAE,OAAO;EACd,UAAU,EAAE,MAAM;;;AACpB,IAAI;EACF,KAAK,EAAE,OAAO;EACd,gBAAgB,EAAE,OAAO;;;AAC3B,EAAE;EACA,WAAW,EAAE,IAAI;;;AACnB,EAAE;EACA,WAAW,EAAE,IAAI;;;AACnB,GAAG;EACD,KAAK,EAAE,OAAO;EACd,UAAU,EAAE,MAAM;;;AACpB,GAAG;EACD,KAAK,EAAE,OAAO;EACd,WAAW,EAAE,IAAI;;;AACnB,GAAG;EACD,KAAK,EAAE,OAAO;EACd,UAAU,EAAE,MAAM;;;AACpB,GAAG;EACD,KAAK,EAAE,OAAO;EACd,WAAW,EAAE,IAAI;EACjB,UAAU,EAAE,MAAM;;;AACpB,GAAG;EACD,KAAK,EAAE,OAAO;EACd,gBAAgB,EAAE,OAAO;;;AAC3B,MAAM;EACJ,KAAK,EAAE,OAAO;EACd,gBAAgB,EAAE,OAAO;;;AAC3B,GAAG;EACD,UAAU,EAAE,MAAM;;;AACpB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;EACd,gBAAgB,EAAE,OAAO;;;AAC3B,MAAM;EACJ,KAAK,EAAE,OAAO;EACd,gBAAgB,EAAE,OAAO;;;AAC3B,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,WAAW,EAAE,IAAI;;;AACnB,GAAG;EACD,KAAK,EAAE,OAAO;EACd,WAAW,EAAE,IAAI;;;AACnB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,WAAW,EAAE,IAAI;;;AACnB,GAAG;EACD,WAAW,EAAE,IAAI;;;AACnB,GAAG;EACD,WAAW,EAAE,IAAI;;;AACnB,GAAG;EACD,WAAW,EAAE,IAAI;;;AACnB,GAAG;EACD,WAAW,EAAE,IAAI;;;AACnB,GAAG;EACD,KAAK,EAAE,OAAO;EACd,WAAW,EAAE,IAAI;;;AACnB,EAAE;EACA,KAAK,EAAE,OAAO;;;AAChB,EAAE;EACA,KAAK,EAAE,OAAO;;;AAChB,EAAE;EACA,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,IAAI;;;AACb,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;EACd,WAAW,EAAE,IAAI;;;AACnB,GAAG;EACD,KAAK,EAAE,IAAI;;;AACb,GAAG;EACD,KAAK,EAAE,MAAM;;;AACf,GAAG;EACD,KAAK,EAAE,OAAO;EACd,WAAW,EAAE,IAAI;;;AACnB,GAAG;EACD,KAAK,EAAE,OAAO;EACd,WAAW,EAAE,IAAI;;;AACnB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,IAAI;;;AACb,GAAG;EACD,KAAK,EAAE,IAAI;;;AACb,GAAG;EACD,WAAW,EAAE,IAAI;;;AACnB,EAAE;EACA,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,IAAI;;;AACb,GAAG;EACD,KAAK,EAAE,IAAI;;;AACb,GAAG;EACD,KAAK,EAAE,IAAI;;;AACb,GAAG;EACD,KAAK,EAAE,OAAO;;;AAChB,GAAG;EACD,KAAK,EAAE,IAAI;EACX,gBAAgB,EAAE,OAAO;;;ACjJ3B,kBAAkB;EAChB,OAAO,EAAE,YAAY;;AACrB,uCAAsB;EACpB,KAAK,EAAE,KAAK;;AACd,oBAAC;EACC,OAAO,EAAE,YAAY;EACrB,OAAO,EAAE,GAAG;;AACZ,gCAAa;EACX,YAAY,EAAE,CAAC;;AACnB,+FAAI;EACF,OAAO,EAAE,GAAG;EACZ,MAAM,EAAE,IAAI;EACZ,UAAU,EAAE,IAAI;;AAChB,uHAAS;EACP,KAAK,EdR2B,OAAW;;;AcSjD,qBAAqB;EACnB,aAAa,EAAE,CAAC;EAChB,KAAK,EhB2B+B,OAAwB;EgB1B5D,SAAS,EAAE,GAAG;EACd,OAAO,EAAE,YAAY;;;AbanB,oCAAsB;EaTxB,qBAAqB;IACnB,OAAO,EAAE,IAAI;;;EACf,uCAAuC;IACrC,OAAO,EAAE,IAAI;;;AAEjB,YAAY;EACV,uCAAuC;IACrC,OAAO,EAAE,IAAI;;;AC9BjB,SAAS;EACP,QAAQ,EAAE,KAAK;EACf,GAAG,ECAO,OAAO;;;ADGjB,gBAAO;EACL,eAAe,EAAE,IAAI;;;AAEzB,cAAc;E/B+FZ,KAAK,EAAE,CAAC;;AACR,2CAAS;EAEP,OAAO,EAAE,KAAK;EACd,OAAO,EAAE,EAAE;;AACb,oBAAO;EACL,KAAK,EAAE,IAAI;;A+BnGb,oCAAM;EACJ,OAAO,EAAE,YAAY;;AACvB,uBAAQ;EACN,UAAU,EAAE,wBAAoB;;AAEhC,6BAAa;EACX,WAAW,EAAE,iBAAyB;;AACxC,8BAAc;EACZ,YAAY,EAAE,iBAAyB;;AAC3C,gBAAC;EACC,MAAM,EAAE,IAAmB;EAC3B,OAAO,EAAE,YAAY;EACrB,WAAW,EAAE,IAAmB;EAChC,OAAO,EAAE,MAAiB;;;AAG5B,qDAAiB;EACf,MAAM,EAAE,IAAmB;EAC3B,OAAO,EAAE,YAAY;EACrB,WAAW,EAAE,IAAmB;EAChC,OAAO,EAAE,SAAS;EAClB,aAAa,EAAE,CAAC;EAChB,OAAO,EAAE,KAAK;EACd,WAAW,EAAE,IAAI;EACjB,cAAc,EAAE,SAAS;EACzB,SAAS,EAAE,GAAG;EACd,KAAK,EjBvB6B,IAAI;EiBwBtC,WAAW,EAAE,MAAM;;AAErB,oBAAE;EACA,aAAa,EAAE,CAAC;;AAEhB,+BAAY;EACV,UAAU,EAAE,iBAAyB;;AACvC,kCAAe;EACb,aAAa,EAAE,iBAAyB;;AAC1C,4BAAS;EACP,UAAU,EAAE,OAAsC;;AAClD,8BAAC;EACC,KAAK,EjBNyB,IAAwB;EiBOtD,YAAY,EAAE,iBAAgD;EAC9D,OAAO,EAAE,gBAAyB;;AAClC,oCAAO;EACL,UAAU,EAAE,OAAsC;;AACxD,qGAAI;EACF,MAAM,EAAE,IAAI;EACZ,UAAU,EAAE,OAAO;EACnB,KAAK,EAAE,OAAO;EACd,YAAY,EAAE,CAAC;EACf,aAAa,EAAE,CAAC;;AAElB,wCAAmB;EACjB,OAAO,EAAE,KAAK;EACd,KAAK,EAAE,IAAI;EACX,WAAW,EAAE,MAAM;EAGnB,SAAS,EAAE,KAAI;EACf,WAAW,EAAE,KAAK;EAClB,KAAK,EAAE,OAAyB;;AAGpC,2DAAuB;EACrB,KAAK,EfnE6B,OAAW;EeoE7C,OAAO,EAAE,gBAAmB;EAC5B,WAAW,EAAE,IAAI;EACjB,QAAQ,EAAE,QAAQ;EAClB,UAAU,EjBtEwB,OAAyB;EiBuE3D,MAAM,EAAE,IAAI;EACZ,aAAa,EAAE,iBAAgD;EAC/D,UAAU,EAAE,iBAAgD;EAC5D,YAAY,EAAE,YAAY;;AAE1B,uEAAO;EACL,UAAU,EjB7EsB,OAAyB;;AiB8EzD,+GAAmB;EACjB,KAAK,EjB3CyB,IAAwB;;AiB4C1D,mGAAmB;EAGjB,OAAO,EAAE,KAAK;EACd,SAAS,EAAE,KAAI;EACf,WAAW,EAAE,KAAK;EAClB,KAAK,EAAE,OAAyB;;AAIlC,sHAAI;EACF,OAAO,EAAE,IAAI;;AACf,sIAAc;EACZ,OAAO,EAAE,KAAK;;AAGd,2CAAG;EACD,UAAU,EAAE,OAAsC;EAClD,OAAO,EAAE,gBAAyB;;AACpC,yDAAiB;EACf,OAAO,EAAE,KAAK;EACd,UAAU,EAAE,OAAsC;EAClD,OAAO,EAAE,gBAAyB;;AACtC,2DAA2B;EACzB,KAAK,EjBpE2B,IAAwB;;AiBqE1D,mDAAmB;EACjB,KAAK,EAAE,OAAsC;;AACjD,+BAAa;EACX,SAAS,EAAE,KAAI;;AAEb,2CAAG;EACD,UAAU,EAAE,OAAsC;EAClD,OAAO,EAAE,gBAAyB;;AACpC,yDAAiB;EACf,OAAO,EAAE,KAAK;EACd,UAAU,EAAE,OAAsC;EAClD,OAAO,EAAE,gBAAyB;EAClC,UAAU,EAAE,IAAI;EAChB,aAAa,EAAE,IAAI;;AACvB,2DAA2B;EACzB,KAAK,EjBpF2B,IAAwB;;AiBqF1D,mDAAmB;EACjB,KAAK,EAAE,OAAsC;;AACjD,+BAAa;EACX,SAAS,EAAE,KAAI;;AAEjB,+BAAa;EACX,OAAO,EAAE,KAAK;;AAChB,uBAAK;EACH,aAAa,EAAE,CAAC;EAChB,OAAO,EAAE,IAAI;;AAEb,kCAAK;EACH,OAAO,EAAE,KAAK;;AAClB,4BAAU;EACR,aAAa,EAAE,CAAC;EAChB,KAAK,EjBnG6B,OAAwB;EiBoG1D,WAAW,EAAE,MAAM;;AACrB,mBAAC;EACC,OAAO,EAAE,YAAY;EACrB,WAAW,EAAE,IAAI;EACjB,OAAO,EAAE,gBAAmB;EAC5B,OAAO,EAAE,KAAK;EACd,QAAQ,EAAE,QAAQ;EAClB,SAAS,EAAE,GAAG;EACd,KAAK,EjB5G6B,OAAwB;;AiB6G1D,yBAAO;EACL,gBAAgB,EAAE,OAAoC;EACtD,MAAM,EAAE,OAAO;;AACf,6CAAmB;EACjB,KAAK,EjBjHyB,OAAwB;;AiBkH1D,0BAAQ;EACN,gBAAgB,EjB/EgB,OAAW;EiBgF3C,MAAM,EAAE,OAAO;EACf,KAAK,EjBvG2B,IAAM;;AiBwGtC,8CAAmB;EACjB,KAAK,EjBzGyB,IAAM;;;AiB2G5C,mBAAmB;EACjB,OAAO,EjBhF6B,GAAG;EiBiFvC,gBAAgB,EjBvFoB,OAAW;EiBwF/C,UAAU,EAAE,MAAM;EAClB,OAAO,EAAE,OAAW;EACpB,OAAO,EAAE,KAAK;EACd,KAAK,EjBpK+B,OAAyB;EiBqK7D,aAAa,EAAE,OAAW;;AAC1B,oCAAgB;EACd,KAAK,EAAE,IAAI;EACX,aAAa,EAAE,IAAI;EACnB,OAAO,EAAE,QAAQ;EACjB,YAAY,EAAE,OAAuB;;AACvC,uBAAG;EACD,OAAO,EAAE,KAAK;EACd,MAAM,EAAE,sBAA0B;EAClC,MAAM,EAAE,IAAI;EACZ,KAAK,EAAE,IAAI;EACX,gBAAgB,EjBvGkB,OAAW;EiBwG7C,OAAO,EAAE,GAAG;EACZ,aAAa,EAAE,IAAI;;AACrB,6DAAqB;EACnB,KAAK,EjBpL6B,OAAyB;EiBqL3D,SAAS,EAAE,IAAI;EACf,WAAW,EAAE,IAAI;EACjB,OAAO,EAAE,YAAY;EACrB,OAAO,EAAE,OAA2C;EACpD,aAAa,EAAE,OAAW;;AAE1B,yEAAO;EACL,UAAU,EAAE,wBAAoB;;AAClC,+EAAQ;EACN,OAAO,EAAE,KAAK;EACd,MAAM,EAAE,MAAM;EACd,MAAM,EAAE,IAAI;EACZ,KAAK,EAAE,IAAI;EACX,aAAa,EAAE,CAAC;EAChB,SAAS,EAAE,IAAI;EACf,UAAU,EAAE,WAAa;;AAEzB,yFAAQ;EACN,UAAU,EAAE,MAAM;;AACxB,iCAAa;EACX,UAAU,EAAE,SAAkB;EAC9B,aAAa,EAAE,OAAW;EAC1B,WAAW,EAAE,MAAM;EACnB,KAAK,EAAE,wBAAoB;;;AAI7B,gCAAM;EACJ,KAAK,EjBxI6B,OAAW;;AiByI/C,2BAAC;EACC,KAAK,EjB9K6B,OAAwB;;AiB+K1D,iCAAO;EACL,gBAAgB,EjB5IgB,OAAW;EiB6I3C,KAAK,EjBnK2B,IAAM;;;AiBqK5C,gBAAgB;EjCtNR,kBAAoB,EAAE,gBAAM;EAK5B,eAAiB,EAAE,gBAAM;EAezB,UAAY,EAAE,gBAAM;EiCoM1B,QAAQ,EAAE,QAAQ;EAClB,OAAO,EAAE,CAAC;EACV,KAAK,EAAE,IAAI;EACX,OAAO,EAAE,CAAC;;AACV,4BAAa;EACX,IAAI,EAAE,CAAC;EACP,KAAK,EAAE,IAAI;EACX,OAAO,EAAE,CAAC;;AACZ,0BAAW;EACT,KAAK,EAAE,IAAI;EACX,IAAI,EAAE,KAAK;EACX,OAAO,EAAE,CAAC;;AACZ,2BAAY;EACV,KAAK,EAAE,KAAK;EACZ,IAAI,EAAE,IAAI;EACV,OAAO,EAAE,CAAC;;;AAGd,gBAAgB;EACd,UAAU,EAAE,qBAAuC;EACnD,gBAAgB,EAAE,2uCAA2uC;EAC7vC,eAAe,EAAE,SAAsB;;;AAEzC,gBAAgB;EACd,QAAQ,EAAE,QAAQ;EAClB,KAAK,EAAE,IAAI;EACX,MAAM,EAAE,IAAI;;;AAEd,YAAY;EACV,QAAQ,EAAE,KAAK;EACf,GAAG,EAAE,CAAC;EACN,MAAM,EAAE,CAAC;EACT,IAAI,EAAE,CAAC;EACP,cAAc,EAAE,GAAG;EACnB,KAAK,EjBlL+B,KAAK;EiBmLzC,UAAU,EAAE,MAAM;EAClB,UAAU,EAAE,MAAM;EAClB,UAAU,EAAE,IAAI;EAChB,UAAU,EjBxLsB,OAAe;EiByL/C,OAAO,EjBlL6B,GAAG;;;AiBoLzC,WAAW;EACT,OAAO,EAAE,IAAI;EACb,UAAU,EjB5L0B,OAAW;EiB6L/C,KAAK,EjBnN+B,IAAM;EiBoN1C,OAAO,EAAE,gBAAuB;EAChC,QAAQ,EAAE,QAAQ;EAClB,WAAW,EAAE,IAAI;EACjB,UAAU,EAAE,MAAM;EAClB,SAAS,EAAE,IAAI;E/B3Kf,KAAK,EAAE,CAAC;;AACR,qCAAS;EAEP,OAAO,EAAE,KAAK;EACd,OAAO,EAAE,EAAE;;AACb,iBAAO;EACL,KAAK,EAAE,IAAI;;A+BuKb,aAAC;EACC,KAAK,EjB3N6B,IAAM;EiB4NxC,WAAW,EAAE,IAAI;;AAEnB,eAAG;EACD,YAAY,EAAE,IAAqB;EACnC,MAAM,EAAE,IAAI;EACZ,KAAK,EAAE,IAAI;EACX,gBAAgB,EjB5MkB,OAAW;EiB6M7C,OAAO,EAAE,GAAG;EACZ,aAAa,EAAE,IAAI;;AACrB,aAAC;EACC,SAAS,EAAE,IAAI;EACf,KAAK,EAAE,IAAI;EACX,MAAM,EAAE,OAAO;;;AAEnB,oBAAoB;EAClB,WAAW,EjBpNyB,KAAK;EiBqNzC,UAAU,EjB/R0B,OAAyB;EiBgS7D,UAAU,EAAE,IAAI;;;AAElB,eAAe;EACb,OAAO,EAAE,eAAmB;EAC5B,MAAM,EAAE,IAAI;EACZ,MAAM,EAAE,IAAI;;;AAEd,aAAa;EACX,QAAQ,EAAE,KAAK;EACf,KAAK,EAAE,IAAI;EACX,MAAM,EAAE,IAAI;EACZ,UAAU,EAAE,kBAAc;EAC1B,OAAO,EAAE,IAAI;EACb,OAAO,EAAE,GAAkB;;AAC3B,gBAAI;EACF,OAAO,EAAE,KAAK;;;AAClB,MAAM;EACJ,KAAK,EjB1S+B,IAAI;;AiB2SxC,QAAC;EACC,aAAa,EAAE,IAAqB;;AACtC,+FAAgB;EACd,OAAO,EAAE,GAAG;EACZ,WAAW,EflTuB,oNAAQ;EemT1C,SAAS,EAAE,GAAG;EACd,UAAU,EAAE,IAAI;EAChB,MAAM,EAAE,IAAI;EACZ,KAAK,EjBnT6B,IAAI;;;AiBqT1C,mBAAmB;E/B5NjB,KAAK,EAAE,CAAC;;AACR,qDAAS;EAEP,OAAO,EAAE,KAAK;EACd,OAAO,EAAE,EAAE;;AACb,yBAAO;EACL,KAAK,EAAE,IAAI;;;A+B0Nb,0BAAU;EACR,aAAa,EjBxSqB,IAAI;EiByStC,aAAa,EAAE,iBAA6B;EAC5C,cAAc,EjB1SoB,IAAI;;AiB2SxC,sCAAsB;EACpB,UAAU,EAAE,iBAA6B;EACzC,WAAW,EjB7SuB,IAAI;;AiB8SxC,4BAAY;EACV,SAAS,EAAE,IAAI;EACf,aAAa,EAAE,IAAqB;EACpC,OAAO,EAAE,YAAY;;AACvB,wBAAQ;EACN,KAAK,EjBxS6B,IAAwB;EiByS1D,SAAS,EAAE,GAAG;;;AdpTd,oCAAsB;EcwTxB,gBAAgB;IACd,UAAU,EjBlVwB,OAAyB;;;EiBmV7D,WAAW;IACT,OAAO,EAAE,KAAK;;;EAChB,YAAY;IAER,IAAI,EAAE,MAAmB;;EAG3B,kBAAO;IACL,KAAK,EAAE,GAAG;IACV,IAAI,EAAE,CAAC;;;EACX,oBAAoB;IAClB,WAAW,EAAE,CAAC;;EACd,oCAAe;IACb,OAAO,ECrWD,OAAO;;EDsWf,0BAAO;IACL,QAAQ,EAAE,KAAK;IACf,SAAS,EAAE,IAAI;IACf,IAAI,EAAE,GAAG;IACT,GAAG,EAAE,CAAC;IACN,MAAM,EAAE,IAAI;IACZ,QAAQ,EAAE,MAAM;;;Ad9UlB,qCAAsB;EciVxB,oBAAoB;IAClB,UAAU,EAAE,mBAAe;;;EAC7B,eAAe;IACb,MAAM,EAAE,CAAC;IACT,UAAU,EjB9WwB,OAAyB;;;AiBgX/D,YAAY;EACV,mCAAmC;IACjC,OAAO,EAAE,IAAI;;;EACf,oBAAoB;IAClB,WAAW,EAAE,CAAC;;;AE3XlB,aAAa;EACX,QAAQ,EAAE,KAAK;EACf,MAAM,EAAE,CAAC;EACT,IAAI,EAAE,CAAC;EACP,KAAK,EnB6E+B,KAAK;EmB5EzC,KAAK,EnBE+B,OAAyB;EmBD7D,UAAU,EAAE,OAAkC;EAC9C,UAAU,EAAE,kBAAiC;EAC7C,WAAW,EjBAyB,2DAAM;EiBC1C,OAAO,EnB+E6B,GAAG;;AmB9EvC,eAAC;EACC,KAAK,EnBqE6B,OAAW;EmBpE7C,eAAe,EAAE,IAAI;;AACvB,8BAAgB;EACd,OAAO,EAAE,IAAI;;AACf,kCAAoB;EAClB,OAAO,EAAE,IAAqB;EAC9B,gBAAgB,EAAE,OAAkC;EACpD,OAAO,EAAE,KAAK;EACd,UAAU,EAAE,KAAK;EACjB,SAAS,EAAE,GAAG;EACd,MAAM,EAAE,OAAO;EACf,KAAK,EnBiD6B,OAAM;EdgC1C,KAAK,EAAE,CAAC;;AACR,mFAAS;EAEP,OAAO,EAAE,KAAK;EACd,OAAO,EAAE,EAAE;;AACb,wCAAO;EACL,KAAK,EAAE,IAAI;;AiCrFX,gsDAAG;EACD,KAAK,EnBlB2B,OAAyB;;AmBmB3D,0FAAQ;EACN,KAAK,EAAE,IAAI;;AACb,6CAAU;EACR,KAAK,EAAE,IAAI;;AACb,kDAAiB;EACf,gBAAgB,EnBQgB,OAAI;EmBPpC,KAAK,EnB0B2B,IAAM;;AmBzBxC,yDAAwB;EACtB,gBAAgB,EnBXgB,OAAO;EmBYvC,KAAK,EnBzB2B,IAAI;;AmB0BxC,0CAA8B;EAC5B,OAAO,EAAE,KAAK;;AAChB,iCAAmB;EACjB,SAAS,EAAE,GAAG;EACd,OAAO,EAAE,IAAqB;EAC9B,KAAK,EnBE6B,IAAwB;EmBD1D,OAAO,EAAE,IAAI;;AACb,oCAAE;EACA,OAAO,EAAE,KAAK;EACd,MAAM,EAAE,GAAG;EACX,MAAM,EAAE,CAAC;EACT,MAAM,EAAE,MAAM;EACd,OAAO,EAAE,CAAC;EACV,UAAU,EAAE,iBAA6C;;AAC3D,oCAAE;EACA,OAAO,EAAE,YAAY;EACrB,MAAM,EAAE,CAAC;;AACT,sCAAC;EACC,OAAO,EAAE,YAAY;EACrB,OAAO,EAAE,GAAqB;EAC9B,KAAK,EnBjDyB,OAAyB;;AmBkD7D,uBAAW;EACT,KAAK,EAAE,IAAI;EACX,MAAM,EAAE,IAAI;EACZ,KAAK,EAAE,IAAI;EACX,IAAI,EAAE,IAAI;EACV,MAAM,EAAE,IAAI;EACZ,SAAS,EnBkByB,KAAK;;AmBjBvC,kCAAU;EACR,KAAK,EAAE,IAAI;;AACb,oEAAQ;EACN,KAAK,EAAE,IAAI;;AACb,qDAA+B;EAC7B,UAAU,EAAE,KAAK;;AACjB,gIAAQ;EACN,KAAK,EAAE,IAAI;;AACb,gEAAU;EACR,KAAK,EAAE,IAAI;;AACf,4CAAoB;EAClB,KAAK,EAAE,IAAI;EACX,MAAM,EAAE,IAAI;EACZ,WAAW,EAAE,IAAI;EACjB,OAAO,EAAE,KAAuB;EAChC,OAAO,EAAE,KAAK;EACd,UAAU,EAAE,MAAM;;;AhBhDpB,oCAAsB;EgBmDxB,aAAa;IACX,KAAK,EAAE,GAAG;IACV,OAAO,EAAE,IAAI;;EACb,mBAAO;IACL,OAAO,EAAE,KAAK;;;EAClB,GAAG;IACD,KAAK,EAAE,IAAI;IACX,MAAM,EAAE,IAAI;;;ACzEd,gBAAG;EACD,SAAS,EAAE,IAAI;EACf,MAAM,EAAE,eAAe;;AAEzB,uBAAU;EACR,aAAa,EpBUqB,IAAI;;AoBTtC,iCAAS;EACP,UAAU,EAAE,MAAM;;AAEtB,oCAAuB;EACrB,UAAU,EAAE,MAAM;;AAGpB,4DAAoC;EAClC,aAAa,EpBCqB,IAAI;;AoBUxC,uBAAU;EACR,WAAW,EpBXuB,IAAI;EoBYtC,WAAW,EpBZuB,IAAI;EoBatC,aAAa,EpBbqB,IAAI;;AoBmBtC,4TAAK;EACH,aAAa,EAAE,CAAC;;AAKlB,qCAAQ;EACN,YAAY,EAAE,GAAG;;AAUrB,8BAAiB;EACf,YAAY,EAAE,kBAAc;;AAC5B,oEAAM;EACJ,UAAU,EAAE,sBAAsB;EAClC,YAAY,EAAE,6BAAyB;;AAG3C,2EAAiD;EAC/C,UAAU,EAAE,WAAW;;AACzB,2EAAiD;EAC/C,UAAU,EAAE,WAAW;;AAGzB,sDAA4B;EAC1B,aAAa,EAAE,IAAqB;;AACtC,wBAAW;EACT,WAAW,EpBpDuB,IAAI;;AoBuDxC,yBAAY;EACV,WAAW,EAAE,IAAI;EACjB,aAAa,EAAE,IAAqB;;AACtC,yBAAY;EACV,KAAK,ElBrF6B,OAAW;;AkBsF/C,yBAAY;EACV,KAAK,EAAE,KAAK;EACZ,MAAM,EAAE,iBAA2C;;AACrD,wBAAW;EACT,KAAK,EAAE,IAAI;EACX,MAAM,EAAE,iBAA2C;;AACrD,0BAAa;EACX,MAAM,EAAE,IAAI;EACZ,OAAO,EAAE,KAAK;;AAMd,qSAAW;EACT,OAAO,EAAE,IAAI;EACb,UAAU,EAAE,MAAM;EAClB,SAAS,EAAE,IAAI;;AAEf,2VAAO;EACL,UAAU,EAAE,OAAO;EACnB,OAAO,EAAE,GAAO;EAChB,WAAW,EAAE,WAAW;EACxB,OAAO,EAAE,YAAY;;AACzB,2VAAmB;EACjB,OAAO,EAAE,YAAY;;AAGzB,qBAAQ;EACN,KAAK,EAAE,KAAK;EACZ,KAAK,EAAE,GAAG;EACV,OAAO,EAAE,KAAK;EACd,MAAM,EAAE,aAAuC;EAC/C,OAAO,EpB7F2B,IAAI;EoB8FtC,UAAU,EpBtDwB,OAAmB;EoBuDrD,MAAM,EAAE,iBAA6B;;AAErC,2EAAS;EACP,SAAS,EAAE,GAAG;;AAChB,2BAAK;EACH,aAAa,EAAE,CAAC;;AAClB,oCAAc;EACZ,OAAO,EAAE,KAAK;EACd,WAAW,ElB9HqB,8DAAa;EkB+H7C,WAAW,EAAE,IAAI;EACjB,UAAU,EpBrFsB,OAAmB;EoBsFnD,OAAO,EAAE,QAA2C;EACpD,MAAM,EAAE,KAAkB;EAC1B,aAAa,EpB5GmB,IAAI;EoB6GpC,SAAS,EAAE,IAAI;;AAEnB,yBAAY;EACV,UAAU,EpBzHwB,OAAO;EoB0HzC,OAAO,EAAE,YAAY;EACrB,WAAW,EAAE,IAAI;EACjB,OAAO,EAAE,KAAuB;;AAGlC,kEAAwC;EACtC,cAAc,EAAE,KAAK;EACrB,SAAS,EAAE,GAAG;;AAIhB,0EAAgD;EAC9C,UAAU,EAAE,IAAI;EAChB,MAAM,EAAE,IAAI;EACZ,KAAK,EpBjJ6B,IAAI;;AoBkJtC,kKAAM;EACJ,MAAM,EAAE,IAAI;EACZ,gBAAgB,EAAE,sBAAsB;EACxC,WAAW,EAAE,MAAM;;AACrB,4FAAQ;EACN,YAAY,EAAE,CAAC;EACf,aAAa,EAAE,CAAC;EAChB,cAAc,EAAE,GAAG;;AACrB,sKAAI;EACF,KAAK,EpB5J2B,IAAI;;AoBmKxC,6BAAgB;EAEd,MAAM,EAAE,IAAI;;AACZ,gCAAE;EACA,MAAM,EAAE,IAAI;EACZ,WAAW,EAAE,GAAG;;AAClB,yCAAW;EACT,OAAO,EAAE,YAAY;EACrB,UAAU,EAAE,GAAG;;AACjB,yCAAW;EACT,aAAa,EAAE,IAAI;EACnB,UAAU,EAAE,IAAI;EAChB,WAAW,EAAE,MAAM;;AACrB,yCAAW;EACT,UAAU,EAAE,IAAI;EAChB,YAAY,EAAE,CAAC;;AAGnB,mDAAQ;EAEN,KAAK,EpB1L6B,IAAI;;AoB2LtC,6HAAO;EACL,SAAS,EAAE,eAAe;EAC1B,WAAW,EAAE,MAAM;;AAErB,2EAAS;EACP,KAAK,EpBnK2B,OAAI;;AoBoKtC,6HAAW;EACT,WAAW,EAAE,IAAI;EACjB,KAAK,ElBvM2B,OAAW;;AkByM/C,yDAAY;EACV,KAAK,EpBhI6B,OAAW;;AoBiI/C,eAAE;EACA,aAAa,EpBlLqB,IAAI;;AoBmLtC,kBAAE;EACA,WAAW,EAAE,IAAI;;AAEnB,gFAAgB;EACd,aAAa,EAAE,eAAgC;;AAEjD,kBAAE;EACA,MAAM,EAAE,aAA4C;;AAMxD,8BAAiB;EACf,aAAa,EpBjMqB,IAAI;;AoBmMtC,iCAAE;EACA,OAAO,EAAE,YAAY;EACrB,MAAM,EAAE,KAAuB;EAC/B,SAAS,EAAE,GAAG;EACd,WAAW,EAAE,MAAM;EACnB,UAAU,EAAE,OAAmB;EAC/B,KAAK,EpBzJ2B,OAAW;EoB0J3C,UAAU,EAAE,iBAA6B;EACzC,OAAO,EAAE,GAAqB;EAC9B,QAAQ,EAAE,QAAQ;;AAClB,wCAAQ;EACN,KAAK,EAAE,OAAmB;;AAC5B,6CAAW;EACT,KAAK,ElB1OyB,OAAW;EkB2OzC,SAAS,EAAE,eAAe;;AAE9B,oCAAK;EACH,aAAa,EAAE,GAAqB;EACpC,MAAM,EAAE,IAAI;EACZ,WAAW,EAAE,iBAAuB;EACpC,UAAU,EAAE,OAAa;EACzB,KAAK,EpB7M2B,IAAwB;;AoB8MxD,gDAAW;EACT,KAAK,ElBpPyB,OAAW;EkBqPzC,SAAS,EAAE,eAAe;;AAC9B,6CAAc;EACZ,UAAU,EAAE,CAAC;;AAEf,yGAAQ;EACN,WAAW,EAAE,IAAI;;AACjB,yRAA2B;EACzB,gBAAgB,EAAE,WAAW;EAC7B,MAAM,EAAE,IAAI;EACZ,OAAO,EAAE,CAAC;EACV,SAAS,EAAE,eAAe;;AAC5B,oIAAU;EACR,WAAW,EAAE,IAAI;;AAErB,wCAAS;EACP,OAAO,EAAE,YAAY;EACrB,OAAO,EAAE,KAAK;EACd,KAAK,EpBlQ2B,IAAI;EoBmQpC,WAAW,EAAE,IAAI;;AACnB,wCAAS;EACP,OAAO,EAAE,YAAY;EACrB,aAAa,EAAE,GAAG;;AAEtB,wDAA8B;EAC5B,OAAO,EAAE,YAAY;EACrB,KAAK,EpB7M6B,OAAM;EoB8MxC,SAAS,EAAE,GAAG;EACd,YAAY,EpBtPsB,IAAI;;AoBuPxC,2BAAc;EACZ,OAAO,EAAE,KAAK;EACd,KAAK,EAAE,KAAK;;AACd,qBAAQ;EACN,aAAa,EAAE,IAAI;EACnB,WAAW,EAAE,IAAI;;AAEnB,oDAAa;EACX,UAAU,EAAE,OAAO;EACnB,OAAO,EAAE,OAAO;EAChB,WAAW,EAAE,OAAO;EACpB,SAAS,EAAE,OAAO;EAClB,KAAK,EAAE,OAAO;EACd,MAAM,EAAE,OAAO;EACf,WAAW,EAAE,OAAO;;AAIlB,oGAAQ;EACN,YAAY,EAAE,GAAG;;;AjB1QrB,oCAAsB;EiB+QtB,qBAAQ;IACN,KAAK,EAAE,IAAI;;;AChTjB,wBAAwB;EACtB,KAAK,EnBK+B,OAAW;;;AmBHjD,KAAK;EACH,UAAU,EAAE,MAAM;;;;ECHlB,WAAW,EAAE,aAAa;EAC1B,UAAU,EAAE,MAAM;EAClB,WAAW,EAAE,GAAG;EAChB,GAAG,EAAE,sEAAoB;;;EAGzB,WAAW,EAAE,aAAa;EAC1B,UAAU,EAAE,MAAM;EAClB,WAAW,EAAE,GAAG;EAChB,GAAG,EAAE,2GAAyB;;;EAG9B,WAAW,EAAE,MAAM;EACnB,UAAU,EAAE,MAAM;EAClB,WAAW,EAAE,GAAG;EAChB,GAAG,EAAE,+FAAqB;;;EAG1B,WAAW,EAAE,MAAM;EACnB,UAAU,EAAE,MAAM;EAClB,WAAW,EAAE,GAAG;EAChB,GAAG,EAAE,sFAAkB;;;EAGvB,WAAW,EAAE,aAAa;EAC1B,UAAU,EAAE,MAAM;EAClB,WAAW,EAAE,GAAG;EAChB,GAAG,EAAE,kHAA4B;;;EAGjC,WAAW,EAAE,aAAa;EAC1B,UAAU,EAAE,MAAM;EAClB,WAAW,EAAE,GAAG;EAChB,GAAG,EAAE,yGAAyB", +"sources": ["../../../bower_components/neat/app/assets/stylesheets/grid/_grid.scss","../../../bower_components/bourbon/dist/addons/_prefixer.scss","../../../bower_components/wyrm/sass/wyrm_core/_reset.sass","../../../bower_components/wyrm/sass/wyrm_core/_mixin.sass","../../../bower_components/font-awesome/scss/_path.scss","../../../bower_components/font-awesome/scss/_core.scss","../../../bower_components/font-awesome/scss/_larger.scss","../../../bower_components/font-awesome/scss/_fixed-width.scss","../../../bower_components/font-awesome/scss/_list.scss","../../../bower_components/font-awesome/scss/_variables.scss","../../../bower_components/font-awesome/scss/_bordered-pulled.scss","../../../bower_components/font-awesome/scss/_spinning.scss","../../../bower_components/font-awesome/scss/_rotated-flipped.scss","../../../bower_components/font-awesome/scss/_mixins.scss","../../../bower_components/font-awesome/scss/_stacked.scss","../../../bower_components/font-awesome/scss/_icons.scss","../../../bower_components/wyrm/sass/wyrm_core/_font_icon_defaults.sass","../../../bower_components/wyrm/sass/wyrm_core/_wy_variables.sass","../../../bower_components/wyrm/sass/wyrm_core/_alert.sass","../../../sass/_theme_variables.sass","../../../bower_components/neat/app/assets/stylesheets/grid/_media.scss","../../../bower_components/wyrm/sass/wyrm_core/_button.sass","../../../bower_components/wyrm/sass/wyrm_core/_dropdown.sass","../../../bower_components/wyrm/sass/wyrm_core/_form.sass","../../../bower_components/neat/app/assets/stylesheets/grid/_outer-container.scss","../../../bower_components/neat/app/assets/stylesheets/settings/_grid.scss","../../../bower_components/neat/app/assets/stylesheets/grid/_span-columns.scss","../../../bower_components/wyrm/sass/wyrm_core/_neat_extra.sass","../../../bower_components/wyrm/sass/wyrm_core/_generic.sass","../../../bower_components/wyrm/sass/wyrm_core/_table.sass","../../../bower_components/wyrm/sass/wyrm_core/_type.sass","../../../bower_components/wyrm/sass/wyrm_addons/pygments/_pygments.sass","../../../bower_components/wyrm/sass/wyrm_addons/pygments/_pygments_light.sass","../../../sass/_theme_breadcrumbs.sass","../../../sass/_theme_layout.sass","../../../bower_components/neat/app/assets/stylesheets/grid/_private.scss","../../../sass/_theme_badge.sass","../../../sass/_theme_rst.sass","../../../sass/_theme_mathjax.sass","../../../sass/_theme_font_local.sass"], +"names": [], +"file": "theme.css" +} diff --git a/doc/_themes/lammps_theme/static/fonts/FontAwesome.otf b/doc/_themes/lammps_theme/static/fonts/FontAwesome.otf new file mode 100644 index 00000000..8b0f54e4 Binary files /dev/null and b/doc/_themes/lammps_theme/static/fonts/FontAwesome.otf differ diff --git a/doc/_themes/lammps_theme/static/fonts/Inconsolata-Bold.ttf b/doc/_themes/lammps_theme/static/fonts/Inconsolata-Bold.ttf new file mode 100644 index 00000000..360a232d Binary files /dev/null and b/doc/_themes/lammps_theme/static/fonts/Inconsolata-Bold.ttf differ diff --git a/doc/_themes/lammps_theme/static/fonts/Inconsolata.ttf b/doc/_themes/lammps_theme/static/fonts/Inconsolata.ttf new file mode 100644 index 00000000..4b8a36d2 Binary files /dev/null and b/doc/_themes/lammps_theme/static/fonts/Inconsolata.ttf differ diff --git a/doc/_themes/lammps_theme/static/fonts/Lato-Bold.ttf b/doc/_themes/lammps_theme/static/fonts/Lato-Bold.ttf new file mode 100644 index 00000000..e8b9bf6a Binary files /dev/null and b/doc/_themes/lammps_theme/static/fonts/Lato-Bold.ttf differ diff --git a/doc/_themes/lammps_theme/static/fonts/Lato-Regular.ttf b/doc/_themes/lammps_theme/static/fonts/Lato-Regular.ttf new file mode 100644 index 00000000..7608bc3e Binary files /dev/null and b/doc/_themes/lammps_theme/static/fonts/Lato-Regular.ttf differ diff --git a/doc/_themes/lammps_theme/static/fonts/RobotoSlab-Bold.ttf b/doc/_themes/lammps_theme/static/fonts/RobotoSlab-Bold.ttf new file mode 100644 index 00000000..e6ed0de5 Binary files /dev/null and b/doc/_themes/lammps_theme/static/fonts/RobotoSlab-Bold.ttf differ diff --git a/doc/_themes/lammps_theme/static/fonts/RobotoSlab-Regular.ttf b/doc/_themes/lammps_theme/static/fonts/RobotoSlab-Regular.ttf new file mode 100644 index 00000000..141d6c08 Binary files /dev/null and b/doc/_themes/lammps_theme/static/fonts/RobotoSlab-Regular.ttf differ diff --git a/doc/_themes/lammps_theme/static/fonts/fontawesome-webfont.eot b/doc/_themes/lammps_theme/static/fonts/fontawesome-webfont.eot new file mode 100644 index 00000000..7c79c6a6 Binary files /dev/null and b/doc/_themes/lammps_theme/static/fonts/fontawesome-webfont.eot differ diff --git a/doc/_themes/lammps_theme/static/fonts/fontawesome-webfont.svg b/doc/_themes/lammps_theme/static/fonts/fontawesome-webfont.svg new file mode 100644 index 00000000..45fdf338 --- /dev/null +++ b/doc/_themes/lammps_theme/static/fonts/fontawesome-webfont.svg @@ -0,0 +1,414 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + \ No newline at end of file diff --git a/doc/_themes/lammps_theme/static/fonts/fontawesome-webfont.ttf b/doc/_themes/lammps_theme/static/fonts/fontawesome-webfont.ttf new file mode 100644 index 00000000..e89738de Binary files /dev/null and b/doc/_themes/lammps_theme/static/fonts/fontawesome-webfont.ttf differ diff --git a/doc/_themes/lammps_theme/static/fonts/fontawesome-webfont.woff b/doc/_themes/lammps_theme/static/fonts/fontawesome-webfont.woff new file mode 100644 index 00000000..8c1748aa Binary files /dev/null and b/doc/_themes/lammps_theme/static/fonts/fontawesome-webfont.woff differ diff --git a/doc/_themes/lammps_theme/static/js/modernizr.min.js b/doc/_themes/lammps_theme/static/js/modernizr.min.js new file mode 100644 index 00000000..f65d4797 --- /dev/null +++ b/doc/_themes/lammps_theme/static/js/modernizr.min.js @@ -0,0 +1,4 @@ +/* Modernizr 2.6.2 (Custom Build) | MIT & BSD + * Build: http://modernizr.com/download/#-fontface-backgroundsize-borderimage-borderradius-boxshadow-flexbox-hsla-multiplebgs-opacity-rgba-textshadow-cssanimations-csscolumns-generatedcontent-cssgradients-cssreflections-csstransforms-csstransforms3d-csstransitions-applicationcache-canvas-canvastext-draganddrop-hashchange-history-audio-video-indexeddb-input-inputtypes-localstorage-postmessage-sessionstorage-websockets-websqldatabase-webworkers-geolocation-inlinesvg-smil-svg-svgclippaths-touch-webgl-shiv-mq-cssclasses-addtest-prefixed-teststyles-testprop-testallprops-hasevent-prefixes-domprefixes-load + */ +;window.Modernizr=function(a,b,c){function D(a){j.cssText=a}function E(a,b){return D(n.join(a+";")+(b||""))}function F(a,b){return typeof a===b}function G(a,b){return!!~(""+a).indexOf(b)}function H(a,b){for(var d in a){var e=a[d];if(!G(e,"-")&&j[e]!==c)return b=="pfx"?e:!0}return!1}function I(a,b,d){for(var e in a){var f=b[a[e]];if(f!==c)return d===!1?a[e]:F(f,"function")?f.bind(d||b):f}return!1}function J(a,b,c){var d=a.charAt(0).toUpperCase()+a.slice(1),e=(a+" "+p.join(d+" ")+d).split(" ");return F(b,"string")||F(b,"undefined")?H(e,b):(e=(a+" "+q.join(d+" ")+d).split(" "),I(e,b,c))}function K(){e.input=function(c){for(var d=0,e=c.length;d',a,""].join(""),l.id=h,(m?l:n).innerHTML+=f,n.appendChild(l),m||(n.style.background="",n.style.overflow="hidden",k=g.style.overflow,g.style.overflow="hidden",g.appendChild(n)),i=c(l,a),m?l.parentNode.removeChild(l):(n.parentNode.removeChild(n),g.style.overflow=k),!!i},z=function(b){var c=a.matchMedia||a.msMatchMedia;if(c)return c(b).matches;var d;return y("@media "+b+" { #"+h+" { position: absolute; } }",function(b){d=(a.getComputedStyle?getComputedStyle(b,null):b.currentStyle)["position"]=="absolute"}),d},A=function(){function d(d,e){e=e||b.createElement(a[d]||"div"),d="on"+d;var f=d in e;return f||(e.setAttribute||(e=b.createElement("div")),e.setAttribute&&e.removeAttribute&&(e.setAttribute(d,""),f=F(e[d],"function"),F(e[d],"undefined")||(e[d]=c),e.removeAttribute(d))),e=null,f}var a={select:"input",change:"input",submit:"form",reset:"form",error:"img",load:"img",abort:"img"};return d}(),B={}.hasOwnProperty,C;!F(B,"undefined")&&!F(B.call,"undefined")?C=function(a,b){return B.call(a,b)}:C=function(a,b){return b in a&&F(a.constructor.prototype[b],"undefined")},Function.prototype.bind||(Function.prototype.bind=function(b){var c=this;if(typeof c!="function")throw new TypeError;var d=w.call(arguments,1),e=function(){if(this instanceof e){var a=function(){};a.prototype=c.prototype;var f=new a,g=c.apply(f,d.concat(w.call(arguments)));return Object(g)===g?g:f}return c.apply(b,d.concat(w.call(arguments)))};return e}),s.flexbox=function(){return J("flexWrap")},s.canvas=function(){var a=b.createElement("canvas");return!!a.getContext&&!!a.getContext("2d")},s.canvastext=function(){return!!e.canvas&&!!F(b.createElement("canvas").getContext("2d").fillText,"function")},s.webgl=function(){return!!a.WebGLRenderingContext},s.touch=function(){var c;return"ontouchstart"in a||a.DocumentTouch&&b instanceof DocumentTouch?c=!0:y(["@media (",n.join("touch-enabled),("),h,")","{#modernizr{top:9px;position:absolute}}"].join(""),function(a){c=a.offsetTop===9}),c},s.geolocation=function(){return"geolocation"in navigator},s.postmessage=function(){return!!a.postMessage},s.websqldatabase=function(){return!!a.openDatabase},s.indexedDB=function(){return!!J("indexedDB",a)},s.hashchange=function(){return A("hashchange",a)&&(b.documentMode===c||b.documentMode>7)},s.history=function(){return!!a.history&&!!history.pushState},s.draganddrop=function(){var a=b.createElement("div");return"draggable"in a||"ondragstart"in a&&"ondrop"in a},s.websockets=function(){return"WebSocket"in a||"MozWebSocket"in a},s.rgba=function(){return D("background-color:rgba(150,255,150,.5)"),G(j.backgroundColor,"rgba")},s.hsla=function(){return D("background-color:hsla(120,40%,100%,.5)"),G(j.backgroundColor,"rgba")||G(j.backgroundColor,"hsla")},s.multiplebgs=function(){return D("background:url(https://),url(https://),red url(https://)"),/(url\s*\(.*?){3}/.test(j.background)},s.backgroundsize=function(){return J("backgroundSize")},s.borderimage=function(){return J("borderImage")},s.borderradius=function(){return J("borderRadius")},s.boxshadow=function(){return J("boxShadow")},s.textshadow=function(){return b.createElement("div").style.textShadow===""},s.opacity=function(){return E("opacity:.55"),/^0.55$/.test(j.opacity)},s.cssanimations=function(){return J("animationName")},s.csscolumns=function(){return J("columnCount")},s.cssgradients=function(){var a="background-image:",b="gradient(linear,left top,right bottom,from(#9f9),to(white));",c="linear-gradient(left top,#9f9, white);";return D((a+"-webkit- ".split(" ").join(b+a)+n.join(c+a)).slice(0,-a.length)),G(j.backgroundImage,"gradient")},s.cssreflections=function(){return J("boxReflect")},s.csstransforms=function(){return!!J("transform")},s.csstransforms3d=function(){var a=!!J("perspective");return a&&"webkitPerspective"in g.style&&y("@media (transform-3d),(-webkit-transform-3d){#modernizr{left:9px;position:absolute;height:3px;}}",function(b,c){a=b.offsetLeft===9&&b.offsetHeight===3}),a},s.csstransitions=function(){return J("transition")},s.fontface=function(){var a;return y('@font-face {font-family:"font";src:url("https://")}',function(c,d){var e=b.getElementById("smodernizr"),f=e.sheet||e.styleSheet,g=f?f.cssRules&&f.cssRules[0]?f.cssRules[0].cssText:f.cssText||"":"";a=/src/i.test(g)&&g.indexOf(d.split(" ")[0])===0}),a},s.generatedcontent=function(){var a;return y(["#",h,"{font:0/0 a}#",h,':after{content:"',l,'";visibility:hidden;font:3px/1 a}'].join(""),function(b){a=b.offsetHeight>=3}),a},s.video=function(){var a=b.createElement("video"),c=!1;try{if(c=!!a.canPlayType)c=new Boolean(c),c.ogg=a.canPlayType('video/ogg; codecs="theora"').replace(/^no$/,""),c.h264=a.canPlayType('video/mp4; codecs="avc1.42E01E"').replace(/^no$/,""),c.webm=a.canPlayType('video/webm; codecs="vp8, vorbis"').replace(/^no$/,"")}catch(d){}return c},s.audio=function(){var a=b.createElement("audio"),c=!1;try{if(c=!!a.canPlayType)c=new Boolean(c),c.ogg=a.canPlayType('audio/ogg; codecs="vorbis"').replace(/^no$/,""),c.mp3=a.canPlayType("audio/mpeg;").replace(/^no$/,""),c.wav=a.canPlayType('audio/wav; codecs="1"').replace(/^no$/,""),c.m4a=(a.canPlayType("audio/x-m4a;")||a.canPlayType("audio/aac;")).replace(/^no$/,"")}catch(d){}return c},s.localstorage=function(){try{return localStorage.setItem(h,h),localStorage.removeItem(h),!0}catch(a){return!1}},s.sessionstorage=function(){try{return sessionStorage.setItem(h,h),sessionStorage.removeItem(h),!0}catch(a){return!1}},s.webworkers=function(){return!!a.Worker},s.applicationcache=function(){return!!a.applicationCache},s.svg=function(){return!!b.createElementNS&&!!b.createElementNS(r.svg,"svg").createSVGRect},s.inlinesvg=function(){var a=b.createElement("div");return a.innerHTML="",(a.firstChild&&a.firstChild.namespaceURI)==r.svg},s.smil=function(){return!!b.createElementNS&&/SVGAnimate/.test(m.call(b.createElementNS(r.svg,"animate")))},s.svgclippaths=function(){return!!b.createElementNS&&/SVGClipPath/.test(m.call(b.createElementNS(r.svg,"clipPath")))};for(var L in s)C(s,L)&&(x=L.toLowerCase(),e[x]=s[L](),v.push((e[x]?"":"no-")+x));return e.input||K(),e.addTest=function(a,b){if(typeof a=="object")for(var d in a)C(a,d)&&e.addTest(d,a[d]);else{a=a.toLowerCase();if(e[a]!==c)return e;b=typeof b=="function"?b():b,typeof f!="undefined"&&f&&(g.className+=" "+(b?"":"no-")+a),e[a]=b}return e},D(""),i=k=null,function(a,b){function k(a,b){var c=a.createElement("p"),d=a.getElementsByTagName("head")[0]||a.documentElement;return c.innerHTML="x",d.insertBefore(c.lastChild,d.firstChild)}function l(){var a=r.elements;return typeof a=="string"?a.split(" "):a}function m(a){var b=i[a[g]];return b||(b={},h++,a[g]=h,i[h]=b),b}function n(a,c,f){c||(c=b);if(j)return c.createElement(a);f||(f=m(c));var g;return f.cache[a]?g=f.cache[a].cloneNode():e.test(a)?g=(f.cache[a]=f.createElem(a)).cloneNode():g=f.createElem(a),g.canHaveChildren&&!d.test(a)?f.frag.appendChild(g):g}function o(a,c){a||(a=b);if(j)return a.createDocumentFragment();c=c||m(a);var d=c.frag.cloneNode(),e=0,f=l(),g=f.length;for(;e",f="hidden"in a,j=a.childNodes.length==1||function(){b.createElement("a");var a=b.createDocumentFragment();return typeof a.cloneNode=="undefined"||typeof a.createDocumentFragment=="undefined"||typeof a.createElement=="undefined"}()}catch(c){f=!0,j=!0}})();var r={elements:c.elements||"abbr article aside audio bdi canvas data datalist details figcaption figure footer header hgroup mark meter nav output progress section summary time video",shivCSS:c.shivCSS!==!1,supportsUnknownElements:j,shivMethods:c.shivMethods!==!1,type:"default",shivDocument:q,createElement:n,createDocumentFragment:o};a.html5=r,q(b)}(this,b),e._version=d,e._prefixes=n,e._domPrefixes=q,e._cssomPrefixes=p,e.mq=z,e.hasEvent=A,e.testProp=function(a){return H([a])},e.testAllProps=J,e.testStyles=y,e.prefixed=function(a,b,c){return b?J(a,b,c):J(a,"pfx")},g.className=g.className.replace(/(^|\s)no-js(\s|$)/,"$1$2")+(f?" js "+v.join(" "):""),e}(this,this.document),function(a,b,c){function d(a){return"[object Function]"==o.call(a)}function e(a){return"string"==typeof a}function f(){}function g(a){return!a||"loaded"==a||"complete"==a||"uninitialized"==a}function h(){var a=p.shift();q=1,a?a.t?m(function(){("c"==a.t?B.injectCss:B.injectJs)(a.s,0,a.a,a.x,a.e,1)},0):(a(),h()):q=0}function i(a,c,d,e,f,i,j){function k(b){if(!o&&g(l.readyState)&&(u.r=o=1,!q&&h(),l.onload=l.onreadystatechange=null,b)){"img"!=a&&m(function(){t.removeChild(l)},50);for(var d in y[c])y[c].hasOwnProperty(d)&&y[c][d].onload()}}var j=j||B.errorTimeout,l=b.createElement(a),o=0,r=0,u={t:d,s:c,e:f,a:i,x:j};1===y[c]&&(r=1,y[c]=[]),"object"==a?l.data=c:(l.src=c,l.type=a),l.width=l.height="0",l.onerror=l.onload=l.onreadystatechange=function(){k.call(this,r)},p.splice(e,0,u),"img"!=a&&(r||2===y[c]?(t.insertBefore(l,s?null:n),m(k,j)):y[c].push(l))}function j(a,b,c,d,f){return q=0,b=b||"j",e(a)?i("c"==b?v:u,a,b,this.i++,c,d,f):(p.splice(this.i++,0,a),1==p.length&&h()),this}function k(){var a=B;return a.loader={load:j,i:0},a}var l=b.documentElement,m=a.setTimeout,n=b.getElementsByTagName("script")[0],o={}.toString,p=[],q=0,r="MozAppearance"in l.style,s=r&&!!b.createRange().compareNode,t=s?l:n.parentNode,l=a.opera&&"[object Opera]"==o.call(a.opera),l=!!b.attachEvent&&!l,u=r?"object":l?"script":"img",v=l?"script":u,w=Array.isArray||function(a){return"[object Array]"==o.call(a)},x=[],y={},z={timeout:function(a,b){return b.length&&(a.timeout=b[0]),a}},A,B;B=function(a){function b(a){var a=a.split("!"),b=x.length,c=a.pop(),d=a.length,c={url:c,origUrl:c,prefixes:a},e,f,g;for(f=0;f ul li.current').removeClass('current'); + parent_li.toggleClass('current'); +} + +$(document).ready(function() { + // Shift nav in mobile when clicking the menu. + $(document).on('click', "[data-toggle='wy-nav-top']", function() { + $("[data-toggle='wy-nav-shift']").toggleClass("shift"); + $("[data-toggle='rst-versions']").toggleClass("shift"); + }); + // Nav menu link click operations + $(document).on('click', ".wy-menu-vertical .current ul li a", function() { + var target = $(this); + // Close menu when you click a link. + $("[data-toggle='wy-nav-shift']").removeClass("shift"); + $("[data-toggle='rst-versions']").toggleClass("shift"); + // Handle dynamic display of l3 and l4 nav lists + toggleCurrent(target); + if (typeof(window.SphinxRtdTheme) != 'undefined') { + window.SphinxRtdTheme.StickyNav.hashChange(); + } + }); + $(document).on('click', "[data-toggle='rst-current-version']", function() { + $("[data-toggle='rst-versions']").toggleClass("shift-up"); + }); + // Make tables responsive + $("table.docutils:not(.field-list)").wrap("
"); + + // Add expand links to all parents of nested ul + $('.wy-menu-vertical ul').siblings('a').each(function () { + var link = $(this); + expand = $(''); + expand.on('click', function (ev) { + toggleCurrent(link); + ev.stopPropagation(); + return false; + }); + link.prepend(expand); + }); +}); + +// Sphinx theme state +window.SphinxRtdTheme = (function (jquery) { + var stickyNav = (function () { + var navBar, + win, + winScroll = false, + linkScroll = false, + winPosition = 0, + enable = function () { + init(); + reset(); + win.on('hashchange', reset); + + // Set scrolling + win.on('scroll', function () { + if (!linkScroll) { + winScroll = true; + } + }); + setInterval(function () { + if (winScroll) { + winScroll = false; + var newWinPosition = win.scrollTop(), + navPosition = navBar.scrollTop(), + newNavPosition = navPosition + (newWinPosition - winPosition); + navBar.scrollTop(newNavPosition); + winPosition = newWinPosition; + } + }, 25); + }, + init = function () { + navBar = jquery('nav.wy-nav-side:first'); + win = jquery(window); + }, + reset = function () { + // Get anchor from URL and open up nested nav + var anchor = encodeURI(window.location.hash); + if (anchor) { + try { + var link = $('.wy-menu-vertical') + .find('[href="' + anchor + '"]'); + $('.wy-menu-vertical li.toctree-l1 li.current') + .removeClass('current'); + link.closest('li.toctree-l2').addClass('current'); + link.closest('li.toctree-l3').addClass('current'); + link.closest('li.toctree-l4').addClass('current'); + } + catch (err) { + console.log("Error expanding nav for anchor", err); + } + } + }, + hashChange = function () { + linkScroll = true; + win.one('hashchange', function () { + linkScroll = false; + }); + }; + jquery(init); + return { + enable: enable, + hashChange: hashChange + }; + }()); + return { + StickyNav: stickyNav + }; +}($)); diff --git a/doc/_themes/lammps_theme/theme.conf b/doc/_themes/lammps_theme/theme.conf new file mode 100644 index 00000000..bd77752a --- /dev/null +++ b/doc/_themes/lammps_theme/theme.conf @@ -0,0 +1,12 @@ +[theme] +inherit = basic +stylesheet = css/theme.css + +[options] +typekit_id = hiw1hhg +analytics_id = +sticky_navigation = False +logo_only = +collapse_navigation = False +display_version = True + diff --git a/doc/averagingModel.html b/doc/averagingModel.html deleted file mode 100644 index 5237b6d4..00000000 --- a/doc/averagingModel.html +++ /dev/null @@ -1,41 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

averagingModel command -

-

Syntax: -

-

Defined in couplingProperties dictionary. -

-
averagingModel model; 
-
-
  • model = name of averaging model to be applied -
-

Examples: -

-
averagingModel dense;
-averagingModel dilute; 
-
-

Note: This examples list might not be complete - please look for other averaging models (averagingModel_XY) in this documentation. -

-

Description: -

-

The averaging model performs the Lagrangian->Eulerian mapping of data (e.g. particle velocities). -

-

Restrictions: -

-

None. -

-

Related commands: -

-

dense, dilute -

-

Default: none -

- diff --git a/doc/averagingModel.txt b/doc/averagingModel.txt index 36c327e7..e474ac75 100644 --- a/doc/averagingModel.txt +++ b/doc/averagingModel.txt @@ -1,7 +1,7 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,7 +9,8 @@ averagingModel command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. averagingModel model; :pre @@ -20,18 +21,24 @@ model = name of averaging model to be applied :ul averagingModel dense; averagingModel dilute; :pre -Note: This examples list might not be complete - please look for other averaging models (averagingModel_XY) in this documentation. +NOTE: +This examples list might not be complete - please look for other averaging +models in this documentation. [Description:] -The averaging model performs the Lagrangian->Eulerian mapping of data (e.g. particle velocities). +The averaging model performs the Lagrangian->Eulerian mapping of data (e.g. +particle velocities). [Restrictions:] -None. +none [Related commands:] "dense"_averagingModel_dense.html, "dilute"_averagingModel_dilute.html -[Default:] none +[Default:] + +none + diff --git a/doc/averagingModel_dense.html b/doc/averagingModel_dense.html deleted file mode 100644 index 239c82d9..00000000 --- a/doc/averagingModel_dense.html +++ /dev/null @@ -1,34 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

averagingModel_dense command -

-

Syntax: -

-

Defined in couplingProperties dictionary. -

-
averagingModel dense; 
-
-

Examples: -

-
averagingModel dense; 
-
-

Description: -

-

The averaging model performs the Lagrangian->Eulerian mapping of data (e.g. particle velocities). In the "cfdemParticle cloud" this averaging model is used to calculate the average particle velocity inside a CFD cell. The "dense" model is supposed to be applied to cases where the granular regime is rather dense. -

-

Restrictions: -

-

No known restrictions. -

-

Related commands: -

-

averagingModel, dilute -

- diff --git a/doc/averagingModel_dense.txt b/doc/averagingModel_dense.txt index 52da602b..f5c74160 100644 --- a/doc/averagingModel_dense.txt +++ b/doc/averagingModel_dense.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -averagingModel_dense command :h3 +averagingModel dense command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. averagingModel dense; :pre @@ -19,7 +20,10 @@ averagingModel dense; :pre [Description:] -The averaging model performs the Lagrangian->Eulerian mapping of data (e.g. particle velocities). In the "cfdemParticle cloud" this averaging model is used to calculate the average particle velocity inside a CFD cell. The "dense" model is supposed to be applied to cases where the granular regime is rather dense. +The averaging model performs the Lagrangian->Eulerian mapping of data (e.g. +particle velocities). In the "cfdemParticle cloud" this averaging model is used +to calculate the average particle velocity inside a CFD cell. The {dense} model +is supposed to be applied to cases where the granular regime is rather dense. [Restrictions:] diff --git a/doc/averagingModel_dilute.html b/doc/averagingModel_dilute.html deleted file mode 100644 index 6f75339c..00000000 --- a/doc/averagingModel_dilute.html +++ /dev/null @@ -1,35 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

averagingModel_dilute command -

-

Syntax: -

-

Defined in couplingProperties dictionary. -

-
averagingModel dilute; 
-
-

Examples: -

-
averagingModel dilute; 
-
-

Description: -

-

The averaging model performs the Lagrangian->Eulerian mapping of data (e.g. particle velocities). -In the "cfdemParticle cloud" this averaging model is used to calculate the average particle velocity inside a CFD cell. The "dilute" model is supposed to be applied to cases where the granular regime is rather dilute. The particle velocity inside a CFD cell is evaluated from a single particle in a cell (no averaging). -

-

Restrictions: -

-

This model is computationally efficient, but should only be used when only one particle is inside one CFD cell. -

-

Related commands: -

-

averagingModel, dense -

- diff --git a/doc/averagingModel_dilute.txt b/doc/averagingModel_dilute.txt index 56640de8..47fa7dfe 100644 --- a/doc/averagingModel_dilute.txt +++ b/doc/averagingModel_dilute.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -averagingModel_dilute command :h3 +averagingModel dilute command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. averagingModel dilute; :pre @@ -19,12 +20,18 @@ averagingModel dilute; :pre [Description:] -The averaging model performs the Lagrangian->Eulerian mapping of data (e.g. particle velocities). -In the "cfdemParticle cloud" this averaging model is used to calculate the average particle velocity inside a CFD cell. The "dilute" model is supposed to be applied to cases where the granular regime is rather dilute. The particle velocity inside a CFD cell is evaluated from a single particle in a cell (no averaging). +The averaging model performs the Lagrangian->Eulerian mapping of data (e.g. +particle velocities). +In the "cfdemParticle cloud" this averaging model is used to calculate the +average particle velocity inside a CFD cell. The {dilute} model is supposed to +be applied to cases where the granular regime is rather dilute. The particle +velocity inside a CFD cell is evaluated from a single particle in a cell (no +averaging). [Restrictions:] -This model is computationally efficient, but should only be used when only one particle is inside one CFD cell. +This model is computationally efficient but should only be used when only one +particle is inside one CFD cell. [Related commands:] diff --git a/doc/cfdemSolverIB.html b/doc/cfdemSolverIB.html deleted file mode 100644 index 556d2441..00000000 --- a/doc/cfdemSolverIB.html +++ /dev/null @@ -1,53 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

cfdemSolverIB command -

-

Description: -

-

"cfdemSolverIB" is a coupled CFD-DEM solver using CFDEMcoupling, an open source parallel coupled CFD-DEM framework, for calculating -the dynamics between immersed bodies and the surrounding fluid. Being an implementation of an immersed boundary method it allows tackling problems where the body diameter exceeds the maximal size of a fluid cell. Using the toolbox of OpenFOAM(R)(*) the governing equations of the fluid are computed and the corrections of velocity and pressure field with respect to the body-movement information, gained from LIGGGHTS, are incorporated. -

-

Code of this solver contributions by Alice Hager, JKU. -

-

Algorithm: -

-

For each time step ... -

-
  • the motion of the spheres is calculated (position, velocity, angular velocity, force...) with LIGGGHTS using the velocity and pressure-field from the previous time step (initial condition for t=0). - -
  • the Navier-Stokes equations are solved on the whole computational domain, disregarding the solid phase. - -
  • the spheres are located within the mesh: each sphere is represented by a cluster of cells, which are either totally or partially covered by the body, depending on its exact position. - -
  • the correction of the velocity and pressure field of the fluid phase takes place, using the information about the location of the spheres and their (angular) velocity. - - -
-

Use: -

-

The solver is realized within the Open Source framework CFDEMcoupling. Just as for the unresolved CFD-DEM solver cfdemSolverPiso the file CFD/constant/couplingProperties contains information about the settings for the different models. While IOmodel, DataExchangeModel etc. are applicable for all CFDEMcoupling-solvers, special locate-, force- and void fraction models were designed for the present case: -

-

engineSearchIB, ArchimedesIB, ShirgaonkarIB, IBVoidfraction -

-

References: -

-

GONIVA, C., KLOSS, C., HAGER,A., WIERINK, G. and PIRKER, S. (2011): "A MULTI-PURPOSE OPEN SOURCE CFD-DEM APPROACH", Proc. of the 8th Int. Conf. on CFD in Oil and Gas, Metallurgical and Process Industries, Trondheim, Norway -

-

and -

-

HAGER, A., KLOSS, C. and GONIVA, C. (2011): "TOWARDS AN EFFICIENT IMMERSED BOUNDARY METHOD WITHIN AN OPEN SOURCE FRAMEWORK", Proc. of the 8th Int. Conf. on CFD in Oil and Gas, Metallurgical and Process Industries, Trondheim, Norway -

-
- -

(*) OpenFOAM(R) is a registered trade mark of Silicon Graphics International Corp. This offering is not affiliated, approved or endorsed by Silicon Graphics International Corp., the producer of the OpenFOAM(R) software and owner of the OpenFOAM(R) trademark. -

-
- - diff --git a/doc/cfdemSolverIB.txt b/doc/cfdemSolverIB.txt index 4bb7c2af..59ca8e25 100644 --- a/doc/cfdemSolverIB.txt +++ b/doc/cfdemSolverIB.txt @@ -1,7 +1,7 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,36 +9,98 @@ cfdemSolverIB command :h3 [Description:] -"cfdemSolverIB" is a coupled CFD-DEM solver using CFDEMcoupling, an open source parallel coupled CFD-DEM framework, for calculating -the dynamics between immersed bodies and the surrounding fluid. Being an implementation of an immersed boundary method it allows tackling problems where the body diameter exceeds the maximal size of a fluid cell. Using the toolbox of OpenFOAM(R)(*) the governing equations of the fluid are computed and the corrections of velocity and pressure field with respect to the body-movement information, gained from LIGGGHTS, are incorporated. +"cfdemSolverIB" is a coupled CFD-DEM solver using CFDEMcoupling, an open-source +parallel coupled CFD-DEM framework, for calculating the dynamics between +immersed bodies and the surrounding fluid. Being an implementation of an +immersed boundary method it allows tackling problems where the body diameter +exceeds the maximal size of a fluid cell. -Code of this solver contributions by Alice Hager, JKU. + +Using the toolbox of OpenFOAM®(*) the governing equations of the fluid are +computed and the corrections of velocity and pressure field with respect to the +body-movement information, gained from LIGGGHTS, are incorporated. + + + + +The code of this solver was contributed by A. Hager, JKU. For more details, see +"Goniva et al. (2011)"_#Goniva2011 and "Hager et al. (2011)"_#Hager2011 [Algorithm:] For each time step ... -the motion of the spheres is calculated (position, velocity, angular velocity, force...) with LIGGGHTS using the velocity and pressure-field from the previous time step (initial condition for t=0). :ulb,l -the Navier-Stokes equations are solved on the whole computational domain, disregarding the solid phase. :l -the spheres are located within the mesh: each sphere is represented by a cluster of cells, which are either totally or partially covered by the body, depending on its exact position. :l -the correction of the velocity and pressure field of the fluid phase takes place, using the information about the location of the spheres and their (angular) velocity. :l +the motion of the spheres is calculated (position, velocity, angular velocity, +force...) with LIGGGHTS using the velocity and pressure-field from the previous +time step (initial condition for t=0). :ulb,l +the Navier-Stokes equations are solved on the whole computational domain, +disregarding the solid phase. :l +the spheres are located within the mesh: each sphere is represented by a cluster +of cells, which are either totally or partially covered by the body, depending +on its exact position. :l +the correction of the velocity and pressure field of the fluid phase takes +place, using the information about the location of the spheres and their +(angular) velocity. :l :ule [Use:] -The solver is realized within the Open Source framework CFDEMcoupling. Just as for the unresolved CFD-DEM solver cfdemSolverPiso the file CFD/constant/couplingProperties contains information about the settings for the different models. While IOmodel, DataExchangeModel etc. are applicable for all CFDEMcoupling-solvers, special locate-, force- and void fraction models were designed for the present case: +The solver is realized within the open-source framework CFDEMcoupling. Just as +for the unresolved CFD-DEM solver cfdemSolverPiso the file +CFD/constant/couplingProperties contains information about the settings for the +different models. While IOmodel, DataExchangeModel etc. are applicable for all +CFDEMcoupling-solvers, special locate-, force- and void fraction models were +designed for the present case: -"engineSearchIB"_locateModel_engineSearchIB.html, "ArchimedesIB"_forceModel_ArchimedesIB.html, "ShirgaonkarIB"_forceModel_ShirgaonkarIB.html, "IBVoidfraction"_voidFractionModel_IBVoidFraction.html - -[References:] - -GONIVA, C., KLOSS, C., HAGER,A., WIERINK, G. and PIRKER, S. (2011): "A MULTI-PURPOSE OPEN SOURCE CFD-DEM APPROACH", Proc. of the 8th Int. Conf. on CFD in Oil and Gas, Metallurgical and Process Industries, Trondheim, Norway - -and - -HAGER, A., KLOSS, C. and GONIVA, C. (2011): "TOWARDS AN EFFICIENT IMMERSED BOUNDARY METHOD WITHIN AN OPEN SOURCE FRAMEWORK", Proc. of the 8th Int. Conf. on CFD in Oil and Gas, Metallurgical and Process Industries, Trondheim, Norway +"engineSearchIB"_locateModel_engineSearchIB.html, +"ArchimedesIB"_forceModel_ArchimedesIB.html, +"ShirgaonkarIB"_forceModel_ShirgaonkarIB.html, +"IBVoidfraction"_voidFractionModel_IBVoidFraction.html :line -(*) "OpenFOAM(R)"_of is a registered trade mark of Silicon Graphics International Corp. This offering is not affiliated, approved or endorsed by Silicon Graphics International Corp., the producer of the OpenFOAM(R) software and owner of the OpenFOAM(R) trademark. + +:link(Goniva2011) +[(Goniva, 2011)] Goniva, C., Kloss, C., Hager, A., Wierink, G. and Pirker, S., +"A multi-purpose open source CFD-DEM approach", +Proc. of the 8th Int. Conf. on CFD in Oil and Gas, Metallurgical and Process Industries, +Trondheim, Norway (2011) + +:link(Hager2011) +[(Hager, 2011)] Hager, A., Kloss, C. and Goniva, C., +"Towards an efficient immersed boundary method within an open source framework", +Proc. of the 8th Int. Conf. on CFD in Oil and Gas, Metallurgical and Process Industries, +Trondheim, Norway (2011) :line + + +NOTE: +(*) This offering is not approved or endorsed by OpenCFD Limited, producer and +distributor of the OpenFOAM software via www.openfoam.com, and owner of the +OPENFOAM® and OpenCFD® trade marks. +OPENFOAM® is a registered trade mark of OpenCFD Limited, producer and +distributor of the OpenFOAM software via www.openfoam.com. + + + + diff --git a/doc/cfdemSolverMultiphase.txt b/doc/cfdemSolverMultiphase.txt new file mode 100644 index 00000000..d655bc97 --- /dev/null +++ b/doc/cfdemSolverMultiphase.txt @@ -0,0 +1,62 @@ + + + + + +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +cfdemSolverMultiphase command :h3 + +[Description:] + + +"cfdemSolverMultiphase" is a coupled CFD-DEM solver using the CFDEMcoupling framework. Based on the OpenFOAM solver multiphaseInterFoam®(*) it has functionality to simulate several fluids using the Volume of Fluid approach, coupled with the DEM code LIGGGHTS for solid particles. + + + + + +For more details, see "Vångö et al. (2018)"_#Vångö2018. + +:line + +:link(Vångö2018) +[(Vångö2018)] M. Vångö, S. Pirker, T. Lichtenegger. (2018): +"Unresolved CFD–DEM modeling of multiphase flow in densely packed particle beds", +Applied Mathematical Modelling + +:line + + +NOTE: +(*) This offering is not approved or endorsed by OpenCFD Limited, producer and +distributor of the OpenFOAM software via www.openfoam.com, and owner of the +OPENFOAM® and OpenCFD® trade marks. +OPENFOAM® is a registered trade mark of OpenCFD Limited, producer and +distributor of the OpenFOAM software via www.openfoam.com. + + + diff --git a/doc/cfdemSolverPiso.html b/doc/cfdemSolverPiso.html deleted file mode 100644 index dda40592..00000000 --- a/doc/cfdemSolverPiso.html +++ /dev/null @@ -1,26 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

cfdemSolverPiso command -

-

Description: -

-

"cfdemSolverPiso" is a coupled CFD-DEM solver using CFDEMcoupling, an open source parallel coupled CFD-DEM framework. Based on pisoFoam(R)(*), a finite volume based solver for turbulent Navier-Stokes equations applying the PISO algorithm, "cfdemSolverPiso" has additional functionality for a coupling to the DEM code "LIGGGHTS". The volume averaged Navier-Stokes Equations are solved accounting for momentum exchange and volume displacement of discrete particles whose trajectories are calculated in the DEM code LIGGGHTS. -

-

see: -

-

GONIVA, C., KLOSS, C., HAGER,A. and PIRKER, S. (2010): "An Open Source CFD-DEM Perspective", Proc. of OpenFOAM Workshop, Göteborg, June 22.-24. -

-
- -

(*) This offering is not approved or endorsed by OpenCFD Limited, the producer of the OpenFOAM software and owner of the OPENFOAM® and OpenCFD® trade marks. OPENFOAM® is a registered trade mark of OpenCFD Limited, a wholly owned subsidiary of the ESI Group. -

-
- - diff --git a/doc/cfdemSolverPiso.txt b/doc/cfdemSolverPiso.txt index 3885699b..167a2b4a 100644 --- a/doc/cfdemSolverPiso.txt +++ b/doc/cfdemSolverPiso.txt @@ -1,7 +1,12 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c + + + + + +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,16 +14,60 @@ cfdemSolverPiso command :h3 [Description:] -"cfdemSolverPiso" is a coupled CFD-DEM solver using CFDEMcoupling, an open source parallel coupled CFD-DEM framework. Based on pisoFoam(R)(*), a finite volume based solver for turbulent Navier-Stokes equations applying the PISO algorithm, "cfdemSolverPiso" has additional functionality for a coupling to the DEM code "LIGGGHTS". The volume averaged Navier-Stokes Equations are solved accounting for momentum exchange and volume displacement of discrete particles whose trajectories are calculated in the DEM code LIGGGHTS. + +"cfdemSolverPiso" is a coupled CFD-DEM solver using CFDEMcoupling, an open-\ +source parallel coupled CFD-DEM framework. Based on pisoFoam®(*), a finite +volume based solver for turbulent Navier-Stokes equations applying the PISO +algorithm, "cfdemSolverPiso" has additional functionality for a coupling to the +DEM code "LIGGGHTS". + -see: + +The volume averaged Navier-Stokes Equations are solved accounting for momentum +exchange and volume displacement of discrete particles whose trajectories are +calculated in the DEM code LIGGGHTS. + +For more details, see "Goniva et al. (2010)"_#Goniva2010. :line -(*) This offering is not approved or endorsed by OpenCFD Limited, the producer of the OpenFOAM software and owner of the OPENFOAM® and OpenCFD® trade marks. OPENFOAM® is a registered trade mark of OpenCFD Limited, a wholly owned subsidiary of the ESI Group. + +:link(Goniva2010) +[(Goniva, 2010)] Goniva, C., Kloss, C., Hager, A. and Pirker, S. (2010): +"An Open Source CFD-DEM Perspective", +Proc. of OpenFOAM Workshop, Göteborg, June 22.-24. :line + + +NOTE: +(*) This offering is not approved or endorsed by OpenCFD Limited, producer and +distributor of the OpenFOAM software via www.openfoam.com, and owner of the +OPENFOAM® and OpenCFD® trade marks. +OPENFOAM® is a registered trade mark of OpenCFD Limited, producer and +distributor of the OpenFOAM software via www.openfoam.com. + + + diff --git a/doc/cfdemSolverPisoScalar.html b/doc/cfdemSolverPisoScalar.html deleted file mode 100644 index 191cd84a..00000000 --- a/doc/cfdemSolverPisoScalar.html +++ /dev/null @@ -1,28 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

cfdemSolverPisoScalar command -

-

Description: -

-

"cfdemSolverPisoScalar" is a coupled CFD-DEM solver using CFDEMcoupling, an open source parallel coupled CFD-DEM framework. Based on pisoFoam(R)(*), a finite volume based solver for turbulent Navier-Stokes equations applying PISO algorithm, "cfdemSolverPisoScalar" has additional functionality for a coupling to the DEM code "LIGGGHTS" as well as a scalar transport equation. The volume averaged Navier-Stokes Equations are solved accounting for momentum exchange and volume displacement of discrete particles, whose trajectories are calculated in the DEM code LIGGGHTS. The scalar transport equation is coupled to scalar properties of the particle phase, thus convective heat transfer in a fluid granular system can be modeled with "cfdemSolverPisoScalar". -

-

see: -

-

GONIVA, C., KLOSS, C., HAGER,A. and PIRKER, S. (2010): "An Open Source CFD-DEM Perspective", Proc. of OpenFOAM Workshop, Göteborg, June 22.-24. -

-

The heat transfer equation is implemented according to Nield & Bejan (2013), Convection in Porous Media, DOI 10.1007/978-1-4614-5541-7_2, Springer -

-
- -

(*) This offering is not approved or endorsed by OpenCFD Limited, the producer of the OpenFOAM software and owner of the OPENFOAM® and OpenCFD® trade marks. OPENFOAM® is a registered trade mark of OpenCFD Limited, a wholly owned subsidiary of the ESI Group. -

-
- - diff --git a/doc/cfdemSolverPisoScalar.txt b/doc/cfdemSolverPisoScalar.txt index f05ca932..e2b0a555 100644 --- a/doc/cfdemSolverPisoScalar.txt +++ b/doc/cfdemSolverPisoScalar.txt @@ -1,7 +1,12 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c + + + + + +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,17 +14,70 @@ cfdemSolverPisoScalar command :h3 [Description:] -"cfdemSolverPisoScalar" is a coupled CFD-DEM solver using CFDEMcoupling, an open source parallel coupled CFD-DEM framework. Based on pisoFoam(R)(*), a finite volume based solver for turbulent Navier-Stokes equations applying PISO algorithm, "cfdemSolverPisoScalar" has additional functionality for a coupling to the DEM code "LIGGGHTS" as well as a scalar transport equation. The volume averaged Navier-Stokes Equations are solved accounting for momentum exchange and volume displacement of discrete particles, whose trajectories are calculated in the DEM code LIGGGHTS. The scalar transport equation is coupled to scalar properties of the particle phase, thus convective heat transfer in a fluid granular system can be modeled with "cfdemSolverPisoScalar". + +"cfdemSolverPisoScalar" is a coupled CFD-DEM solver using CFDEMcoupling, an open +source parallel coupled CFD-DEM framework. Based on pisoFoam®(*), a finite +volume based solver for turbulent Navier-Stokes equations applying PISO +algorithm, "cfdemSolverPisoScalar" has additional functionality for a coupling +to the DEM code "LIGGGHTS" as well as a scalar transport equation. + -see: + +The volume averaged Navier-Stokes Equations are solved accounting for momentum +exchange and volume displacement of discrete particles, whose trajectories are +calculated in the DEM code LIGGGHTS. + +The scalar transport equation is coupled to scalar properties of the particle +phase, thus convective heat transfer in a fluid granular system can be modeled +with "cfdemSolverPisoScalar". + +For more details, see "Goniva et al. (2010)"_#Goniva2010. The heat transfer +equation is implemented according to "Nield and Bejan (2013)"_#Nield2013. :line -(*) This offering is not approved or endorsed by OpenCFD Limited, the producer of the OpenFOAM software and owner of the OPENFOAM® and OpenCFD® trade marks. OPENFOAM® is a registered trade mark of OpenCFD Limited, a wholly owned subsidiary of the ESI Group. + +:link(Goniva2010) +[(Goniva, 2010)] Goniva, C., Kloss, C., Hager, A. and Pirker, S. (2010): +"An Open Source CFD-DEM Perspective", +Proc. of OpenFOAM Workshop, Göteborg, June 22.-24. + +:link(Nield2013) +[(Nield, 2013)] Nield, D. A. and Bejan, A. (2013): +"Convection in Porous Media", DOI 10.1007/978-1-4614-5541-7_2, Springer :line + + +NOTE: +(*) This offering is not approved or endorsed by OpenCFD Limited, producer and +distributor of the OpenFOAM software via www.openfoam.com, and owner of the +OPENFOAM® and OpenCFD® trade marks. +OPENFOAM® is a registered trade mark of OpenCFD Limited, producer and +distributor of the OpenFOAM software via www.openfoam.com. + + + + diff --git a/doc/chemistrModel.html b/doc/chemistrModel.html deleted file mode 100644 index c89115e5..00000000 --- a/doc/chemistrModel.html +++ /dev/null @@ -1,51 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

chemistryModel command -

-

Syntax: -

-

Defined in couplingProperties dictionary. -

-
chemistryModels
-(
-    model_x
-    model_y
-); 
-
-
  • model = name of chemistry model to be applied -
-

Examples: -

-
chemistryModels
-(
-    species
-    diffusionCoefficients
-    massTransferCoeff
-); 
-
-

Note: This examples list might not be complete - please look for other models (forceModel_XY) in this documentation. -

-

Description: -

-

The chemistry model initialized the fields performs calculation of molar fractions and diffusion coefficients of the gaseous reactants at the location of each DEM particle. All models are executed sequentially. These values are used in the DEM calculation of particle reduction models. -

-

Restrictions: -

-

None. -

-

Related commands: -

-

species, diffusionCoefficient, massTransferCoeff -

-

Note: This examples list may be incomplete - please look for other models (forceModel_XY) in this documentation. -

-

Default: none. -

- diff --git a/doc/chemistryModel.txt b/doc/chemistryModel.txt index 458d52c8..7cf36f3b 100644 --- a/doc/chemistryModel.txt +++ b/doc/chemistryModel.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -chemistryModel command :h3 +chemistryModels command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. chemistryModels ( @@ -30,16 +31,22 @@ chemistryModels [Description:] -The chemistry model initializes the required fields for the calculation of molar fractions, determines the diffusion coefficients of the gaseous reactants, calculates the necessary coefficients for the calculation of a mass transfer coefficient. All models are executed sequentially. These values are used in the DEM calculation of particle reduction models. +The chemistry model initializes the required fields for the calculation of molar +fractions, determines the diffusion coefficients of the gaseous reactants, +calculates the necessary coefficients for the calculation of a mass transfer +coefficient. All models are executed sequentially. These values are used in the +DEM calculation of particle reduction models. [Restrictions:] -None. +none [Related commands:] -"species"_chemistryModel_species.html, "diffusionCoefficient"_chemistryModel_diffusionCoefficient.html, "massTransferCoeff"_chemistryModel_massTransferCoeffs.html +"diffusionCoefficient"_chemistryModel_diffusionCoefficients.html, +"massTransferCoeff"_chemistryModel_massTransferCoeff.html, +"species"_chemistryModel_species.html -Note: This examples list may be incomplete - please look for other models (forceModel_XY) in this documentation. +[Default:] -[Default:] none. +none diff --git a/doc/chemistryModel_diffusionCoefficients.html b/doc/chemistryModel_diffusionCoefficients.html deleted file mode 100644 index 94c463dd..00000000 --- a/doc/chemistryModel_diffusionCoefficients.html +++ /dev/null @@ -1,62 +0,0 @@ - -
CFDEMproject WWW Site - CFDEM Commands -
- - - - -
- -

chemistryModel_diffusionCoefficients command -

-

Syntax: -

-

Defined in couplingProperties dictionary. -

-
chemistryModels
-(
-    diffusionCoefficients
-);
-diffusionCoefficientsProps
-{
-    verbose			switch1;        
-    ChemistryFile 		"$casePath/CFD/constant/foam.inp";
-     diffusantGasNames          ( speciesNames ); 
-}; 
-
-
  • switch1 = (optional, normally off) flag to give information - -
    • ChemistryFile = path to file, where the reacting species are listed - -
    • diffusantGasNames = list of gas field names that are the reactant gases - - -
    -

    Examples: -

    -
    chemistryModels	
    -(
    -    diffusionCoefficients
    -);
    -speciesProps
    -{
    -    verbose			false;        
    -    ChemistryFile 		"$casePath/CFD/constant/foam.inp";
    -    diffusantGasNames       (    CO
    -                                 H2
    -                            ); 
    -} 
    -
    -

    Description: -

    -

    The chemistry model performs the calculation of chemical reactional effects acting on each DEM particle. The diffusionCoefficients model activates the binary molecular diffusion calculation of the reacting species using the Fuller-Schettler-Giddings correlation. -

    -

    Restrictions: -

    -

    Species model needs to be active. -

    -

    Related commands: -

    -

    chemistryModel -

    - diff --git a/doc/chemistryModel_diffusionCoefficients.txt b/doc/chemistryModel_diffusionCoefficients.txt index 8a116317..df64243b 100644 --- a/doc/chemistryModel_diffusionCoefficients.txt +++ b/doc/chemistryModel_diffusionCoefficients.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -chemistryModel_diffusionCoefficients command :h3 +chemistryModel diffusionCoefficients command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. chemistryModels ( @@ -17,40 +18,44 @@ chemistryModels ); diffusionCoefficientsProps \{ - verbose switch1; - ChemistryFile "$casePath/CFD/constant/foam.inp"; - diffusantGasNames ( speciesNames ); -\}; :pre + verbose switch1; + ChemistryFile "$casePath/CFD/constant/foam.inp"; + diffusantGasNames ( speciesNames ); +\} :pre -{switch1} = (optional, normally off) flag to give information :l -{ChemistryFile} = path to file, where the reacting species are listed :ulb,l +{switch1} = (optional, normally off) flag to give information :ulb,l +{ChemistryFile} = path to file, where the reacting species are listed :l {diffusantGasNames} = list of gas field names that are the reactant gases :l :ule [Examples:] -chemistryModels +chemistryModels ( diffusionCoefficients ); -speciesProps +diffusionCoefficientsProps \{ - verbose false; - ChemistryFile "$casePath/CFD/constant/foam.inp"; - diffusantGasNames ( CO - H2 - ); + verbose false; + ChemistryFile "$casePath/CFD/constant/foam.inp"; + diffusantGasNames ( CO + H2 + ); \} :pre [Description:] -The chemistry model performs the calculation of chemical reactional effects acting on each DEM particle. The diffusionCoefficients model activates the binary molecular diffusion calculation of the reacting species using the Fuller-Schettler-Giddings correlation. +The chemistry model performs the calculation of chemical reactional effects +acting on each DEM particle. The diffusionCoefficients model activates the +binary molecular diffusion calculation of the reacting species using the +Fuller-Schettler-Giddings correlation. [Restrictions:] -Species model needs to be active. +The "species"_chemistryModel_species.html model needs to be active. [Related commands:] -"chemistryModel"_chemistryModel.html +"chemistryModel"_chemistryModel.html, +"chemistryModel species"_chemistryModel_species.html diff --git a/doc/chemistryModel_massTransferCoeff.html b/doc/chemistryModel_massTransferCoeff.html deleted file mode 100644 index a80c8d4a..00000000 --- a/doc/chemistryModel_massTransferCoeff.html +++ /dev/null @@ -1,52 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    chemistryModel_massTransferCoeff command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    chemistryModels
    -(
    -    massTransferCoeff
    -);
    -diffusionCoefficientsProps
    -{
    -    verbose			switch1;        
    -}; 
    -
    -
  • switch1 = (optional, normally off) flag to give information - - - -

    Examples: -

    -
    chemistryModels	
    -(
    -    massTransferCoeff
    -);
    -massTransferCoeffProps
    -{
    -     verbose 			false;	
    -} 
    -
    -

    Description: -

    -

    The chemistry model performs the calculation of chemical reactional effects acting on each DEM particle. The coeffs needed to calculate the mass transfer coefficients are transferred to the DEM side, where it is used in the fix_chem_shrink_core module. -

    -

    Restrictions: -

    -

    Species model needs to be active. -

    -

    Related commands: -

    -

    chemistryModel -

    - diff --git a/doc/chemistryModel_massTransferCoeff.txt b/doc/chemistryModel_massTransferCoeff.txt index f0f04ba4..39573ac4 100644 --- a/doc/chemistryModel_massTransferCoeff.txt +++ b/doc/chemistryModel_massTransferCoeff.txt @@ -1,48 +1,53 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -chemistryModel_massTransferCoeff command :h3 +chemistryModel massTransferCoeff command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. chemistryModels ( massTransferCoeff ); -diffusionCoefficientsProps +massTransferCoeffProps \{ - verbose switch1; -\}; :pre + verbose switch1; +\} :pre {switch1} = (optional, normally off) flag to give information :l :ule [Examples:] -chemistryModels +chemistryModels ( massTransferCoeff ); massTransferCoeffProps \{ - verbose false; + verbose false; \} :pre [Description:] -The chemistry model performs the calculation of chemical reactional effects acting on each DEM particle. The coeffs needed to calculate the mass transfer coefficients are transferred to the DEM side, where it is used in the fix_chem_shrink_core module. +The chemistry model performs the calculation of chemical reactional effects +acting on each DEM particle. The coefficients needed to calculate the mass +transfer coefficients are transferred to the DEM side, where it is used in the +{fix chem/shrink/core} module. [Restrictions:] -Species model needs to be active. +The "species"_chemistryModel_species.html model needs to be active. [Related commands:] -"chemistryModel"_chemistryModel.html +"chemistryModel"_chemistryModel.html, +"chemistryModel species"_chemistryModel_species.html diff --git a/doc/chemistryModel_noChemistry.txt b/doc/chemistryModel_noChemistry.txt new file mode 100644 index 00000000..51cdc55d --- /dev/null +++ b/doc/chemistryModel_noChemistry.txt @@ -0,0 +1,39 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +chemistryModel off command :h3 + +[Syntax:] + +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. + +chemistryModels +( + off +); :pre + +[Examples:] + +chemistryModels +( + off +); :pre + +[Description:] + +The {off} model is a dummy chemistryModel model which does not perform any +chemical reaction calculations. + +[Restrictions:] + +none + +[Related commands:] + +"chemistryModel"_chemistryModel.html + diff --git a/doc/chemistryModel_species.html b/doc/chemistryModel_species.html deleted file mode 100644 index 7a4da001..00000000 --- a/doc/chemistryModel_species.html +++ /dev/null @@ -1,74 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    chemistryModel_species command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    chemistryModels
    -(
    -    species
    -);
    -speciesProps
    -{
    -    ChemistryFile 		"$casePath/CFD/constant/foam.inp";
    -    verbose			switch1;
    -    tempFieldName		"T";
    -    densityFieldName		"rho"
    -    voidfractionFieldName	"voidfraction"
    -    totalMoleFieldName		"molarConc"
    -    partTempName		"partTemp"
    -    partRhoName			"partRho"
    -}; 
    -
    -
    • ChemistryFile = path to file, where the reacting species are listed - -
    • T = name of the finite volume temperature field, it is already added in default and doesn't need to be specified if name is the same - -
    • rho = name of the finite volume density field, it is already added in default and doesn't need to be specified if name is the same - -
    • voidfraction = name of the finite volume voidfraction field, it is already added in default and doesn't need to be specified if name is the same - -
    • molarConc = name of the finite volume molar concentration field, it is already added in default and doesn't need to be specified if name is the same - -
    • partTemp = name of the finite volume cell averaged particle temperature field, it is already added in default and doesn't need to be specified if name is the same - -
    • partRho = name of the finite volume cell averaged density temperature field, it is already added in default and doesn't need to be specified if name is the same - -
    • switch1 = (optional, normally off) flag to give information - - -
    -

    Examples: -

    -
    chemistryModels	
    -(
    -    species
    -);
    -speciesProps
    -{
    -     ChemistryFile 		"$casePath/CFD/constant/foam.inp";
    -     verbose			false;
    -} 
    -
    -

    Description: -

    -

    The chemistry model performs the calculation of chemical reactional effects acting on each DEM particle. The species model is the model, where the specified species fields (from the foam.inp folder) are intialized, and information such as temperature, density, molar concentration and more importantly the molar fractions are transferred to DEM side. -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    chemistryModel -

    - diff --git a/doc/chemistryModel_species.txt b/doc/chemistryModel_species.txt index 66f92a9d..ad4891bf 100644 --- a/doc/chemistryModel_species.txt +++ b/doc/chemistryModel_species.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -chemistryModel_species command :h3 +chemistryModel species command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. chemistryModels ( @@ -17,20 +18,20 @@ chemistryModels ); speciesProps \{ - ChemistryFile "$casePath/CFD/constant/foam.inp"; - verbose switch1; - tempFieldName "T"; - densityFieldName "rho" - voidfractionFieldName "voidfraction" - totalMoleFieldName "molarConc" - partTempName "partTemp" - partRhoName "partRho" -\}; :pre + ChemistryFile "$casePath/CFD/constant/foam.inp"; + tempFieldName "T"; + densityFieldName "rho"; + voidfractionFieldName "voidfraction"; + totalMoleFieldName "molarConc"; + partTempName "partTemp"; + partRhoName "partRho"; + verbose switch1; +\} :pre {ChemistryFile} = path to file, where the reacting species are listed :ulb,l {T} = name of the finite volume temperature field, it is already added in default and doesn't need to be specified if name is the same :l {rho} = name of the finite volume density field, it is already added in default and doesn't need to be specified if name is the same :l -{voidfraction} = name of the finite volume voidfraction field, it is already added in default and doesn't need to be specified if name is the same :l +{voidfraction} = name of the finite volume void fraction field, it is already added in default and doesn't need to be specified if name is the same :l {molarConc} = name of the finite volume molar concentration field, it is already added in default and doesn't need to be specified if name is the same :l {partTemp} = name of the finite volume cell averaged particle temperature field, it is already added in default and doesn't need to be specified if name is the same :l {partRho} = name of the finite volume cell averaged density temperature field, it is already added in default and doesn't need to be specified if name is the same :l @@ -39,23 +40,27 @@ speciesProps [Examples:] -chemistryModels +chemistryModels ( species ); speciesProps \{ - ChemistryFile "$casePath/CFD/constant/foam.inp"; - verbose false; + ChemistryFile "$casePath/CFD/constant/foam.inp"; + verbose false; \} :pre [Description:] -The chemistry model performs the calculation of chemical reactional effects acting on each DEM particle. The species model is the model, where the specified species fields (from the foam.inp folder) are intialized, and information such as temperature, density, molar concentration and more importantly the molar fractions are transferred to DEM side. +The chemistry model performs the calculation of chemical reactional effects +acting on each DEM particle. The species model is the model, where the specified +species fields (from the foam.inp folder) are initialized, and information such +as temperature, density, molar concentration and more importantly the molar +fractions are transferred to DEM side. [Restrictions:] -none. +none [Related commands:] diff --git a/doc/clockModel.html b/doc/clockModel.html deleted file mode 100644 index 7b590f81..00000000 --- a/doc/clockModel.html +++ /dev/null @@ -1,36 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    clockModel command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    clockModel model; 
    -
    -
    • model = name of the clockModel to be applied -
    -

    Examples: -

    -
    clockModel standardClock; 
    -
    -

    Note: This examples list might not be complete - please look for other models (clockModel_XY) in this documentation. -

    -

    Description: -

    -

    The clockModel is the base class for models to examine the code/algorithm with respect to run time. -

    -

    Main parts of the clockModel classes are written by Josef Kerbl, JKU. -

    -

    Restrictions: none. -

    -

    Default: none. -

    - diff --git a/doc/clockModel.txt b/doc/clockModel.txt index fa93276a..370cb59d 100644 --- a/doc/clockModel.txt +++ b/doc/clockModel.txt @@ -1,7 +1,7 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,7 +9,8 @@ clockModel command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. clockModel model; :pre @@ -19,14 +20,20 @@ model = name of the clockModel to be applied :ul clockModel standardClock; :pre -Note: This examples list might not be complete - please look for other models (clockModel_XY) in this documentation. +NOTE: This examples list might not be complete - please look for other clock +models in this documentation. [Description:] -The clockModel is the base class for models to examine the code/algorithm with respect to run time. +The clockModel is the base class for models to examine the code/algorithm with +respect to run time. -Main parts of the clockModel classes are written by Josef Kerbl, JKU. +Main parts of the clockModel classes were written by Josef Kerbl, JKU. -[Restrictions:] none. +[Restrictions:] -[Default:] none. +none + +[Default:] + +none diff --git a/doc/clockModel_noClock.html b/doc/clockModel_noClock.html deleted file mode 100644 index 23448e45..00000000 --- a/doc/clockModel_noClock.html +++ /dev/null @@ -1,32 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    clockModel_noClock command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    clockModel off; 
    -
    -

    Examples: -

    -
    clockModel off; 
    -
    -

    Description: -

    -

    The "noClock" model is a dummy clockModel model which does not measure/evaluate the run time. -

    -

    Restrictions: none. -

    -

    Related commands: -

    -

    clockModel -

    - diff --git a/doc/clockModel_noClock.txt b/doc/clockModel_noClock.txt index 509c0b65..ae6af057 100644 --- a/doc/clockModel_noClock.txt +++ b/doc/clockModel_noClock.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -clockModel_noClock command :h3 +clockModel off command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. clockModel off; :pre @@ -19,9 +20,12 @@ clockModel off; :pre [Description:] -The "noClock" model is a dummy clockModel model which does not measure/evaluate the run time. +The {off} model is a dummy clockModel model which does not measure/evaluate the +run time. -[Restrictions:] none. +[Restrictions:] + +none [Related commands:] diff --git a/doc/clockModel_standardClock.html b/doc/clockModel_standardClock.html deleted file mode 100644 index b757df1f..00000000 --- a/doc/clockModel_standardClock.html +++ /dev/null @@ -1,34 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    clockModel_standardClock command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    clockModel standardClock; 
    -
    -

    Examples: -

    -
    clockModel standardClock; 
    -
    -

    Description: -

    -

    The "standardClock" model is a basic clockModel model which measures the run time between every ".start(int arrayPos,string name)" and ".stop(string name)" statement placed in the code. If a ".start(name)" is called more than once (e.g. in a loop) the accumulated times are calculated. After the simulation has finished, the data is stored in $caseDir/CFD/clockData/$startTime/*.txt . -Since the measurements are stored in an array, it is necessary to put a variable arrayPos (type integer) at the start command. Those do not need to be in ascending order and positions may be omitted. The standard size of this array is 30 and can be changed at the initialization of the standardClock class. If arrayPos is out of bounds, the array size will be doubled. The stop command does not need arrayPos, since the class remembers the positions. The string name is intended for easier evaluation afterwards an may be omitted like ".start(int arrayPos)" and ".stop()". The command ".stop(string name)" is a safety feature, because if the name is not equal to the started name, output will be produced for information. -After the case ran you may use the matPlot.py script located in $CFDEM_UT_DIR/vizClock/ to produce a graphical output of your measurements. The usage is like 'python < matPlot.py' and you have to be in the directory of the desired time step, where there is a file called "timeEvalFull.txt", which contains averaged and maximum data with respect to the number of processes. There is an alias called "vizClock" to run this python routine for visualizing the data. -

    -

    Restrictions: none. -

    -

    Related commands: -

    -

    clockModel -

    - diff --git a/doc/clockModel_standardClock.txt b/doc/clockModel_standardClock.txt index bae9832a..596eba70 100644 --- a/doc/clockModel_standardClock.txt +++ b/doc/clockModel_standardClock.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -clockModel_standardClock command :h3 +clockModel standardClock command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. clockModel standardClock; :pre @@ -19,11 +20,38 @@ clockModel standardClock; :pre [Description:] -The "standardClock" model is a basic clockModel model which measures the run time between every ".start(int arrayPos,string name)" and ".stop(string name)" statement placed in the code. If a ".start(name)" is called more than once (e.g. in a loop) the accumulated times are calculated. After the simulation has finished, the data is stored in $caseDir/CFD/clockData/$startTime/*.txt . -Since the measurements are stored in an array, it is necessary to put a variable {arrayPos} (type integer) at the start command. Those do not need to be in ascending order and positions may be omitted. The standard size of this array is 30 and can be changed at the initialization of the standardClock class. If {arrayPos} is out of bounds, the array size will be doubled. The stop command does not need {arrayPos}, since the class remembers the positions. The string name is intended for easier evaluation afterwards an may be omitted like ".start(int arrayPos)" and ".stop()". The command ".stop(string name)" is a safety feature, because if the name is not equal to the started name, output will be produced for information. -After the case ran you may use the matPlot.py script located in $CFDEM_UT_DIR/vizClock/ to produce a graphical output of your measurements. The usage is like 'python < matPlot.py' and you have to be in the directory of the desired time step, where there is a file called "timeEvalFull.txt", which contains averaged and maximum data with respect to the number of processes. There is an alias called "vizClock" to run this python routine for visualizing the data. +The {standardClock} model is a basic clock model which measures the run time +between every ".start(int arrayPos,string name)" and ".stop(string name)" +statement placed in the code. If a ".start(name)" is called more than once +(e.g. in a loop) the accumulated times are calculated. -[Restrictions:] none. +After the simulation has finished, the data is stored in +$caseDir/CFD/clockData/$startTime/*.txt. + +Since the measurements are stored in an array, it is necessary to put a variable +{arrayPos} (type integer) at the start command. Those do not need to be in +ascending order and positions may be omitted. The standard size of this array is +30 and can be changed at the initialization of the standardClock class. If +{arrayPos} is out of bounds, the array size will be doubled. The stop command +does not need {arrayPos}, since the class remembers the positions. The string +name is intended for easier evaluation afterwards an may be omitted like +".start(int arrayPos)" and ".stop()". The command ".stop(string name)" is a +safety feature, because if the name is not equal to the started name, output +will be produced for information. + +After the case ran you may use the matPlot.py script located in +$CFDEM_UT_DIR/vizClock/ to produce a graphical output of your measurements. The +usage is like + +python < matPlot.py :pre +and you have to be in the directory of the desired time step, where there is a +file called "timeEvalFull.txt", which contains averaged and maximum data with +respect to the number of processes. There is an alias called "vizClock" to run +this python routine for visualizing the data. + +[Restrictions:] + +none [Related commands:] diff --git a/doc/conf.py b/doc/conf.py new file mode 100644 index 00000000..fbca9962 --- /dev/null +++ b/doc/conf.py @@ -0,0 +1,289 @@ +#!/usr/bin/env python3 +# -*- coding: utf-8 -*- +# +# LAMMPS documentation build configuration file, created by +# sphinx-quickstart on Sat Sep 6 14:20:08 2014. +# +# This file is execfile()d with the current directory set to its +# containing dir. +# +# Note that not all possible configuration values are present in this +# autogenerated file. +# +# All configuration values have a default; values that are commented out +# serve to show the default. + +import sys +import os + +# Special treatment of package import error +# see https://github.com/spinus/sphinxcontrib-images/issues/41 +from docutils.parsers.rst.directives.admonitions import BaseAdmonition +from sphinx.util import compat +compat.make_admonition = BaseAdmonition + +# If extensions (or modules to document with autodoc) are in another directory, +# add these directories to sys.path here. If the directory is relative to the +# documentation root, use os.path.abspath to make it absolute, like shown here. +#sys.path.insert(0, os.path.abspath('.')) + +# -- General configuration ------------------------------------------------ + +# If your documentation needs a minimal Sphinx version, state it here. +#needs_sphinx = '1.0' + +# Add any Sphinx extension module names here, as strings. They can be +# extensions coming with Sphinx (named 'sphinx.ext.*') or your custom +# ones. +extensions = [ + 'sphinx.ext.mathjax', + 'sphinxcontrib.images', +] + +images_config = { + 'default_image_width' : '25%', + 'default_group' : 'default' +} + +# Add any paths that contain templates here, relative to this directory. +templates_path = ['_templates'] + +# The suffix of source filenames. +source_suffix = '.rst' + +# The encoding of source files. +#source_encoding = 'utf-8-sig' + +# The master toctree document. +master_doc = 'CFDEMcoupling_Manual' + +# General information about the project. +project = 'CFDEMcoupling Academic' +copyright = '2018 JKU Linz and DCS Computing GmbH' + +def get_cfdemcoupling_version(): + import os + script_dir = os.path.dirname(os.path.realpath(__file__)) + #with open(os.path.join(script_dir, '../src/lagrangian/cfdemParticle/cfdTools/versionInfo.H'), 'r') as f: + with open(os.path.join(script_dir, '../etc/bashrc'), 'r') as f: + versionline = [line for line in f if line.startswith('export CFDEM_VERSION=')][0] + return versionline.strip('export CFDEM_VERSION=') + +# The version info for the project you're documenting, acts as replacement for +# |version| and |release|, also used in various other places throughout the +# built documents. +# +# The short X.Y version. +version = get_cfdemcoupling_version() +# The full version, including alpha/beta/rc tags. +release = version + +rst_epilog = """ +.. |ProjectVersion| replace:: Academic version {versionnum} +""".format( +versionnum = version, +) + +# The language for content autogenerated by Sphinx. Refer to documentation +# for a list of supported languages. +#language = None + +# There are two options for replacing |today|: either, you set today to some +# non-false value, then it is used: +#today = '' +# Else, today_fmt is used as the format for a strftime call. +#today_fmt = '%B %d, %Y' + +# List of patterns, relative to source directory, that match files and +# directories to ignore when looking for source files. +exclude_patterns = ['_build'] + +# The reST default role (used for this markup: `text`) to use for all +# documents. +#default_role = None + +# If true, '()' will be appended to :func: etc. cross-reference text. +#add_function_parentheses = True + +# If true, the current module name will be prepended to all description +# unit titles (such as .. function::). +#add_module_names = True + +# If true, sectionauthor and moduleauthor directives will be shown in the +# output. They are ignored by default. +#show_authors = False + +# The name of the Pygments (syntax highlighting) style to use. +pygments_style = 'sphinx' + +# A list of ignored prefixes for module index sorting. +#modindex_common_prefix = [] + +# If true, keep warnings as "system message" paragraphs in the built documents. +#keep_warnings = False + + +# -- Options for HTML output ---------------------------------------------- + +# The theme to use for HTML and HTML Help pages. See the documentation for +# a list of builtin themes. +html_theme = 'lammps_theme' + +# Theme options are theme-specific and customize the look and feel of a theme +# further. For a list of options available for each theme, see the +# documentation. +#html_theme_options = {} + +# Add any paths that contain custom themes here, relative to this directory. +html_theme_path = ['_themes'] + +# The name for this set of Sphinx documents. If None, it defaults to +# " v documentation". +#html_title = None + +# A shorter title for the navigation bar. Default is the same as html_title. +#html_short_title = None + +# The name of an image file (relative to this directory) to place at the top +# of the sidebar. +#html_logo = None + +# The name of an image file (within the static path) to use as favicon of the +# docs. This file should be a Windows icon file (.ico) being 16x16 or 32x32 +# pixels large. +#html_favicon = None + +# Add any paths that contain custom static files (such as style sheets) here, +# relative to this directory. They are copied after the builtin static files, +# so a file named "default.css" will overwrite the builtin "default.css". +html_static_path = ['_static'] + +# Add any extra paths that contain custom files (such as robots.txt or +# .htaccess) here, relative to this directory. These files are copied +# directly to the root of the documentation. +#html_extra_path = [] + +# If not '', a 'Last updated on:' timestamp is inserted at every page bottom, +# using the given strftime format. +#html_last_updated_fmt = '%b %d, %Y' + +# If true, SmartyPants will be used to convert quotes and dashes to +# typographically correct entities. +#html_use_smartypants = True + +# Custom sidebar templates, maps document names to template names. +#html_sidebars = {} + +# Additional templates that should be rendered to pages, maps page names to +# template names. +#html_additional_pages = {} + +# If false, no module index is generated. +#html_domain_indices = True + +# If false, no index is generated. +#html_use_index = True + +# If true, the index is split into individual pages for each letter. +#html_split_index = False + +# If true, links to the reST sources are added to the pages. +html_show_sourcelink = False + +# If true, "Created using Sphinx" is shown in the HTML footer. Default is True. +#html_show_sphinx = True + +# If true, "(C) Copyright ..." is shown in the HTML footer. Default is True. +#html_show_copyright = True + +# If true, an OpenSearch description file will be output, and all pages will +# contain a tag referring to it. The value of this option must be the +# base URL from which the finished HTML is served. +#html_use_opensearch = '' + +# This is the file name suffix for HTML files (e.g. ".xhtml"). +#html_file_suffix = None + +# Output file base name for HTML help builder. +htmlhelp_basename = 'CFDEMcouplingdoc' + + +# -- Options for LaTeX output --------------------------------------------- + +latex_elements = { +# The paper size ('letterpaper' or 'a4paper'). +#'papersize': 'letterpaper', + +# The font size ('10pt', '11pt' or '12pt'). +#'pointsize': '10pt', + +# Additional stuff for the LaTeX preamble. +#'preamble': '', +} + +# Grouping the document tree into LaTeX files. List of tuples +# (source start file, target name, title, +# author, documentclass [howto, manual, or own class]). +latex_documents = [ + ('CFDEMcoupling_Manual', 'CFDEMcoupling.tex', 'CFDEMcoupling Documentation', + ' ', 'manual'), +] + +# The name of an image file (relative to this directory) to place at the top of +# the title page. +#latex_logo = None + +# For "manual" documents, if this is true, then toplevel headings are parts, +# not chapters. +#latex_use_parts = False + +# If true, show page references after internal links. +#latex_show_pagerefs = False + +# If true, show URL addresses after external links. +#latex_show_urls = False + +# Documents to append as an appendix to all manuals. +#latex_appendices = [] + +# If false, no module index is generated. +#latex_domain_indices = True + + +# -- Options for manual page output --------------------------------------- + +# One entry per manual page. List of tuples +# (source start file, name, description, authors, manual section). +man_pages = [ + ('CFDEMcoupling_Manual', 'cfdemcoupling', 'CFDEMcoupling Documentation', + [' '], 1) +] + +# If true, show URL addresses after external links. +#man_show_urls = False + + +# -- Options for Texinfo output ------------------------------------------- + +# Grouping the document tree into Texinfo files. List of tuples +# (source start file, target name, title, author, +# dir menu entry, description, category) +texinfo_documents = [ + ('Manual', 'CFDEMcoupling', 'CFDEMcoupling Documentation', + 'CFDEMcoupling', 'One line description of project.', + 'Miscellaneous'), +] + +# Documents to append as an appendix to all manuals. +#texinfo_appendices = [] + +# If false, no module index is generated. +#texinfo_domain_indices = True + +# How to display URL addresses: 'footnote', 'no', or 'inline'. +#texinfo_show_urls = 'footnote' + +# If true, do not generate a @detailmenu in the "Top" node's menu. +#texinfo_no_detailmenu = False + + diff --git a/doc/dataExchangeModel.html b/doc/dataExchangeModel.html deleted file mode 100644 index 51d81bbd..00000000 --- a/doc/dataExchangeModel.html +++ /dev/null @@ -1,41 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    dataExchangeModel command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    dataExchangeModel model; 
    -
    -
    • model = name of data exchange model to be applied -
    -

    Examples: -

    -
    dataExchangeModel twoWayFiles;
    -dataExchangeModel twoWayMPI; 
    -
    -

    Note: This examples list might not be complete - please look for other models (dataExchangeModel_XY) in this documentation. -

    -

    Description: -

    -

    The data exchange model performs the data exchange between the DEM code and the CFD code. -

    -

    Restrictions: -

    -

    None. -

    -

    Related commands: -

    -

    noDataExchange, oneWayVTK, twoWayFiles, twoWayMPI -

    -

    Default: none -

    - diff --git a/doc/dataExchangeModel.txt b/doc/dataExchangeModel.txt index 42e06384..ee054d2f 100644 --- a/doc/dataExchangeModel.txt +++ b/doc/dataExchangeModel.txt @@ -1,7 +1,7 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,7 +9,8 @@ dataExchangeModel command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. dataExchangeModel model; :pre @@ -20,18 +21,25 @@ model = name of data exchange model to be applied :ul dataExchangeModel twoWayFiles; dataExchangeModel twoWayMPI; :pre -Note: This examples list might not be complete - please look for other models (dataExchangeModel_XY) in this documentation. +NOTE: This examples list might not be complete - please look for other models +(dataExchangeModel XY) in this documentation. [Description:] -The data exchange model performs the data exchange between the DEM code and the CFD code. +The data exchange model performs the data exchange between the DEM code and the +CFD code. [Restrictions:] -None. +none [Related commands:] -"noDataExchange"_dataExchangeModel_noDataExchange.html, "oneWayVTK"_dataExchangeModel_oneWayVTK.html, "twoWayFiles"_dataExchangeModel_twoWayFiles.html, "twoWayMPI"_dataExchangeModel_twoWayMPI.html +"noDataExchange"_dataExchangeModel_noDataExchange.html, +"oneWayVTK"_dataExchangeModel_oneWayVTK.html, +"twoWayFiles"_dataExchangeModel_twoWayFiles.html, +"twoWayMPI"_dataExchangeModel_twoWayMPI.html -[Default:] none +[Default:] + +none diff --git a/doc/dataExchangeModel_noDataExchange.html b/doc/dataExchangeModel_noDataExchange.html deleted file mode 100644 index f84f4a55..00000000 --- a/doc/dataExchangeModel_noDataExchange.html +++ /dev/null @@ -1,34 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    dataExchangeModel_noDataExchange command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    dataExchangeModel noDataExchange; 
    -
    -

    Examples: -

    -
    dataExchangeModel noDataExchange; 
    -
    -

    Description: -

    -

    The data exchange model performs the data exchange between the DEM code and the CFD code. The noDataExchange model is a dummy model where no data is exchanged. -

    -

    Restrictions: -

    -

    None. -

    -

    Related commands: -

    -

    dataExchangeModel -

    - diff --git a/doc/dataExchangeModel_noDataExchange.txt b/doc/dataExchangeModel_noDataExchange.txt index ee6db034..676907c8 100644 --- a/doc/dataExchangeModel_noDataExchange.txt +++ b/doc/dataExchangeModel_noDataExchange.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -dataExchangeModel_noDataExchange command :h3 +dataExchangeModel noDataExchange command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. dataExchangeModel noDataExchange; :pre @@ -19,11 +20,12 @@ dataExchangeModel noDataExchange; :pre [Description:] -The data exchange model performs the data exchange between the DEM code and the CFD code. The noDataExchange model is a dummy model where no data is exchanged. +The data exchange model performs the data exchange between the DEM code and the +CFD code. The {noDataExchange} model is a dummy model where no data is exchanged. [Restrictions:] -None. +none [Related commands:] diff --git a/doc/dataExchangeModel_oneWayVTK.html b/doc/dataExchangeModel_oneWayVTK.html deleted file mode 100644 index def26192..00000000 --- a/doc/dataExchangeModel_oneWayVTK.html +++ /dev/null @@ -1,58 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    dataExchangeModel_oneWayVTK command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    dataExchangeModel oneWayVTK;
    -oneWayVTKProps
    -{
    -    DEMts timeStep;
    -    relativePath "path";
    -    couplingFilename "filename";
    -    maxNumberOfParticles number;
    -}; 
    -
    -
    • timeStep = time step size of stored DEM data - -
    • path = path to the VTK data files relative do simulation directory - -
    • filename = filename of the VTK file series - -
    • number = maximum number of particles in DEM simulation - - -
    -

    Examples: -

    -
    dataExchangeModel oneWayVTK;
    -oneWayVTKProps
    -{
    -    DEMts 0.0001;
    -    relativePath "../DEM/post";
    -    couplingFilename "vtk_out%4.4d.vtk";
    -    maxNumberOfParticles 30000;
    -} 
    -
    -

    Description: -

    -

    The data exchange model performs the data exchange between the DEM code and the CFD code. The oneWayVTK model is a model that can exchange particle properties from DEM to CFD based on previously stored VTK data. -

    -

    Restrictions: -

    -

    None. -

    -

    Related commands: -

    -

    dataExchangeModel -

    - diff --git a/doc/dataExchangeModel_oneWayVTK.txt b/doc/dataExchangeModel_oneWayVTK.txt index 3cf66429..f565f0da 100644 --- a/doc/dataExchangeModel_oneWayVTK.txt +++ b/doc/dataExchangeModel_oneWayVTK.txt @@ -1,24 +1,25 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -dataExchangeModel_oneWayVTK command :h3 +dataExchangeModel oneWayVTK command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. dataExchangeModel oneWayVTK; oneWayVTKProps \{ - DEMts timeStep; - relativePath "path"; - couplingFilename "filename"; - maxNumberOfParticles number; -\}; :pre + DEMts timeStep; + relativePath "path"; + couplingFilename "filename"; + maxNumberOfParticles number; +\} :pre {timeStep} = time step size of stored DEM data :ulb,l {path} = path to the VTK data files relative do simulation directory :l @@ -31,19 +32,21 @@ oneWayVTKProps dataExchangeModel oneWayVTK; oneWayVTKProps \{ - DEMts 0.0001; - relativePath "../DEM/post"; - couplingFilename "vtk_out%4.4d.vtk"; - maxNumberOfParticles 30000; + DEMts 0.0001; + relativePath "../DEM/post"; + couplingFilename "vtk_out%4.4d.vtk"; + maxNumberOfParticles 30000; \} :pre [Description:] -The data exchange model performs the data exchange between the DEM code and the CFD code. The oneWayVTK model is a model that can exchange particle properties from DEM to CFD based on previously stored VTK data. +The data exchange model performs the data exchange between the DEM code and the +CFD code. The {oneWayVTK} model is a model that can exchange particle properties +from DEM to CFD based on previously stored VTK data. [Restrictions:] -None. +none [Related commands:] diff --git a/doc/dataExchangeModel_twoWayFiles.html b/doc/dataExchangeModel_twoWayFiles.html deleted file mode 100644 index 46d2d891..00000000 --- a/doc/dataExchangeModel_twoWayFiles.html +++ /dev/null @@ -1,50 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    dataExchangeModel_twoWayFiles command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    dataExchangeModel twoWayFiles;
    -twoWayFilesProps
    -{
    -    couplingFilename "filename";
    -    maxNumberOfParticles number;
    -}; 
    -
    -
    • filename = filename of the VTK file series - -
    • number = maximum number of particles in DEM simulation - - -
    -

    Examples: -

    -
    dataExchangeModel twoWayFiles;
    -twoWayFilesProps
    -{
    -    couplingFilename "vtk_out%4.4d.vtk";
    -    maxNumberOfParticles 30000;
    -} 
    -
    -

    Description: -

    -

    The data exchange model performs the data exchange between the DEM code and the CFD code. The twoWayFiles model is a model that can exchange particle properties from DEM to CFD and from CFD to DEM. Data is exchanged via files that are sequentially written/read by the codes. -

    -

    Restrictions: -

    -

    Developed only for two processors, one for DEM and one for CFD run. -

    -

    Related commands: -

    -

    dataExchangeModel -

    - diff --git a/doc/dataExchangeModel_twoWayFiles.txt b/doc/dataExchangeModel_twoWayFiles.txt index cd31b167..d2cb2a38 100644 --- a/doc/dataExchangeModel_twoWayFiles.txt +++ b/doc/dataExchangeModel_twoWayFiles.txt @@ -1,25 +1,28 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -dataExchangeModel_twoWayFiles command :h3 +dataExchangeModel twoWayFiles command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. dataExchangeModel twoWayFiles; twoWayFilesProps \{ - couplingFilename "filename"; - maxNumberOfParticles number; -\}; :pre + couplingFilename "filename"; + maxNumberOfParticles scalar1; + DEMts scalar2; +\} :pre {filename} = filename of the VTK file series :ulb,l -{number} = maximum number of particles in DEM simulation :l +{scalar1} = maximum number of particles in DEM simulation :l +{scalar2} = DEM time step width :l :ule [Examples:] @@ -27,13 +30,16 @@ twoWayFilesProps dataExchangeModel twoWayFiles; twoWayFilesProps \{ - couplingFilename "vtk_out%4.4d.vtk"; - maxNumberOfParticles 30000; + couplingFilename "vtk_out%4.4d.vtk"; + maxNumberOfParticles 30000; \} :pre [Description:] -The data exchange model performs the data exchange between the DEM code and the CFD code. The twoWayFiles model is a model that can exchange particle properties from DEM to CFD and from CFD to DEM. Data is exchanged via files that are sequentially written/read by the codes. +The data exchange model performs the data exchange between the DEM code and the +CFD code. The {twoWayFiles} model is a model that can exchange particle +properties from DEM to CFD and from CFD to DEM. Data is exchanged via files that +are sequentially written/read by the codes. [Restrictions:] diff --git a/doc/dataExchangeModel_twoWayMPI.html b/doc/dataExchangeModel_twoWayMPI.html deleted file mode 100644 index cde5fabe..00000000 --- a/doc/dataExchangeModel_twoWayMPI.html +++ /dev/null @@ -1,46 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    dataExchangeModel_twoWayMPI command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    dataExchangeModel twoWayMPI;
    -twoWayMPIProps
    -{
    -    liggghtsPath "path";
    -}; 
    -
    -
    • path = path to the DEM simulation input file - - -
    -

    Examples: -

    -
    dataExchangeModel twoWayMPI;
    -twoWayMPIProps
    -{
    -    liggghtsPath "../DEM/in.liggghts_init";
    -} 
    -
    -

    Description: -

    -

    The data exchange model performs the data exchange between the DEM code and the CFD code. The twoWayMPI model is a model that can exchange particle properties from DEM to CFD and from CFD to DEM. Data is exchanged via MPI technique. The DEM run is executed by the coupling model, via a liggghtsCommandModel object. -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    dataExchangeModel -

    - diff --git a/doc/dataExchangeModel_twoWayMPI.txt b/doc/dataExchangeModel_twoWayMPI.txt index f698b0e0..5410ef1e 100644 --- a/doc/dataExchangeModel_twoWayMPI.txt +++ b/doc/dataExchangeModel_twoWayMPI.txt @@ -1,21 +1,22 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -dataExchangeModel_twoWayMPI command :h3 +dataExchangeModel twoWayMPI command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. dataExchangeModel twoWayMPI; twoWayMPIProps \{ liggghtsPath "path"; -\}; :pre +\} :pre {path} = path to the DEM simulation input file :ulb,l :ule @@ -30,11 +31,14 @@ twoWayMPIProps [Description:] -The data exchange model performs the data exchange between the DEM code and the CFD code. The twoWayMPI model is a model that can exchange particle properties from DEM to CFD and from CFD to DEM. Data is exchanged via MPI technique. The DEM run is executed by the coupling model, via a liggghtsCommandModel object. +The data exchange model performs the data exchange between the DEM code and the +CFD code. The {twoWayMPI} model is a model that can exchange particle properties +from DEM to CFD and from CFD to DEM. Data is exchanged via MPI technique. The +DEM run is executed by the coupling model, via a {liggghtsCommandModel} object. [Restrictions:] -none. +none [Related commands:] diff --git a/doc/dataExchangeModel_twoWayMany2Many.html b/doc/dataExchangeModel_twoWayMany2Many.html deleted file mode 100644 index db5b6592..00000000 --- a/doc/dataExchangeModel_twoWayMany2Many.html +++ /dev/null @@ -1,46 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    dataExchangeModel_twoWayMany2Many command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    dataExchangeModel twoWayMany2Many;
    -twoWayMany2ManyProps
    -{
    -    liggghtsPath "path";
    -}; 
    -
    -
    • path = path to the DEM simulation input file - - -
    -

    Examples: -

    -
    dataExchangeModel twoWayMany2Many;
    -twoWayMany2ManyProps
    -{
    -    liggghtsPath "../DEM/in.liggghts_init";
    -} 
    -
    -

    Description: -

    -

    The data exchange model performs the data exchange between the DEM code and the CFD code. The twoWayMany2Many model is a model that can exchange particle properties from DEM to CFD and from CFD to DEM. Data is exchanged via MPI technique using the many to many mapping scheme. The DEM run is executed by the coupling model, via a liggghtsCommandModel object. -

    -

    Restrictions: -

    -

    Must be used in combination with the engineSearchMany2Many locate model! -

    -

    Related commands: -

    -

    dataExchangeModel -

    - diff --git a/doc/dataExchangeModel_twoWayMany2Many.txt b/doc/dataExchangeModel_twoWayMany2Many.txt index 31f87e67..0cf4e372 100644 --- a/doc/dataExchangeModel_twoWayMany2Many.txt +++ b/doc/dataExchangeModel_twoWayMany2Many.txt @@ -1,21 +1,22 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -dataExchangeModel_twoWayMany2Many command :h3 +dataExchangeModel twoWayMany2Many command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. dataExchangeModel twoWayMany2Many; twoWayMany2ManyProps \{ liggghtsPath "path"; -\}; :pre +\} :pre {path} = path to the DEM simulation input file :ulb,l :ule @@ -30,11 +31,16 @@ twoWayMany2ManyProps [Description:] -The data exchange model performs the data exchange between the DEM code and the CFD code. The twoWayMany2Many model is a model that can exchange particle properties from DEM to CFD and from CFD to DEM. Data is exchanged via MPI technique using the many to many mapping scheme. The DEM run is executed by the coupling model, via a liggghtsCommandModel object. +The data exchange model performs the data exchange between the DEM code and the +CFD code. The {twoWayMany2Many} model is a model that can exchange particle +properties from DEM to CFD and from CFD to DEM. Data is exchanged via MPI +technique using the many to many mapping scheme. The DEM run is executed by the +coupling model, via a {liggghtsCommandModel} object. [Restrictions:] -Must be used in combination with the engineSearchMany2Many locate model! +Must be used in combination with the +"engineSearchMany2Many"_locateModel_engineSearchMany2Many.html locate model! [Related commands:] diff --git a/doc/forceModel.html b/doc/forceModel.html deleted file mode 100644 index fa2d2f78..00000000 --- a/doc/forceModel.html +++ /dev/null @@ -1,50 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    model_x
    -    model_y
    -); 
    -
    -
    • model = name of force model to be applied -
    -

    Examples: -

    -
    forceModels
    -(
    -    Archimedes
    -    DiFeliceDrag
    -); 
    -
    -

    Note: This examples list might not be complete - please look for other models (forceModel_XY) in this documentation. -

    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. All force models selected are executed sequentially and the forces on the particles are superposed. If the fluid density field is needed, by default a field named "rho" will be used. Via the forceSubModel an alternative field can be chosen. -

    -

    Restrictions: -

    -

    None. -

    -

    Related commands: -

    -

    Archimedes, DiFeliceDrag, gradPForce, viscForce">dSauter -

    -

    Note: This examples list may be incomplete - please look for other models (forceModel_XY) in this documentation. -

    -

    Default: none. -

    - diff --git a/doc/forceModel.txt b/doc/forceModel.txt index 2ada849a..4f8edeba 100644 --- a/doc/forceModel.txt +++ b/doc/forceModel.txt @@ -1,7 +1,7 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,7 +9,8 @@ forceModel command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -27,20 +28,28 @@ forceModels DiFeliceDrag ); :pre -Note: This examples list might not be complete - please look for other models (forceModel_XY) in this documentation. +NOTE: This examples list might not be complete - please look for other models +(forceModel XY) in this documentation. [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. All force models selected are executed sequentially and the forces on the particles are superposed. If the fluid density field is needed, by default a field named "rho" will be used. Via the forceSubModel an alternative field can be chosen. +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. All force models selected are +executed sequentially and the forces on the particles are superposed. If the +fluid density field is needed, by default a field named "rho" will be used. Via +the forceSubModel an alternative field can be chosen. [Restrictions:] -None. +none [Related commands:] -"Archimedes"_forceModel_Archimedes.html, "DiFeliceDrag"_forceModel_DiFeliceDrag.html, "gradPForce"_forceModel_gradPForce.html, "viscForce"_forceModel_viscForce.html,"dSauter"_forceModel_dSauter.html +"Archimedes"_forceModel_Archimedes.html, "DiFeliceDrag"_forceModel_DiFeliceDrag.html, +"gradPForce"_forceModel_gradPForce.html, "viscForce"_forceModel_viscForce.html, +"dSauter"_forceModel_dSauter.html -Note: This examples list may be incomplete - please look for other models (forceModel_XY) in this documentation. +[Default:] + +none -[Default:] none. diff --git a/doc/forceModel_Archimedes.html b/doc/forceModel_Archimedes.html deleted file mode 100644 index 8301478d..00000000 --- a/doc/forceModel_Archimedes.html +++ /dev/null @@ -1,52 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_Archimedes command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    Archimedes
    -);
    -ArchimedesProps
    -{
    -    gravityFieldName "gravity";
    -}; 
    -
    -
    • gravity = name of the finite volume gravity field - - -
    -

    Examples: -

    -
    forceModels
    -(
    -    Archimedes
    -);
    -ArchimedesProps
    -{
    -    gravityFieldName "g";
    -} 
    -
    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The Archimedes model is a model that calculates the Archimedes' volumetric lift force stemming from density difference of fluid and particle. -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_Archimedes.txt b/doc/forceModel_Archimedes.txt index 41c18aee..48b95e44 100644 --- a/doc/forceModel_Archimedes.txt +++ b/doc/forceModel_Archimedes.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_Archimedes command :h3 +forceModel Archimedes command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -17,10 +18,14 @@ forceModels ); ArchimedesProps \{ - gravityFieldName "gravity"; -\}; :pre + gravityFieldName "gravity"; + treatForceExplicit switch1; + treatForceDEM switch2; +\} :pre {gravity} = name of the finite volume gravity field :ulb,l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch2} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l :ule [Examples:] @@ -36,11 +41,14 @@ ArchimedesProps [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The Archimedes model is a model that calculates the Archimedes' volumetric lift force stemming from density difference of fluid and particle. +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {Archimedes} model is a +model that calculates the Archimedes' volumetric lift force stemming from +density difference of fluid and particle. [Restrictions:] -none. +none [Related commands:] diff --git a/doc/forceModel_ArchimedesIB.html b/doc/forceModel_ArchimedesIB.html deleted file mode 100644 index 9f43172f..00000000 --- a/doc/forceModel_ArchimedesIB.html +++ /dev/null @@ -1,56 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_ArchimedesIB command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    ArchimedesIB
    -);
    -ArchimedesIBProps
    -{
    -    gravityFieldName "gravity";
    -    voidfractionFieldName "voidfraction";
    -}; 
    -
    -
    • gravity = name of the finite volume gravity field - -
    • voidfraction = name of the finite volume voidfraction field - - -
    -

    Examples: -

    -
    forceModels
    -(
    -    ArchimedesIB
    -);
    -ArchimedesIBProps
    -{
    -    gravityFieldName "g";
    -    voidfractionFieldName "voidfractionNext";
    -} 
    -
    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The ArchimedesIB model is a model that calculates the ArchimedesIB' volumetric lift force stemming from density difference of fluid and particle. This model is especially suited for resolved CFD-DEM simulations where the particle is represented by immersed boundary method. -

    -

    Restrictions: -

    -

    Only for immersed boundary solvers. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_ArchimedesIB.txt b/doc/forceModel_ArchimedesIB.txt index 041d737b..bd661f54 100644 --- a/doc/forceModel_ArchimedesIB.txt +++ b/doc/forceModel_ArchimedesIB.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_ArchimedesIB command :h3 +forceModel ArchimedesIB command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -17,12 +18,16 @@ forceModels ); ArchimedesIBProps \{ - gravityFieldName "gravity"; + gravityFieldName "gravity"; voidfractionFieldName "voidfraction"; -\}; :pre + twoDimensional; + treatForceExplicit switch1; +\} :pre {gravity} = name of the finite volume gravity field :ulb,l -{voidfraction} = name of the finite volume voidfraction field :l +{voidfraction} = name of the finite volume void fraction field :l +{twoDimensional} = optional keyword for conducting a two dimensional calculation :l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l :ule [Examples:] @@ -33,13 +38,18 @@ forceModels ); ArchimedesIBProps \{ - gravityFieldName "g"; + gravityFieldName "g"; voidfractionFieldName "voidfractionNext"; \} :pre [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The ArchimedesIB model is a model that calculates the ArchimedesIB' volumetric lift force stemming from density difference of fluid and particle. This model is especially suited for resolved CFD-DEM simulations where the particle is represented by immersed boundary method. +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {ArchimedesIB} model is a +model that calculates the ArchimedesIB' volumetric lift force stemming from +density difference of fluid and particle. This model is especially suited for +resolved CFD-DEM simulations where the particle is represented by immersed +boundary method. [Restrictions:] diff --git a/doc/forceModel_BeetstraDrag.txt b/doc/forceModel_BeetstraDrag.txt new file mode 100644 index 00000000..b1c16c57 --- /dev/null +++ b/doc/forceModel_BeetstraDrag.txt @@ -0,0 +1,117 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +forceModel BeetstraDrag command :h3 + +[Syntax:] + +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. + +forceModels +( + BeetstraDrag +); +BeetstraDragProps +\{ + velFieldName "U"; + voidfractionFieldName "voidfraction"; + minVoidfraction scalar1; + granVelFieldName "Us"; +\ + useFilteredDragModel; + g gravity; + dPrim dPrimValue; + rhoP rhoPValue; + rho rhoValue; + nuf nufValue; +\ + useParcelSizeDependentFilteredDrag; + k kValue; +\ + treatForceExplicit; + implForceDEM; + verbose; + interpolation; +\} :pre + +{U} = name of the finite volume fluid velocity field :ulb,l +{voidfraction} = name of the finite volume void fraction field :l +{minVoidfraction} = minimum void fraction value to ensure meaningful interpolated void fraction (default = 0.1) :l +{Us} = name of the finite volume cell averaged particle velocity field :l + +{useFilteredDragModel} = switch for using a coarsening correction for the Beetstra drag model (takes grid-size effects into account; default = off) :l + +{gravity} = gravity value (default = 9.81) :l +{dPrimValue} = diameter of primary particle :l +{rhoPValue} = particle density :l +{rhoValue} = finite volume density :l +{nufValue} = kinematic viscosity :l + +{useParcelSizeDependentFilteredDrag} = switch for using a coarsening correction for the Beetstra drag model (only used if {useFilteredDragModel} is on; default = off) :l + +{kValue} = factor for parcels size effect (default = 0.05; must be defined if useParcelSizeDependentFilteredDrag is used) :l + +{interpolation} = flag to use interpolated void fraction and fluid velocity values (normally off) :l +{treatForceExplicit} = switch to force explicit treatment of force (normally off) :l +{implForceDEM} = flag to use implicit formulation of drag on DEM side (normally off, if on, this switch will force {treatForceExplicit} to be off) :l +{verbose} = switch to force display of data on screen (default: off; typically used for debug purposes) :l +:ule + +[Examples:] + +forceModels +( + BeetstraDrag +); +BeetstraDragProps +\{ + velFieldName "U"; + voidfractionFieldName "voidfraction"; + granVelFieldName "Us"; + interpolation true; + useFilteredDragModel; + g 9.81; + dPrim 100e-6; + rhoP 7000.; + rho 10.; + nuf 1.5e-4; + useParcelSizeDependentFilteredDrag; + k 0.05; +\} :pre + +[Description:] + +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {BeetstraDrag} model is a +model that calculates the particle based drag force following the correlation of +"Beetstra et al. (2007)"_#Beetstra2007. +The filtered drag model is based on "Radl and Sundaresan (2014)"_#Radl2014. + +[Restrictions:] + +This model is strictly valid only for monodisperse gas-particle flows. +For the polydisperse model of "Beetstra et al. (2007)"_#Beetstra2007 use +{BeetstraDragPoly}. + +[Related commands:] + +"forceModel"_forceModel.html, BeetstraDragPoly + +:line + +:link(Beetstra2007) +[(Beetstra, 2007)] +Beetstra, R., van der Hoef, M. A. and Kuipers J. A. M., +"Drag force of intermediate Reynolds number flow past mono- and bidisperse arrays of spheres", +AIChE J., 53(2) (2007) + +:link(Radl2014) +[(Radl, 2014)] Radl, S. and Sundaresan, S., +"A drag model for filtered Euler-Lagrange simulations of clustered gas-particle suspensions", +Chem. Eng. Sci., 117, pp. 416-425 (2014) + diff --git a/doc/forceModel_DiFeliceDrag.html b/doc/forceModel_DiFeliceDrag.html deleted file mode 100644 index 53a2aebf..00000000 --- a/doc/forceModel_DiFeliceDrag.html +++ /dev/null @@ -1,56 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_DiFeliceDrag command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    DiFeliceDrag
    -);
    -DiFeliceDragProps
    -{
    -    velFieldName "U";
    -    interpolation switch1;
    -}; 
    -
    -
    • U = name of the finite volume fluid velocity field - -
    • switch1 = flag to use interpolated voidfraction and velocity values (normally off) - - -
    -

    Examples: -

    -
    forceModels
    -(
    -    DiFeliceDrag
    -);
    -DiFeliceDragProps
    -{
    -    velFieldName "U";
    -    interpolation true;
    -} 
    -
    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The DiFeliceDrag model is a model that calculates the particle based drag force following the correlation of Di Felice (see Zhou et al. (2010), JFM). -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_DiFeliceDrag.txt b/doc/forceModel_DiFeliceDrag.txt index 77e6e4ba..7fe5396d 100644 --- a/doc/forceModel_DiFeliceDrag.txt +++ b/doc/forceModel_DiFeliceDrag.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_DiFeliceDrag command :h3 +forceModel DiFeliceDrag command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -17,12 +18,29 @@ forceModels ); DiFeliceDragProps \{ - velFieldName "U"; - interpolation switch1; -\}; :pre + velFieldName "U"; + voidfractionFieldName "voidfraction"; + granVelFieldName "Us"; + scale scalar1; + scaleDrag scalar2; + treatForceExplicit switch1; + implForceDEM switch2; + verbose switch3; + interpolation switch4; + scalarViscosity switch5; +\} :pre {U} = name of the finite volume fluid velocity field :ulb,l -{switch1} = flag to use interpolated voidfraction and velocity values (normally off) :l +{voidfraction} = name of the finite volume void fraction field :l +{Us} = name of the finite volume granular velocity field :l +{scalar1} = (optional) scaling of particle diameter: d_sim=scale*d_real. d_sim=(potentially coarse-grained) particle diameter. +scale=coarse-graining factor. d_real= particle diameter as it is measured. :l +{scalar2} = (optional) scaling factor which directly scales the drag force. :l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch2} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch3} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch4} = (optional, default false) flag to use interpolated void fraction and velocity values :l +{switch5} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l :ule [Examples:] @@ -33,17 +51,20 @@ forceModels ); DiFeliceDragProps \{ - velFieldName "U"; + velFieldName "U"; interpolation true; \} :pre [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The DiFeliceDrag model is a model that calculates the particle based drag force following the correlation of Di Felice (see Zhou et al. (2010), JFM). +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {DiFeliceDrag} model is a +model that calculates the particle based drag force following the correlation of +Di Felice (see Zhou et al. (2010), JFM). [Restrictions:] -none. +none [Related commands:] diff --git a/doc/forceModel_GidaspowDrag.html b/doc/forceModel_GidaspowDrag.html deleted file mode 100644 index 9aa7318d..00000000 --- a/doc/forceModel_GidaspowDrag.html +++ /dev/null @@ -1,68 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_GidaspowDrag command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    GidaspowDrag
    -);
    -GidaspowDragProps
    -{
    -    velFieldName "U";
    -    voidfractionFieldName "voidfraction";
    -    granVelFieldName "Us";
    -    phi "scalar";
    -    interpolation switch1;
    -    implForceDEM switch2;
    -}; 
    -
    -
    • U = name of the finite volume fluid velocity field - -
    • voidfraction = name of the finite volume voidfraction field - -
    • Us = name of the finite volume cell averaged particle velocity field - -
    • phi = drag correction factor (in doubt 1) - -
    • switch1 = (optional, normally off) flag to use interpolated voidfraction and fluid velocity values - -switch2 = (optional, normally off) flag to use implicit formulation of drag on DEM side:l - -
    -

    Examples: -

    -
    forceModels
    -(
    -    GidaspowDrag
    -);
    -GidaspowDragProps
    -{
    -    velFieldName "U";
    -    voidfractionFieldName "voidfraction";
    -    granVelFieldName "Us";
    -} 
    -
    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The GidaspowDrag model is a model that calculates the particle based drag force following the correlation of Gidaspow which is a combination of Ergun (1952) and Wen & Yu (1966) (see Zhu et al. (2007): "Discrete particle simulation of particulate systems: Theoretical developments", ChemEngScience). -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_GidaspowDrag.txt b/doc/forceModel_GidaspowDrag.txt index 452c67f1..2905df7b 100644 --- a/doc/forceModel_GidaspowDrag.txt +++ b/doc/forceModel_GidaspowDrag.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_GidaspowDrag command :h3 +forceModel GidaspowDrag command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -17,20 +18,32 @@ forceModels ); GidaspowDragProps \{ - velFieldName "U"; + velFieldName "U"; voidfractionFieldName "voidfraction"; - granVelFieldName "Us"; - phi "scalar"; - interpolation switch1; - implForceDEM switch2; -\}; :pre + granVelFieldName "Us"; + phi scalar1; + scale scalar2; + scaleDrag scalar3; + switchingVoidfraction scalar4; + treatForceExplicit switch1; + implForceDEM switch2; + verbose switch3; + interpolation switch4; + scalarViscosity switch5; +\} :pre {U} = name of the finite volume fluid velocity field :ulb,l -{voidfraction} = name of the finite volume voidfraction field :l +{voidfraction} = name of the finite volume void fraction field :l {Us} = name of the finite volume cell averaged particle velocity field :l -{phi} = drag correction factor (in doubt 1) :l -{switch1} = (optional, normally off) flag to use interpolated voidfraction and fluid velocity values :l -{switch2} = (optional, normally off) flag to use implicit formulation of drag on DEM side:l +{scalar1} = drag correction factor (in doubt 1) :l +{scalar2} = (optional, default 1.0) scaling of particle diameter: d_sim=scale*d_real. d_sim=(potentially coarse-grained) particle diameter. scale=coarse-graining factor. d_real= particle diameter as it is measured. :l +{scalar3} = (optional, default 1.0) scaling of drag law :l +{scalar4} = (optional, default 0.8) void fraction above which dilute formulation will be used :l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch2} = (optional, default false) flag to use implicit formulation of drag on DEM side :l +{switch3} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch4} = (optional, default false) flag to use interpolated void fraction and fluid velocity values :l +{switch5} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l :ule [Examples:] @@ -41,18 +54,23 @@ forceModels ); GidaspowDragProps \{ - velFieldName "U"; + velFieldName "U"; voidfractionFieldName "voidfraction"; - granVelFieldName "Us"; + granVelFieldName "Us"; \} :pre [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The GidaspowDrag model is a model that calculates the particle based drag force following the correlation of Gidaspow which is a combination of Ergun (1952) and Wen & Yu (1966) (see Zhu et al. (2007): "Discrete particle simulation of particulate systems: Theoretical developments", ChemEngScience). +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {GidaspowDrag} model is a +model that calculates the particle based drag force following the correlation of +Gidaspow which is a combination of Ergun (1952) and Wen & Yu (1966) +(see Zhu et al. (2007): "Discrete particle simulation of particulate systems: +Theoretical developments", ChemEngScience). [Restrictions:] -none. +none [Related commands:] diff --git a/doc/forceModel_KochHillDrag.html b/doc/forceModel_KochHillDrag.html deleted file mode 100644 index 1cf16d96..00000000 --- a/doc/forceModel_KochHillDrag.html +++ /dev/null @@ -1,61 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_KochHillDrag command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    KochHillDrag
    -);
    -KochHillDragProps
    -{
    -    velFieldName "U";
    -    voidfractionFieldName "voidfraction"; 
    -    interpolation "bool1";
    -    implForceDEM "bool2";
    -}; 
    -
    -
    • U = name of the finite volume fluid velocity field - -
    • voidfraction = name of the finite volume voidfraction field - -
    • bool1 = (optional, normally off) flag to use interpolated voidfraction and fluid velocity values - -bool2 = (optional, normally off) flag to use implicit formulation of drag on DEM side:l - -
    -

    Examples: -

    -
    forceModels
    -(
    -    KochHillDrag
    -);
    -KochHillDragProps
    -{
    -    velFieldName "U";
    -    voidfractionFieldName "voidfraction"; 
    -} 
    -
    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The KochHillDrag model is a model that calculates the particle based drag force following the correlation of Koch & Hill (2001) (see van Buijtenen et al. (2011): "Numerical and experimental study on multiple-spout fluidized beds", ChemEngScience). -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_KochHillDrag.txt b/doc/forceModel_KochHillDrag.txt index 0737bb22..190de60d 100644 --- a/doc/forceModel_KochHillDrag.txt +++ b/doc/forceModel_KochHillDrag.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_KochHillDrag command :h3 +forceModel KochHillDrag command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -17,16 +18,26 @@ forceModels ); KochHillDragProps \{ - velFieldName "U"; - voidfractionFieldName "voidfraction"; - interpolation "bool1"; - implForceDEM "bool2"; -\}; :pre + velFieldName "U"; + voidfractionFieldName "voidfraction"; + granVelFieldName "Us" + treatForceExplicit switch1; + implForceDEM switch2; + verbose switch3; + interpolation switch4; + implForceDEMaccumulated switch5; + scalarViscosity switch6; +\} :pre {U} = name of the finite volume fluid velocity field :ulb,l -{voidfraction} = name of the finite volume voidfraction field :l -{bool1} = (optional, normally off) flag to use interpolated voidfraction and fluid velocity values :l -{bool2} = (optional, normally off) flag to use implicit formulation of drag on DEM side:l +{voidfraction} = name of the finite volume void fraction field :l +{Us} = (optional, default "Us") name of finite volume granular velocity field :l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch2} = (optional, default false) flag to use implicit formulation of drag on DEM side :l +{switch3} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch4} = (optional, default false) flag to use interpolated void fraction and fluid velocity values :l +{switch5} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch6} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l :ule [Examples:] @@ -38,16 +49,20 @@ forceModels KochHillDragProps \{ velFieldName "U"; - voidfractionFieldName "voidfraction"; + voidfractionFieldName "voidfraction"; \} :pre [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The KochHillDrag model is a model that calculates the particle based drag force following the correlation of Koch & Hill (2001) (see van Buijtenen et al. (2011): "Numerical and experimental study on multiple-spout fluidized beds", ChemEngScience). +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {KochHillDrag} model is a +model that calculates the particle based drag force following the correlation of +Koch & Hill (2001) (see van Buijtenen et al. (2011): "Numerical and experimental +study on multiple-spout fluidized beds", ChemEngScience). [Restrictions:] -none. +none [Related commands:] diff --git a/doc/forceModel_LaEuScalarTemp.html b/doc/forceModel_LaEuScalarTemp.html deleted file mode 100644 index 778d3e32..00000000 --- a/doc/forceModel_LaEuScalarTemp.html +++ /dev/null @@ -1,82 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_LaEuScalarTemp command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    LaEuScalarTemp
    -);
    -LaEuScalarTempProps
    -{
    -    velFieldName "U";
    -    tempFieldName "T";
    -    voidfractionFieldName "voidfraction";
    -    partTempName "Temp";
    -    partHeatFluxName "convectiveHeatFlux";
    -    lambda value;
    -    Cp value1;
    -    interpolation "switch1";
    -    verbose "switch2";
    -}; 
    -
    -
    • U = name of the finite volume fluid velocity field - -
    • T = name of the finite volume scalar temperature field - -
    • voidfraction = name of the finite volume voidfraction field - -
    • Temp = name of the DEM data representing the particles temperature - -
    • convectiveHeatFlux = name of the DEM data representing the particle-fluid convective heat flux - -
    • value = fluid thermal conductivity [W/(m*K)] - -
    • value1 = fluid specific heat capacity [W*s/(kg*K)] - -
    • switch1 = (optional, normally off) flag to use interpolated voidfraction and fluid velocity values - -
    • switch2 = (normally off) for verbose run - - -
    -

    Examples: -

    -
    forceModels
    -(
    -    LaEuScalarTemp
    -);
    -LaEuScalarTempProps
    -{
    -    velFieldName "U";
    -    tempFieldName "T";
    -    voidfractionFieldName "voidfraction";
    -    partTempName "Temp";
    -    partHeatFluxName "convectiveHeatFlux";
    -    lambda 0.0256;
    -    Cp 1007;
    -} 
    -
    -

    Description: -

    -

    This "forceModel" does not influence the particles or the fluid flow! Using the particles' temperature a scalar field representing "particle-fluid heatflux" is calculated. The solver then uses this source field in the scalar transport equation for the temperature. The model for convective heat transfer is based on Li and Mason (2000), A computational investigation of transient heat transfer in pneumatic transport of granular particles, Pow.Tech 112 -

    -

    Restrictions: -

    -

    Goes only with cfdemSolverScalar. The force model has to be the second (!!!) model in the forces list. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_LaEuScalarTemp.txt b/doc/forceModel_LaEuScalarTemp.txt index 307693c7..2be22fee 100644 --- a/doc/forceModel_LaEuScalarTemp.txt +++ b/doc/forceModel_LaEuScalarTemp.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_LaEuScalarTemp command :h3 +forceModel LaEuScalarTemp command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -17,26 +18,30 @@ forceModels ); LaEuScalarTempProps \{ - velFieldName "U"; - tempFieldName "T"; + velFieldName "U"; + tempFieldName "T"; voidfractionFieldName "voidfraction"; - partTempName "Temp"; - partHeatFluxName "convectiveHeatFlux"; - lambda value; - Cp value1; - interpolation "switch1"; - verbose "switch2"; -\}; :pre + partTempName "Temp"; + partHeatFluxName "convectiveHeatFlux"; + lambda scalar1; + Cp scalar2; + maxSource scalar3; + verbose switch1; + interpolation switch2; + scalarViscosity switch3; +\} :pre {U} = name of the finite volume fluid velocity field :ulb,l {T} = name of the finite volume scalar temperature field :l -{voidfraction} = name of the finite volume voidfraction field :l +{voidfraction} = name of the finite volume void fraction field :l {Temp} = name of the DEM data representing the particles temperature :l {convectiveHeatFlux} = name of the DEM data representing the particle-fluid convective heat flux :l -{value} = fluid thermal conductivity \[W/(m*K)\] :l -{value1} = fluid specific heat capacity \[W*s/(kg*K)\] :l -{switch1} = (optional, normally off) flag to use interpolated voidfraction and fluid velocity values :l -{switch2} = (normally off) for verbose run :l +{scalar1} = fluid thermal conductivity \[W/(m*K)\] :l +{scalar2} = fluid specific heat capacity \[W*s/(kg*K)\] :l +{scalar3} = (optional, default 1e30) limit maximal turbulence :l +{switch1} = (optional, default false) for verbose run :l +{switch2} = (optional, default false) flag to use interpolated void fraction and fluid velocity values :l +{switch3} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l :ule [Examples:] @@ -47,22 +52,28 @@ forceModels ); LaEuScalarTempProps \{ - velFieldName "U"; - tempFieldName "T"; + velFieldName "U"; + tempFieldName "T"; voidfractionFieldName "voidfraction"; - partTempName "Temp"; - partHeatFluxName "convectiveHeatFlux"; - lambda 0.0256; - Cp 1007; + partTempName "Temp"; + partHeatFluxName "convectiveHeatFlux"; + lambda 0.0256; + Cp 1007; \} :pre [Description:] -This "forceModel" does not influence the particles or the fluid flow! Using the particles' temperature a scalar field representing "particle-fluid heatflux" is calculated. The solver then uses this source field in the scalar transport equation for the temperature. The model for convective heat transfer is based on Li and Mason (2000), A computational investigation of transient heat transfer in pneumatic transport of granular particles, Pow.Tech 112 +This "force model" does not influence the particles or the fluid flow! Using the +particles' temperature a scalar field representing "particle-fluid heat flux" is +calculated. The solver then uses this source field in the scalar transport +equation for the temperature. The model for convective heat transfer is based on +Li and Mason (2000), A computational investigation of transient heat transfer in +pneumatic transport of granular particles, Pow.Tech 112 [Restrictions:] -Goes only with cfdemSolverScalar. The force model has to be the second (!!!) model in the forces list. +Goes only with cfdemSolverPisoScalar. The force model has to be the second (!!!) +model in the forces list. [Related commands:] diff --git a/doc/forceModel_MeiLift.html b/doc/forceModel_MeiLift.html deleted file mode 100644 index e21aa8b2..00000000 --- a/doc/forceModel_MeiLift.html +++ /dev/null @@ -1,64 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_MeiLift command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    MeiLift
    -);
    -MeiLiftProps
    -{
    -    velFieldName "U";
    -    useSecondOrderTerms;
    -    interpolation "switch1";
    -    verbose "switch2";
    -}; 
    -
    -
    • U = name of the finite volume fluid velocity field - -
    • useSecondOrderTerms = switch to activate second order terms in the lift force model - -
    • switch1 = switch to activate tri-linear interpolation of the flow quantities at the particle position - -
    • switch2 = switch to activate the report of per-particle quantities to the screen - - -
    -

    Examples: -

    -
    forceModels
    -(
    -    MeiLift
    -);
    -MeiLiftProps
    -{
    -    velFieldName "U";
    -    useSecondOrderTerms;
    -    interpolation true;
    -    verbose true;
    -} 
    -
    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The MeiLift model calculates the lift force for each particle based on Loth and Dorgan (2009). In case the keyword "useSecondOrderTerms" is not specified, this lift force model uses the expression of McLaughlin (1991, Journal of Fluid Mechanics 224:261-274). -

    -

    Restrictions: -

    -

    None. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_MeiLift.txt b/doc/forceModel_MeiLift.txt index 205a5978..de006c5b 100644 --- a/doc/forceModel_MeiLift.txt +++ b/doc/forceModel_MeiLift.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_MeiLift command :h3 +forceModel MeiLift command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -17,16 +18,20 @@ forceModels ); MeiLiftProps \{ - velFieldName "U"; + velFieldName "U"; useSecondOrderTerms; - interpolation "switch1"; - verbose "switch2"; -\}; :pre + treatForceExplicit switch1; + verbose switch2; + interpolation switch3; + scalarViscosity switch4; +\} :pre {U} = name of the finite volume fluid velocity field :ulb,l -{useSecondOrderTerms} = switch to activate second order terms in the lift force model :l -{switch1} = switch to activate tri-linear interpolation of the flow quantities at the particle position :l -{switch2} = switch to activate the report of per-particle quantities to the screen :l +{useSecondOrderTerms} = (optional, default false) switch to activate second order terms in the lift force model :l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch2} = (optional, default false) switch to activate the report of per-particle quantities to the screen :l +{switch3} = (optional, default false) switch to activate tri-linear interpolation of the flow quantities at the particle position :l +{switch4} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l :ule [Examples:] @@ -37,19 +42,23 @@ forceModels ); MeiLiftProps \{ - velFieldName "U"; + velFieldName "U"; useSecondOrderTerms; - interpolation true; - verbose true; + interpolation true; + verbose true; \} :pre [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The MeiLift model calculates the lift force for each particle based on Loth and Dorgan (2009). In case the keyword "useSecondOrderTerms" is not specified, this lift force model uses the expression of McLaughlin (1991, Journal of Fluid Mechanics 224:261-274). +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {MeiLift} model calculates +the lift force for each particle based on Loth and Dorgan (2009). In case the +keyword "useSecondOrderTerms" is not specified, this lift force model uses the +expression of McLaughlin (1991, J. Fluid Mech. 224:261-274). [Restrictions:] -None. +none [Related commands:] diff --git a/doc/forceModel_SchillerNaumannDrag.html b/doc/forceModel_SchillerNaumannDrag.html deleted file mode 100644 index 7ff1ecae..00000000 --- a/doc/forceModel_SchillerNaumannDrag.html +++ /dev/null @@ -1,52 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_SchillerNaumannDrag command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    SchillerNaumannDrag
    -);
    -SchillerNaumannDragProps
    -{
    -    velFieldName "U";
    -}; 
    -
    -
    • U = name of the finite volume fluid velocity field - - -
    -

    Examples: -

    -
    forceModels
    -(
    -    SchillerNaumannDrag
    -);
    -SchillerNaumannDragProps
    -{
    -    velFieldName "U";
    -} 
    -
    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The SchillerNaumannDrag model is a model that calculates the particle based drag force following the correlation of Schiller and Naumann. -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_SchillerNaumannDrag.txt b/doc/forceModel_SchillerNaumannDrag.txt index aaa1c8a8..7c243739 100644 --- a/doc/forceModel_SchillerNaumannDrag.txt +++ b/doc/forceModel_SchillerNaumannDrag.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_SchillerNaumannDrag command :h3 +forceModel SchillerNaumannDrag command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -18,9 +19,11 @@ forceModels SchillerNaumannDragProps \{ velFieldName "U"; -\}; :pre + treatForceExplicit switch1; +\} :pre {U} = name of the finite volume fluid velocity field :ulb,l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l :ule [Examples:] @@ -36,11 +39,14 @@ SchillerNaumannDragProps [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The SchillerNaumannDrag model is a model that calculates the particle based drag force following the correlation of Schiller and Naumann. +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {SchillerNaumannDrag} model +is a model that calculates the particle based drag force following the +correlation of Schiller and Naumann. [Restrictions:] -none. +none [Related commands:] diff --git a/doc/forceModel_ShirgaonkarIB.html b/doc/forceModel_ShirgaonkarIB.html deleted file mode 100644 index 27e0ddc4..00000000 --- a/doc/forceModel_ShirgaonkarIB.html +++ /dev/null @@ -1,60 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_ShirgaonkarIB command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    ShirgaonkarIB
    -);
    -ShirgaonkarIBProps
    -{
    -    velFieldName "U";
    -    pressureFieldName "pressure";
    -}; 
    -
    -
    • U = name of the finite volume fluid velocity field - -
    • pressure = name of the finite volume pressure field - - -
    -

    Examples: -

    -
    forceModels
    -(
    -    ShirgaonkarIB
    -);
    -ShirgaonkarIBProps
    -{
    -    velFieldName "U";
    -    pressureFieldName "p";
    -} 
    -
    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The ShirgaonkarIB model calculates the drag force (viscous and pressure force) acting on each particle in a resolved manner (see Shirgaonkar et al. (2009): "A new mathematical formulation and fast algorithm for fully resolved simulation of self-propulsion", Journal of Comp. Physics). This model is only suited for resolved CFD-DEM simulations where the particle is represented by immersed boundary method. -

    -

    References: -

    -

    SHIRGAONKAR, A.A., MACIVER, M.A. and PATANKAR, N.A., (2009), “A new mathematical formulation and fast algorithm for fully resolved simulation of self-propulsion”, J. Comput. Phys., 228, 2366-2390. -

    -

    Restrictions: -

    -

    Only for immersed boundary solvers. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_ShirgaonkarIB.txt b/doc/forceModel_ShirgaonkarIB.txt index 87cae6ce..313b18c3 100644 --- a/doc/forceModel_ShirgaonkarIB.txt +++ b/doc/forceModel_ShirgaonkarIB.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_ShirgaonkarIB command :h3 +forceModel ShirgaonkarIB command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -17,12 +18,16 @@ forceModels ); ShirgaonkarIBProps \{ - velFieldName "U"; + velFieldName "U"; pressureFieldName "pressure"; -\}; :pre + twoDimensional; + treatForceExplicit switch1; +\} :pre {U} = name of the finite volume fluid velocity field :ulb,l {pressure} = name of the finite volume pressure field :l +{twoDimensional} = optional keyword for conducting a two dimensional calculation :l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l :ule [Examples:] @@ -39,11 +44,12 @@ ShirgaonkarIBProps [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The ShirgaonkarIB model calculates the drag force (viscous and pressure force) acting on each particle in a resolved manner (see Shirgaonkar et al. (2009): "A new mathematical formulation and fast algorithm for fully resolved simulation of self-propulsion", Journal of Comp. Physics). This model is only suited for resolved CFD-DEM simulations where the particle is represented by immersed boundary method. - -[References:] - -SHIRGAONKAR, A.A., MACIVER, M.A. and PATANKAR, N.A., (2009), “A new mathematical formulation and fast algorithm for fully resolved simulation of self-propulsion”, J. Comput. Phys., 228, 2366-2390. +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {ShirgaonkarIB} model +calculates the drag force (viscous and pressure force) acting on each particle +in a resolved manner (see "Shirgaonkar et al. (2009)"_#Shirgaonkar2009). +This model is only suited for resolved CFD-DEM simulations where +the particle is represented by immersed boundary method. [Restrictions:] @@ -53,3 +59,11 @@ Only for immersed boundary solvers. "forceModel"_forceModel.html +:line + +:link(Shirgaonkar2009) +[(Shirgaonkar, 2009)] Shirgaonkar, A. A., MacIver, M. A. and Patankar, N. A., (2009), +"A new mathematical formulation and fast algorithm for fully resolved simulation +of self-propulsion", J. Comput. Phys., 228, pp. 2366-2390. + + diff --git a/doc/forceModel_dSauter.html b/doc/forceModel_dSauter.html deleted file mode 100644 index 4f8050e3..00000000 --- a/doc/forceModel_dSauter.html +++ /dev/null @@ -1,47 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_dSauter command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    dSauter
    -);
    -dSauterProps
    -{
    -    coarseGrainingFactors
    -    (
    -        X Y Z
    -    );
    -}; 
    -
    -
    • coarseGrainingFactors = list of coarse graining factors by type, separated by whitespace, optional - - -
    -

    Description: -

    -

    This "forceModel" does not influence the particles or the flow - it calculates the Sauter diameter -

    -
    -
    -

    . -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    forceModel

    - diff --git a/doc/forceModel_dSauter.txt b/doc/forceModel_dSauter.txt index 478c8dbd..298d0eb7 100644 --- a/doc/forceModel_dSauter.txt +++ b/doc/forceModel_dSauter.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_dSauter command :h3 +forceModel dSauter command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -21,15 +22,16 @@ dSauterProps ( X Y Z ); -\}; :pre - -{coarseGrainingFactors} = list of coarse graining factors by type, separated by whitespace, optional :ulb,l +\} :pre +{coarseGrainingFactors} = list of coarse graining factors by type, separated by +whitespace, optional :ulb,l :ule [Description:] -This "forceModel" does not influence the particles or the flow - it calculates the Sauter diameter +This "force model" does not influence the particles or the flow - it calculates +the Sauter diameter :c,image(Eqs/d32.png) . @@ -37,8 +39,9 @@ This "forceModel" does not influence the particles or the flow - it calculates t [Restrictions:] -none. +none [Related commands:] -"forceModel"_forceModel.html \ No newline at end of file +"forceModel"_forceModel.html + diff --git a/doc/forceModel_fieldStore.html b/doc/forceModel_fieldStore.html deleted file mode 100644 index d21cbcb9..00000000 --- a/doc/forceModel_fieldStore.html +++ /dev/null @@ -1,68 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_fieldStore command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    fieldStore
    -);
    -fieldStoreProps
    -{
    -    scalarFieldNames
    -    (
    -        "scalarField"
    -    );
    -    vectorFieldNames
    -    (
    -        "vectorField"
    -    );
    -}; 
    -
    -
    • scalarField = names of the finite volume scalar fields to be stored - -
    • vectorField = names of the finite volume vector fields to be stored - - -
    -

    Examples: -

    -
    forceModels
    -(
    -    fieldStore
    -);
    -fieldStoreProps
    -{
    -    scalarFieldNames
    -    (
    -        "voidfraction"
    -    );
    -    vectorFieldNames
    -    (
    -        "U"
    -    );
    -} 
    -
    -

    Description: -

    -

    This "forceModel" does not influence the particles or the flow - it is a tool to store a scalar/vector field! This is especially useful if you use a boundary condition which cannot interpreted correctly in your postporcessor (e.g. paraview). -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_fieldStore.txt b/doc/forceModel_fieldStore.txt index 2e8af443..b52d75ee 100644 --- a/doc/forceModel_fieldStore.txt +++ b/doc/forceModel_fieldStore.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_fieldStore command :h3 +forceModel fieldStore command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -25,7 +26,7 @@ fieldStoreProps ( "vectorField" ); -\}; :pre +\} :pre {scalarField} = names of the finite volume scalar fields to be stored :ulb,l {vectorField} = names of the finite volume vector fields to be stored :l @@ -51,11 +52,13 @@ fieldStoreProps [Description:] -This "forceModel" does not influence the particles or the flow - it is a tool to store a scalar/vector field! This is especially useful if you use a boundary condition which cannot interpreted correctly in your postporcessor (e.g. paraview). +This "force model" does not influence the particles or the flow - it is a tool +to store a scalar/vector field! This is especially useful if you use a boundary +condition which cannot interpreted correctly in your post-processor (e.g. paraview). [Restrictions:] -none. +none [Related commands:] diff --git a/doc/forceModel_fieldTimeAverage.txt b/doc/forceModel_fieldTimeAverage.txt new file mode 100644 index 00000000..e2c454f9 --- /dev/null +++ b/doc/forceModel_fieldTimeAverage.txt @@ -0,0 +1,70 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +forceModel fieldTimeAverage command :h3 + +[Syntax:] + +Defined in couplingProperties dictionary. + +forceModels +( + fieldTimeAverage +); +fieldTimeAverageProps +\{ + startTime time; + scalarFieldNames + ( + "scalarField" + ); + vectorFieldNames + ( + "vectorField" + ); +\} :pre + +{time} = (optional) time to start temporal averaging :ulb,l +{scalarField} = names of the finite volume scalar fields to be temporally averaged :l +{vectorField} = names of the finite volume vector fields to be temporally averaged :l +:ule + +[Examples:] + +forceModels +( + fieldTimeAverage +); +fieldTimeAverageProps +\{ + startTime 1.0; + scalarFieldNames + ( + "voidfraction" + ); + vectorFieldNames + ( + "Us" + ); +\} :pre + +[Description:] + +This "force model" does not influence the particles or the simulation - it is a +post-processing tool! Starting at start time the specified fields are temporally +averaged and written at "writeTime". They can then be probed using standard +function object probes. The output name is timeAverage_scalarField, where +scalarField is the name of the original field. + +[Restrictions:] + +none + +[Related commands:] + +"forceModel"_forceModel.html + diff --git a/doc/forceModel_gradPForce.html b/doc/forceModel_gradPForce.html deleted file mode 100644 index 661b4a0e..00000000 --- a/doc/forceModel_gradPForce.html +++ /dev/null @@ -1,60 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_gradPForce command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    gradPForce;
    -);
    -gradPForceProps
    -{
    -    pFieldName "pressure";
    -    velocityFieldName "U";
    -    interpolation switch1;
    -}; 
    -
    -
    • pressure = name of the finite volume fluid pressure field - -
    • U = name of the finite volume fluid velocity field - -
    • switch1 = flag to use interpolated pressure values (normally off) - - -
    -

    Examples: -

    -
    forceModels
    -(
    -    gradPForce;
    -);
    -gradPForceProps
    -{
    -    pFieldName "p";
    -    velocityFieldName "U";
    -    interpolation true;
    -} 
    -
    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The gradPForce model is a model that calculates the particle based pressure gradient force -(grad(p)) * Vparticle (see Zhou et al. (2010): "Discrete particle simulation of particle-fluid flow: model formulations and their applicability" ,JFM). -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_gradPForce.txt b/doc/forceModel_gradPForce.txt index 68a8b30c..c9db690d 100644 --- a/doc/forceModel_gradPForce.txt +++ b/doc/forceModel_gradPForce.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_gradPForce command :h3 +forceModel gradPForce command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -17,14 +18,20 @@ forceModels ); gradPForceProps \{ - pFieldName "pressure"; - velocityFieldName "U"; - interpolation switch1; -\}; :pre + pFieldName "pressure"; + velocityFieldName "U"; + useAddedMass scalar1; + treatForceExplicit switch1; + treatForceDEM switch2; + interpolation switch3; +\} :pre {pressure} = name of the finite volume fluid pressure field :ulb,l {U} = name of the finite volume fluid velocity field :l -{switch1} = flag to use interpolated pressure values (normally off) :l +{scalar1} = (optional, default 0) coefficient of added mass accounted for :l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch2} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch3} = (optional, default false) flag to use interpolated pressure values :l :ule [Examples:] @@ -35,18 +42,22 @@ forceModels ); gradPForceProps \{ - pFieldName "p"; + pFieldName "p"; velocityFieldName "U"; - interpolation true; + interpolation true; \} :pre [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The gradPForce model is a model that calculates the particle based pressure gradient force -(grad(p)) * Vparticle (see Zhou et al. (2010): "Discrete particle simulation of particle-fluid flow: model formulations and their applicability" ,JFM). +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {gradPForce} model is a +model that calculates the particle based pressure gradient force -(grad(p)) * +Vparticle (see Zhou et al. (2010): "Discrete particle simulation of +particle-fluid flow: model formulations and their applicability", J. Fluid Mech.). [Restrictions:] -none. +none [Related commands:] diff --git a/doc/forceModel_gradPForceSmooth.txt b/doc/forceModel_gradPForceSmooth.txt new file mode 100644 index 00000000..2b97c1ec --- /dev/null +++ b/doc/forceModel_gradPForceSmooth.txt @@ -0,0 +1,77 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +forceModel gradPForceSmooth command :h3 + +[Syntax:] + +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. + +forceModels +( + gradPForceSmooth; +); +gradPForceSmoothProps +\{ + pFieldName "pressure"; + velocityFieldName "U"; + useAddedMass scalar1; + treatForceExplicit switch1; + treatForceDEM switch2; + interpolation switch3; + smoothingModel "smoothingModel"; +\} :pre + +{pressure} = name of the finite volume fluid pressure field :ulb,l +{U} = name of the finite volume fluid velocity field :l +{scalar1} = (optional, default 0) coefficient of added mass accounted for :l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch2} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch3} = (optional, default false) flag to use interpolated pressure values :l +{smoothingModel} = name of smoothing model :l +:ule + +[Examples:] + +forceModels +( + gradPForceSmooth; +); +gradPForceSmoothProps +\{ + pFieldName "p_rgh"; + velocityFieldName "U"; + interpolation false; + smoothingModel "temporalSmoothing"; + temporalSmoothingProps + \{ + lowerLimit 0.1; + upperLimit 1e10; + refField "p_rgh"; + gamma 1.0; + \} :pre + +\} :pre +[Description:] + +The {gradPForceSmooth} model calculates the particle based pressure gradient +force identically to the "gradPForce"_forceModel_gradPForce.html model but +allows smoothing of the pressure prior to the force calculation (without +altering the original pressure field). +Any smoothing model can be used and does not have to be the same as specified in +couplingProperties. Properties for the smoothing model have to be specified in a +sub-dictionary within {gradPForceSmoothProps}. + +[Restrictions:] + +A volScalarField "pSmooth" MUST be specified in the initial time directory! + +[Related commands:] + +"forceModel"_forceModel.html, "gradPForce"_forceModel_gradPForce.html + diff --git a/doc/forceModel_interface.txt b/doc/forceModel_interface.txt new file mode 100644 index 00000000..45e07755 --- /dev/null +++ b/doc/forceModel_interface.txt @@ -0,0 +1,85 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +forceModel interface command :h3 + +[Syntax:] + +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. + +forceModels +( + interface +); +interfaceProps +\{ + VOFvoidfractionFieldName "alpha"; + gradAlphaName "gradAlpha"; + alphaThreshold scalar1; + sigma scalar2; + theta scalar3; + deltaAlphaIn scalar4; + deltaAlphaOut scalar5; + C scalar6; + treatForceExplicit switch1; +\} :pre + +{alpha} = name of the finite volume fluid volume fraction field in a VOF simulation :ulb,l +{gradAlpha} = name of gradient fluid volume fraction field :l +{scalar1} = parameter used to define the distance of influence of the model :l +{scalar2} = fluid gas surface tension :l +{scalar3} = Three-phase contact angle for interface force :l +{scalar4} = delta value subtracted from alphaThreshold :l +{scalar5} = delta value added to alphaThreshold :l +{scalar6} = (optional, default 1.0) factor to scale interfacial force :l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +:ule + +[Examples:] + +forceModels +( + interface +); +interfaceProps +\{ + VOFvoidfractionFieldName "alpha"; + gradAlphaName "gradAlpha"; + alphaThreshold 0.55; + sigma 0.07; + theta 1.12; + deltaAlphaIn 0.05; + deltaAlphaOut 0.05; +\} :pre + +[Description:] + +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {interface} model is a +model that calculates the particle-fluid-gas interfacial force. +(see "Wierink et al. (2011)"_#Wierink2011) + +[Restrictions:] + +Only for VOF simulations. + +[Related commands:] + +"forceModel"_forceModel.html + +:line + +:link(Wierink2011) +[(Wierink 2011)] +"Mechanistic modelling of particle interface interaction in three phase flows", +Wierink G., Goniva C., Niceno B., Heiskanen K., +Proc. of the 8th Int. Conf. on CFD in Oil and Gas, Metallurgical and Process Industries, +Trondheim, Norway. + + + diff --git a/doc/forceModel_noDrag.html b/doc/forceModel_noDrag.html deleted file mode 100644 index 9baaa53f..00000000 --- a/doc/forceModel_noDrag.html +++ /dev/null @@ -1,45 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_noDrag command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    noDrag
    -); 
    -
    -

    Examples: -

    -
    forceModels
    -(
    -    noDrag
    -); 
    -
    -
    noDragProps (optional)
    -{
    -    noDEMForce; (optional)
    -}; 
    -
    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The noDrag model sets the forces acting on the particle to zero. If several force models are selected and noDrag is the last model being executed, the fluid particle force will be set to zero. If the variable noDEMForce is set, then the forces communicated to the DEM solver are also set to zero. -

    -

    Restrictions: -

    -

    None. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_noDrag.txt b/doc/forceModel_noDrag.txt index ec43c191..4116aa2f 100644 --- a/doc/forceModel_noDrag.txt +++ b/doc/forceModel_noDrag.txt @@ -1,40 +1,57 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_noDrag command :h3 +forceModel noDrag command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( noDrag ); :pre +noDragProps +\{ + noDEMForce; + keepCFDForce; + treatForceExplicit switch1; +\} :pre + +{noDEMForce} = (optional, default false) do not apply the previously calculated forces in DEM integration :ulb,l +{keepCFDForce} = (optional, default false) do not delete the previously calculated forces and use them in CFD source terms :l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +:ule [Examples:] forceModels ( noDrag -); :pre - -noDragProps (optional) +) +noDragProps \{ - noDEMForce; (optional) -\}; :pre + noDEMForce; +\} :pre + [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The noDrag model sets the forces acting on the particle to zero. If several force models are selected and noDrag is the last model being executed, the fluid particle force will be set to zero. If the variable noDEMForce is set, then the forces communicated to the DEM solver are also set to zero. +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {noDrag} model sets the +forces acting on the particle to zero. If several force models are selected and +noDrag is the last model being executed, the fluid particle force will be set to +zero. If the variable {noDEMForce} is set, then the forces communicated to the +DEM solver are also set to zero. [Restrictions:] -None. +none [Related commands:] diff --git a/doc/forceModel_particleCellVolume.html b/doc/forceModel_particleCellVolume.html deleted file mode 100644 index c34aa71e..00000000 --- a/doc/forceModel_particleCellVolume.html +++ /dev/null @@ -1,59 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_particleCellVolume command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    particleCellVolume
    -);
    -particleCellVolumeProps
    -{
    -    upperThreshold value;
    -    lowerThreshold value2;
    -    verbose;
    -}; 
    -
    -
  • value = only cells with a field value (magnitude) lower than this upper threshold are considered - -
  • value2 = only cells with a field value (magnitude) greater than this lower threshold are considered - - - -

    Examples: -

    -
    forceModels
    -(
    -    particleCellVolume
    -);
    -particleCellVolumeProps
    -{
    -    upperThreshold 0.999;
    -    lowerThreshold 0;
    -    verbose;
    -} 
    -
    -

    Description: -

    -

    This "forceModel" does not influence the particles or the simulation - it is a postprocessing tool! The total volume of the particles as they are represented on the CFD mesh is calculated. Further the total volume of the cells particles are in is calculated. -At "writeTime" a field named particleCellVolume , where scalarField is the name of the original field, is written. This can then be probed using standard function object probes. Analogously a field named cellVolume is written. Using the verbose option a screen output is given. -

    -

    Restrictions: -

    -

    None. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_particleCellVolume.txt b/doc/forceModel_particleCellVolume.txt index 93b1dbfb..08162efb 100644 --- a/doc/forceModel_particleCellVolume.txt +++ b/doc/forceModel_particleCellVolume.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_particleCellVolume command :h3 +forceModel particleCellVolume command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -17,13 +18,15 @@ forceModels ); particleCellVolumeProps \{ - upperThreshold value; - lowerThreshold value2; + upperThreshold scalar1; + lowerThreshold scalar2; + startTime scalar3; verbose; -\}; :pre +\} :pre -{value} = only cells with a field value (magnitude) lower than this upper threshold are considered :l -{value2} = only cells with a field value (magnitude) greater than this lower threshold are considered :l +{scalar1} = only cells with a field value (magnitude) lower than this upper threshold are considered :l +{scalar2} = only cells with a field value (magnitude) greater than this lower threshold are considered :l +{scalar3} = (optional, default 0) start time of volume calculation and output :l :ule [Examples:] @@ -41,12 +44,19 @@ particleCellVolumeProps [Description:] -This "forceModel" does not influence the particles or the simulation - it is a postprocessing tool! The total volume of the particles as they are represented on the CFD mesh is calculated. Further the total volume of the cells particles are in is calculated. -At "writeTime" a field named particleCellVolume , where scalarField is the name of the original field, is written. This can then be probed using standard function object probes. Analogously a field named cellVolume is written. Using the verbose option a screen output is given. +This "force model" does not influence the particles or the simulation - it is a +post-processing tool! The total volume of the particles as they are represented +on the CFD mesh is calculated. Further the total volume of the cells particles +are in is calculated. + +At "writeTime" a field named particleCellVolume, where scalarField is the name +of the original field, is written. This can then be probed using standard +function object probes. Analogously a field named cellVolume is written. Using +the {verbose} option a screen output is given. [Restrictions:] -None. +none [Related commands:] diff --git a/doc/forceModel_pdCorrelation.html b/doc/forceModel_pdCorrelation.html deleted file mode 100644 index c838e5e2..00000000 --- a/doc/forceModel_pdCorrelation.html +++ /dev/null @@ -1,58 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_pdCorrelation -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    pdCorrelation
    -);
    -pdCorrelationProps
    -{
    -    coarseGrainingFactors
    -    (
    -        X Y Z
    -    );
    -    particleDensities
    -    (
    -        A B C
    -    );
    -    runOnWriteOnly true;
    -}; 
    -
    -
    • coarseGrainingFactors = list of coarse graining factors by type, separated by whitespace, optional - -
    • particleDensities = list of particle densities by type, separated by whitespace, optional - -
    • runOnWriteOnly = switch if this should be executed on write, optional (default: false - execute every coupling step). - - -
    -

    Description: -

    -

    This "forceModel" does not influence the particles or the flow - it calculates the particle momentum-diameter correlation -

    -
    -
    -

    where delta is the type-specific coarsegraining factor. -

    -

    This model is sensitive to additionally pulled particle type info, and can either use the type-specific densities from the dict or those pulled from LIGGGHTS. -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    forceModel

    - diff --git a/doc/forceModel_pdCorrelation.txt b/doc/forceModel_pdCorrelation.txt index 34049c96..f390b0b7 100644 --- a/doc/forceModel_pdCorrelation.txt +++ b/doc/forceModel_pdCorrelation.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_pdCorrelation :h3 +forceModel pdCorrelation :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -26,7 +27,7 @@ pdCorrelationProps A B C ); runOnWriteOnly true; -\}; :pre +\} :pre {coarseGrainingFactors} = list of coarse graining factors by type, separated by whitespace, optional :ulb,l {particleDensities} = list of particle densities by type, separated by whitespace, optional :l @@ -37,17 +38,21 @@ pdCorrelationProps [Description:] -This "forceModel" does not influence the particles or the flow - it calculates the particle momentum-diameter correlation +This "forceModel" does not influence the particles or the flow - it calculates +the particle momentum-diameter correlation :c,image(Eqs/pdCorrelation.png) -where delta is the type-specific coarsegraining factor. +where delta is the type-specific coarse-graining factor. -This model is sensitive to additionally pulled particle type info, and can either use the type-specific densities from the dict or those pulled from LIGGGHTS. +This model is sensitive to additionally pulled particle type info, and can +either use the type-specific densities from the dictionary or those pulled from +LIGGGHTS. [Restrictions:] -none. +none [Related commands:] -"forceModel"_forceModel.html \ No newline at end of file +"forceModel"_forceModel.html + diff --git a/doc/forceModel_surfaceTensionForce.txt b/doc/forceModel_surfaceTensionForce.txt new file mode 100644 index 00000000..63657974 --- /dev/null +++ b/doc/forceModel_surfaceTensionForce.txt @@ -0,0 +1,55 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +forceModel surfaceTensionForce command :h3 + +[Syntax:] + +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. + +forceModels +( + surfaceTensionForce; +); +surfaceTensionForceProps +\{ + stfFieldName "surfaceTensionField"; +\} :pre + +{surfaceTensionField} = name of the surface tension force field :ulb,l +:ule + +[Examples:] + +forceModels +( + surfaceTensionForce; +); +surfaceTensionForceProps +\{ + stfFieldName "surfaceTensionForce"; +\} :pre + +[Description:] + +The force model calculates the surface tension force acting on each DEM particle +based on a pre-calculated surface tension force as V_particle * F^sigma. When +used in conjunction with the "cfdemSolverMultiphase"_cfdemSolverMultiphase.html +solver, the surface tension force is calculated with the CSF (continuum surface +force) model (see Brackbill et al. (1992): "A continuum method for modeling +surface tension", J. Comput. Phys.). + +[Restrictions:] + +Has to be used with a multiphase solver that calculates the surface tension +force, e.g. {cfdemSolverMultiphase}. + +[Related commands:] + +"forceModel"_forceModel.html, "cfdemSolverMultiphase"_cfdemSolverMultiphase.html + diff --git a/doc/forceModel_virtualMassForce.html b/doc/forceModel_virtualMassForce.html deleted file mode 100644 index 8c7499fc..00000000 --- a/doc/forceModel_virtualMassForce.html +++ /dev/null @@ -1,52 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_virtualMassForce command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    virtualMassForce
    -);
    -virtualMassForceProps
    -{
    -    velFieldName "U";
    -}; 
    -
    -
    • U = name of the finite volume fluid velocity field - - -
    -

    Examples: -

    -
    forceModels
    -(
    -    virtualMassForce
    -);
    -virtualMassForceProps
    -{
    -    velFieldName "U";
    -} 
    -
    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The virtualMassForce model calculates the virtual mass force for each particle. -

    -

    Restrictions: -

    -

    Model not validated! -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_virtualMassForce.txt b/doc/forceModel_virtualMassForce.txt index 084371fe..537818a3 100644 --- a/doc/forceModel_virtualMassForce.txt +++ b/doc/forceModel_virtualMassForce.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_virtualMassForce command :h3 +forceModel virtualMassForce command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -18,9 +19,19 @@ forceModels virtualMassForceProps \{ velFieldName "U"; -\}; :pre + phiFieldName "phi"; + splitUrelCalculation switch1; + Cadd scalar1; + treatForceExplicit switch2; + interpolation switch3; +\} :pre {U} = name of the finite volume fluid velocity field :ulb,l +{phi} = name of the finite volume flux field :l +{switch1} = (optional, default false) indicator to split calculation of Urel between CFDEM and LIGGGHTS :l +{scalar1} = (optional, default 0.5) virtual mass coefficient :l +{switch2} = (optional, default true) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch3} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l :ule [Examples:] @@ -32,15 +43,16 @@ forceModels virtualMassForceProps \{ velFieldName "U"; + phiFieldName "phi"; \} :pre [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The virtualMassForce model calculates the virtual mass force for each particle. +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {virtualMassForce} model +calculates the virtual mass force for each particle. -[Restrictions:] - -Model not validated! +IMPORTANT NOTE: Model not validated! [Related commands:] diff --git a/doc/forceModel_viscForce.html b/doc/forceModel_viscForce.html deleted file mode 100644 index cb233bf1..00000000 --- a/doc/forceModel_viscForce.html +++ /dev/null @@ -1,55 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceModel_viscForce command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    forceModels
    -(
    -    viscForce;
    -);
    -viscForceProps
    -{
    -    velocityFieldName "U";
    -    interpolation "switch";
    -}; 
    -
    -
    • U = name of the finite volume fluid velocity field - -
    • switch = flag to use interpolated stress values (normally off) - - -
    -

    Examples: -

    -
    forceModels
    -(
    -    viscForce;
    -);
    -viscForceProps
    -{
    -    velocityFieldName "U";
    -} 
    -
    -

    Description: -

    -

    The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The viscForce model calculates the particle based viscous force, -(grad(tau)) * Vparticle (see Zhou et al. (2010): "Discrete particle simulation of particle-fluid flow: model formulations and their applicability", JFM). -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    forceModel -

    - diff --git a/doc/forceModel_viscForce.txt b/doc/forceModel_viscForce.txt index 6bcd3cbb..08baea2f 100644 --- a/doc/forceModel_viscForce.txt +++ b/doc/forceModel_viscForce.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceModel_viscForce command :h3 +forceModel viscForce command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. forceModels ( @@ -17,12 +18,20 @@ forceModels ); viscForceProps \{ - velocityFieldName "U"; - interpolation "switch"; -\}; :pre + velocityFieldName "U"; + useAddedMass scalar1; + treatForceExplicit switch1; + treatForceDEM switch2; + interpolation switch3; + scalarViscosity switch4; +\} :pre {U} = name of the finite volume fluid velocity field :ulb,l -{switch} = flag to use interpolated stress values (normally off) :l +{scalar1} = (optional, default 0) coefficient of added mass accounted for :l +{switch1} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch2} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l +{switch3} = (optional, default false) flag to use interpolated stress values :l +{switch4} = (optional, default false) sub model switch, see "forceSubModel"_forceSubModel.html for details :l :ule [Examples:] @@ -38,11 +47,15 @@ viscForceProps [Description:] -The force model performs the calculation of forces (e.g. fluid-particle interaction forces) acting on each DEM particle. The viscForce model calculates the particle based viscous force, -(grad(tau)) * Vparticle (see Zhou et al. (2010): "Discrete particle simulation of particle-fluid flow: model formulations and their applicability", JFM). +The force model performs the calculation of forces (e.g. fluid-particle +interaction forces) acting on each DEM particle. The {viscForce} model +calculates the particle based viscous force, -(grad(tau)) * Vparticle +(see Zhou et al. (2010): "Discrete particle simulation of particle-fluid flow: +model formulations and their applicability", J. Fluid Mech.). [Restrictions:] -none. +none [Related commands:] diff --git a/doc/forceModel_volWeightedAverage.txt b/doc/forceModel_volWeightedAverage.txt new file mode 100644 index 00000000..a5773317 --- /dev/null +++ b/doc/forceModel_volWeightedAverage.txt @@ -0,0 +1,80 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +forceModel volWeightedAverage command :h3 + +[Syntax:] + +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. + +forceModels +( + volWeightedAverage +); +volWeightedAverageProps +\{ + startTime time; + scalarFieldNames + ( + scalarField + ); + vectorFieldNames + ( + vectorField + ); + upperThreshold scalar1; + lowerThreshold scalar2; + verbose; +\} :pre + +{time} = (optional, default 0.) time to start the averaging :ulb,l +{scalarField} = names of the finite volume scalar fields to be temporally averaged :l +{vectorField} = names of the finite volume vector fields to be temporally averaged :l +{scalar1} = only cells with a field value (magnitude) lower than this upper threshold are considered :l +{scalar2} = only cells with a field value (magnitude) greater than this lower threshold are considered :l +{verbose} = (optional, default false) keyword only (mostly used for debugging) :l +:ule + +[Examples:] + +forceModels +( + volWeightedAverage +); +volWeightedAverageProps +\{ + startTime 0.1; + scalarFieldNames + ( + voidfraction + ); + vectorFieldNames + ( + ); + upperThreshold 0.999; + lowerThreshold 0; +\} :pre + +[Description:] + +This "forceModel" does not influence the particles or the simulation - it is a +post-processing tool! Starting at start time the volume weighted averages of +those cells of the fields within the threshold are calculated. + +At "writeTime" a field named volAverage_field, where scalarField is the name of +the original field, is written. This can then be probed using standard function +object probes. + +[Restrictions:] + +Currently all fields have the same threshold value! + +[Related commands:] + +"forceModel"_forceModel.html + diff --git a/doc/forceSubModel.html b/doc/forceSubModel.html deleted file mode 100644 index 090c1c98..00000000 --- a/doc/forceSubModel.html +++ /dev/null @@ -1,49 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceSubModel command -

    -

    Syntax: -

    -

    Defined in couplingProperties sub-dictionary of the force model in use. If no force sub-model is applied ImEx is used as default. If the keyword "forceSubModels" is provided, a choice of sub model is demanded. -

    -
    forceSubModels
    -(
    -    model_x
    -    model_y
    -); 
    -
    -
    • model = name of force sub-model to be applied -
    -

    Examples: -

    -
    forceSubModels
    -(
    -    ImEx
    -); 
    -
    -

    Note: This examples list might not be complete - please look for other models (forceSubModel_XY) in this documentation. -

    -

    Description: -

    -

    The force sub model is designed to hold the settings a force model can have. For now it handles the treatExplicit, treatDEM and implDEM option. -

    -

    Restrictions: -

    -

    None. -

    -

    Related commands: -

    -

    ImEx -

    -

    Note: This examples list may be incomplete - please look for other models (forceSubModel_XY) in this documentation. -

    -

    Default: none. -

    - diff --git a/doc/forceSubModel.txt b/doc/forceSubModel.txt index 8d150a90..a6c8cc01 100644 --- a/doc/forceSubModel.txt +++ b/doc/forceSubModel.txt @@ -1,15 +1,18 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceSubModel command :h3 +forceSubModels command :h3 [Syntax:] -Defined in couplingProperties sub-dictionary of the force model in use. If no force sub-model is applied ImEx is used as default. If the keyword "forceSubModels" is provided, a choice of sub model is demanded. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +sub-dictionary of the force model in use. If no force sub-model is applied, ImEx +is used as default. If the keyword "forceSubModels" is provided, a choice of +sub-model is demanded. forceSubModels ( @@ -26,20 +29,53 @@ forceSubModels ImEx ); :pre -Note: This examples list might not be complete - please look for other models (forceSubModel_XY) in this documentation. +NOTE: This examples list might not be complete - please look for other models +(forceSubModel XY) in this documentation. [Description:] -The force sub model is designed to hold the settings a force model can have. For now it handles the treatExplicit, treatDEM and implDEM option. +The force sub model is designed to hold the settings a force model can have. +Depending on the availability within the respective force model, the following +options are handled: + +{treatForceExplicit} - switch for the purely explicit consideration of the force +term in the equation of motion on the CFD side (off -> the force is considered +semi-implicitly; default off) :ulb,l +{treatForceDEM} - switch for the consideration of the forces on the DEM side only +(off -> calculate forces for DEM and CFD; default off) :l +{implForceDEM} - If true, the fluid velocity and drag coefficient are communicated +to the DEM calculation at each coupling time step and the drag force is +calculated at each DEM time step, using the current particle velocity. +If false, a force term is communicated to the DEM calculation at each coupling +time step, the term is constant for one coupling interval. +(on -> DEM forces are updated every DEM step; default off) :l +{verbose} - switch for debug output to screen (on -> enable debug output; default +off) :l +{interpolation} - switch for the usage of interpolation models when getting data +for the Lagrangian calculation from Eulerian fields; +f false, the cell centre values are used. (default off) :l +{useFilteredDragModel} - switch for using a coarse-grid version of the Beetstra +drag model (takes grid-size effects into account; default = off) :l +{useParcelSizeDependentFilteredDrag} - switch for using a coarse-grid version of +the Beetstra drag model (takes parcel-size effects into account, will force the +switch useFilteredDragModel to "on"; default = off) :l +{implForceDEMaccumulated} - Can only be used in combination with implForceDEM +switch, drag force values of each DEM time step are accumulated and passed on to +the CFD-calculation. (default off) :l +{scalarViscosity} - switch for the usage of a user-defined viscosity nu for the +calculation of the drag force; The CFD calculation always uses the value of the +transport model. (off -> use transportProperties nu; default off) :l +:ule [Restrictions:] -None. +none [Related commands:] "ImEx"_forceSubModel_ImEx.html -Note: This examples list may be incomplete - please look for other models (forceSubModel_XY) in this documentation. +[Default:] + +none -[Default:] none. diff --git a/doc/forceSubModel_ImEx.html b/doc/forceSubModel_ImEx.html deleted file mode 100644 index 43b92d46..00000000 --- a/doc/forceSubModel_ImEx.html +++ /dev/null @@ -1,45 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceSubModel_ImEx command -

    -

    Syntax: -

    -

    Defined in couplingProperties sub-dictionary of the force model in use. -

    -

    forceSubModels -( - ImEx; -); -

    -

    treatExplicit true; // optional for some force models. -treatDEM true; // optional for some force models. -implDEM true; // optional for some force models. -

    -

    Examples: -

    -

    forceSubModels -( - ImEx; -); -treatExplicit true; // optional for some force models. -

    -

    Description: -

    -

    If no force sub-model is applied ImEx is used as default. If the keyword "forceSubModels" is provided, a choice of sub model is demanded. Depending on the force model different keywords are read and can therefrore be set (see the log file). If the keyword is provided, its value is used. -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    forceSubModel -

    - diff --git a/doc/forceSubModel_ImEx.txt b/doc/forceSubModel_ImEx.txt index e81f55e1..ebbdac82 100644 --- a/doc/forceSubModel_ImEx.txt +++ b/doc/forceSubModel_ImEx.txt @@ -1,24 +1,33 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceSubModel_ImEx command :h3 +forceSubModel ImEx command :h3 [Syntax:] -Defined in couplingProperties sub-dictionary of the force model in use. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +sub-dictionary of the force model in use. forceSubModels ( ImEx; -); +); :pre -treatExplicit true; // optional for some force models. -treatDEM true; // optional for some force models. -implDEM true; // optional for some force models. +Optional for some force models: + +treatForceExplicit true; +treatForceDEM true; +implForceDEM true; +verbose true; +interpolation true; +useFilteredDragModel true; +useParcelSizeDependentFilteredDrag true; +implForceDEMaccumulated true; +scalarViscosity true; :pre [Examples:] @@ -26,15 +35,18 @@ forceSubModels ( ImEx; ); -treatExplicit true; // optional for some force models. +treatForceExplicit true; // optional for some force models. :pre [Description:] - If no force sub-model is applied ImEx is used as default. If the keyword "forceSubModels" is provided, a choice of sub model is demanded. Depending on the force model different keywords are read and can therefrore be set (see the log file). If the keyword is provided, its value is used. +If no force sub-model is applied {ImEx} is used as default. If the keyword +"forceSubModels" is provided, a choice of sub model is demanded. Depending on +the force model different keywords are read and can therefore be set +(see the log file). If the keyword is provided, its value is used. [Restrictions:] -none. +none [Related commands:] diff --git a/doc/forceSubModel_ImExCorr.html b/doc/forceSubModel_ImExCorr.html deleted file mode 100644 index 215cb415..00000000 --- a/doc/forceSubModel_ImExCorr.html +++ /dev/null @@ -1,46 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    forceSubModel_ImExCorr command -

    -

    Syntax: -

    -

    Defined in couplingProperties sub-dictionary of the force model in use. -

    -

    forceSubModels -( - ImExCorr; -); -

    -

    treatExplicit true; // optional for some force models. -treatDEM true; // optional for some force models. -implDEM true; // optional for some force models. -explicitInterpCorr true; // optional for some force models. -

    -

    Examples: -

    -

    forceSubModels -( - ImExCorr; -); -treatExplicit true; // optional for some force models. -

    -

    Description: -

    -

    Same as ImEx, but it additionally reads "explicitInterpCorr" to correct the error steming from interpolation of Ufluid and averaging of Uparticles. -

    -

    Restrictions: -

    -

    none. -

    -

    Related commands: -

    -

    forceSubModel -

    - diff --git a/doc/forceSubModel_ImExCorr.txt b/doc/forceSubModel_ImExCorr.txt index 666ffe11..85f6645c 100644 --- a/doc/forceSubModel_ImExCorr.txt +++ b/doc/forceSubModel_ImExCorr.txt @@ -1,25 +1,25 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -forceSubModel_ImExCorr command :h3 +forceSubModel ImExCorr command :h3 [Syntax:] -Defined in couplingProperties sub-dictionary of the force model in use. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +sub-dictionary of the force model in use. forceSubModels ( ImExCorr; ); - treatExplicit true; // optional for some force models. treatDEM true; // optional for some force models. implDEM true; // optional for some force models. -explicitInterpCorr true; // optional for some force models. +explicitInterpCorr true; // optional for some force models. :pre [Examples:] @@ -27,15 +27,17 @@ forceSubModels ( ImExCorr; ); -treatExplicit true; // optional for some force models. +treatExplicit true; // optional for some force models. :pre [Description:] - Same as ImEx, but it additionally reads "explicitInterpCorr" to correct the error steming from interpolation of Ufluid and averaging of Uparticles. +Same as "ImEx"_forceSubModel_ImEx.html, but it additionally reads +"explicitInterpCorr" to correct the error steming from interpolation of Ufluid +and averaging of Uparticles. [Restrictions:] -none. +none [Related commands:] diff --git a/doc/githubAccess_public.html b/doc/githubAccess_public.html deleted file mode 100644 index b27e7093..00000000 --- a/doc/githubAccess_public.html +++ /dev/null @@ -1,186 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - - - - - -
    - -

    githubAccess_public -

    -
    - -

    Description: -

    -

    This routine describes how to set up a github account and pull repositories of the CFDEM(R)project. -After setting some environment variables LIGGGHTS(R) and CFDEM(R)coupling can be compiled -

    -

    Procedure: -

    -

    Basically the following steps have to be performed: -

    -
    • git clone the desired repository - -
    • update your repositories by git pull - -
    • set environment variables - -
    • compile LIGGGHTS(R) and CFDEM(R)coupling - -
    • run your own cases - - -
    -

    git clone the desired repository: -

    -

    If not already done, open a terminal and create a directory for LIGGGHTS(R) in $HOME: -

    -
    cd 
    -
    -
    mkdir LIGGGHTS 
    -
    -
    cd LIGGGHTS 
    -
    -

    To clone the public LIGGGHTS repository, open a terminal and execute: -

    -
    git clone git://github.com/CFDEMproject/LIGGGHTS-PUBLIC.git LIGGGHTS-PUBLIC -
    -

    If not already done, open a terminal and create a directory for CFDEM(R)coupling in $HOME: -

    -
    cd 
    -
    -
    mkdir CFDEM 
    -
    -
    cd CFDEM 
    -
    -

    Make sure that OpenFOAM(R) is already set up correctly! -

    -

    To clone the public CFDEM(R)coupling repository, open a terminal and execute: -

    -
    git clone git://github.com/CFDEMproject/CFDEMcoupling-PUBLIC.git CFDEMcoupling-PUBLIC-$WM_PROJECT_VERSION -
    -

    Troubles? See Troubleshooting section below. -

    -

    Update your repositories by git pull: -

    -

    To get the latest version, open a terminal, go to the location of your local installation and type: -Warning: git stash will remove your changes in $HOME/CFDEM/CFDEMcoupling-PUBLIC-$WM_PROJECT_VERSION ! -

    -
    cd $HOME/CFDEM/CFDEMcoupling-PUBLIC-$WM_PROJECT_VERSION
    -git stash
    -git pull 
    -
    -

    Set Environment Variables: -

    -

    Now you need to set some environment variables in ~/.bashrc (if you use c-shell, manipulate ~/.cshrc accordingly). Open ~/.bashrc -

    -
    gedit ~/.bashrc & 
    -
    -

    add the lines (you find them also in .../cfdemParticle/etc/bashrc and cshrc respectively): -

    -
    #================================================#
    -#- source cfdem env vars
    -export CFDEM_VERSION=PUBLIC
    -export CFDEM_PROJECT_DIR=$HOME/CFDEM/CFDEMcoupling-$CFDEM_VERSION-$WM_PROJECT_VERSION
    -export CFDEM_SRC_DIR=$CFDEM_PROJECT_DIR/src
    -export CFDEM_SOLVER_DIR=$CFDEM_PROJECT_DIR/applications/solvers
    -export CFDEM_DOC_DIR=$CFDEM_PROJECT_DIR/doc
    -export CFDEM_UT_DIR=$CFDEM_PROJECT_DIR/applications/utilities
    -export CFDEM_TUT_DIR=$CFDEM_PROJECT_DIR/tutorials
    -export CFDEM_PROJECT_USER_DIR=$HOME/CFDEM/$LOGNAME-$CFDEM_VERSION-$WM_PROJECT_VERSION
    -export CFDEM_bashrc=$CFDEM_SRC_DIR/lagrangian/cfdemParticle/etc/bashrc
    -export CFDEM_LIGGGHTS_SRC_DIR=$HOME/LIGGGHTS/LIGGGHTS-PUBLIC/src
    -export CFDEM_LIGGGHTS_MAKEFILE_NAME=fedora_fpic
    -export CFDEM_LPP_DIR=$HOME/LIGGGHTS/mylpp/src
    -export CFDEM_PIZZA_DIR=$HOME/LIGGGHTS/PIZZA/gran_pizza_17Aug10/src
    -. $CFDEM_bashrc
    -#================================================# 
    -
    -

    Save the ~/.bashrc, open a new terminal and test the settings. The commands: -

    -
    $CFDEM_PROJECT_DIR
    -$CFDEM_SRC_DIR
    -$CFDEM_LIGGGHTS_SRC_DIR 
    -
    -

    should give "...: is a directory" otherwise something went wrong and the environment variables in ~/.bashrc are not set correctly. -

    -

    To specify the paths of pizza, please check the settings in $CFDEM_SRC_DIR/lagrangian/cfdemParticle/etc/bashrc. -

    -

    If $CFDEM_SRC_DIR is set correctly, you can type -

    -
    cfdemSysTest 
    -
    -

    to get some information if the paths are set correctly. -

    -

    Compile LIGGGHTS(R) and CFDEM(R)coupling: -

    -

    If above settings were done correctly, you can compile LIGGGHTS(R) by typing: -

    -
    cfdemCompLIG 
    -
    -

    and you can then compile CFDEM(R)coupling by typing: -

    -
    cfdemCompCFDEM 
    -
    -

    You can run the tutorial cases by executing .../etc/testTutorial.sh through the alias cfdemTestTUT. -Alternatively you can run each tutorial using the Allrun.sh scripts in the tutorial directories. -

    -

    In case questions concerning the installation arise, please feel free to contact our forum at www.cfdem.com. -

    -

    Run Your Own Cases: -

    -

    If you want to run your own cases, please do so in $CFDEM_PROJECT_USER_DIR/run which is automatically being generated. E.g. copy one of the tutorial cases there, adapt it to your needs. -Changes in $CFDEM_TUT_DIR will be lost after every git stash! -

    -

    Additional Installations: -

    -

    Optionally you can install lpp which will help you convert the DEM (dump) data to VTK format. For standard CFD-DEM runs this will not be necessary. To get the DEM postprocessing tool "lpp" you need python-numpy package installed: -

    -
    sudo apt-get install python-numpy 
    -
    -

    You can pull the latest version of lpp with: -

    -
    cd $HOME/LIGGGHTS 
    -
    -
    git clone git://cfdem.git.sourceforge.net/gitroot/cfdem/lpp mylpp 
    -
    -

    Backwards Compatibility: -

    -

    Basically CFDEM(R)coupling supports one OpenFOAM(R) version therefore all settings are prepared for that. Nevertheless we try to maintain backwards compatibility as long as it works with reasonable effort. -

    -

    The supported OpenFOAM(R) and LIGGGHTS(R) versions are stated in: -src/lagrangian/cfdemParticle/cfdTools/versionInfo.H -

    -

    For using other versions you can manipulate: -src/lagrangian/cfdemParticle/etc/OFversion/OFversion.H -(still not all functionality might work then!) -

    -

    Troubleshooting: -

    -
    • Troubles with git clone? - - -
    -

    a) The git protocol will not work if your computer is behind a firewall which blocks the relevant TCP port, you can use alternatively (write command in one line): -

    -

    git clone https://user@github.com/CFDEMproject/CFDEMcoupling-PUBLIC.git -CFDEMcoupling-PUBLIC-$WM_PROJECT_VERSION -

    -

    b) If you face the error: "error: SSL certificate problem, verify that the CA cert is OK. Details: error:14090086:SSL routines:SSL3_GET_SERVER_CERTIFICATE:certificate verify failed while accessing https://github.com/...", -

    -

    please use: env GIT_SSL_NO_VERIFY=true git clone https://github... -

    -

    (see http://stackoverflow.com/questions/3777075/https-github-access) -

    -

    c) If you face the error: "Agent admitted failure to sign using the key. Permission denied (publickey).", after ssh -T git@github.com -

    -

    please type: "ssh-add" -

    -

    (see: https://help.github.com/articles/error-agent-admitted-failure-to-sign) -

    - diff --git a/doc/githubAccess_public.pdf b/doc/githubAccess_public.pdf deleted file mode 100644 index 13f6bb53..00000000 Binary files a/doc/githubAccess_public.pdf and /dev/null differ diff --git a/doc/githubAccess_public.txt b/doc/githubAccess_public.txt deleted file mode 100644 index f72df624..00000000 --- a/doc/githubAccess_public.txt +++ /dev/null @@ -1,169 +0,0 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c - -:link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) -:link(github,http://github.com) -:link(gitHelp,http://help.github.com/linux-set-up-git) - -:line -githubAccess_public :h3 -:line - -[Description:] - -This routine describes how to set up a github account and pull repositories of the CFDEM(R)project. -After setting some environment variables LIGGGHTS(R) and CFDEM(R)coupling can be compiled - -[Procedure:] - -Basically the following steps have to be performed: - -{git clone} the desired repository :ulb,l -update your repositories by {git pull} :l -set environment variables :l -compile LIGGGHTS(R) and CFDEM(R)coupling :l -run your own cases :l -:ule - -[{git clone} the desired repository:] - -If not already done, open a terminal and create a directory for LIGGGHTS(R) in $HOME: - -cd :pre -mkdir LIGGGHTS :pre -cd LIGGGHTS :pre - -To clone the public LIGGGHTS repository, open a terminal and execute: - -git clone git://github.com/CFDEMproject/LIGGGHTS-PUBLIC.git LIGGGHTS-PUBLIC :pre,h6 - -If not already done, open a terminal and create a directory for CFDEM(R)coupling in $HOME: - -cd :pre -mkdir CFDEM :pre -cd CFDEM :pre - -Make sure that OpenFOAM(R) is already set up correctly! - -To clone the public CFDEM(R)coupling repository, open a terminal and execute: - -git clone git://github.com/CFDEMproject/CFDEMcoupling-PUBLIC.git CFDEMcoupling-PUBLIC-$WM_PROJECT_VERSION :pre,h6 - -Troubles? See Troubleshooting section below. - - -[Update your repositories by {git pull}:] - -To get the latest version, open a terminal, go to the location of your local installation and type: -{Warning: git stash will remove your changes in $HOME/CFDEM/CFDEMcoupling-PUBLIC-$WM_PROJECT_VERSION !} - -cd $HOME/CFDEM/CFDEMcoupling-PUBLIC-$WM_PROJECT_VERSION -git stash -git pull :pre - -[Set Environment Variables:] - -Now you need to set some environment variables in ~/.bashrc (if you use c-shell, manipulate ~/.cshrc accordingly). Open ~/.bashrc - -gedit ~/.bashrc & :pre - -add the lines (you find them also in .../cfdemParticle/etc/bashrc and cshrc respectively): - -#================================================# -#- source cfdem env vars -export CFDEM_VERSION=PUBLIC -export CFDEM_PROJECT_DIR=$HOME/CFDEM/CFDEMcoupling-$CFDEM_VERSION-$WM_PROJECT_VERSION -export CFDEM_SRC_DIR=$CFDEM_PROJECT_DIR/src -export CFDEM_SOLVER_DIR=$CFDEM_PROJECT_DIR/applications/solvers -export CFDEM_DOC_DIR=$CFDEM_PROJECT_DIR/doc -export CFDEM_UT_DIR=$CFDEM_PROJECT_DIR/applications/utilities -export CFDEM_TUT_DIR=$CFDEM_PROJECT_DIR/tutorials -export CFDEM_PROJECT_USER_DIR=$HOME/CFDEM/$LOGNAME-$CFDEM_VERSION-$WM_PROJECT_VERSION -export CFDEM_bashrc=$CFDEM_SRC_DIR/lagrangian/cfdemParticle/etc/bashrc -export CFDEM_LIGGGHTS_SRC_DIR=$HOME/LIGGGHTS/LIGGGHTS-PUBLIC/src -export CFDEM_LIGGGHTS_MAKEFILE_NAME=fedora_fpic -export CFDEM_LPP_DIR=$HOME/LIGGGHTS/mylpp/src -export CFDEM_PIZZA_DIR=$HOME/LIGGGHTS/PIZZA/gran_pizza_17Aug10/src -. $CFDEM_bashrc -#================================================# :pre - -Save the ~/.bashrc, open a new terminal and test the settings. The commands: - -$CFDEM_PROJECT_DIR -$CFDEM_SRC_DIR -$CFDEM_LIGGGHTS_SRC_DIR :pre - -should give "...: is a directory" otherwise something went wrong and the environment variables in ~/.bashrc are not set correctly. - -To specify the paths of pizza, please check the settings in $CFDEM_SRC_DIR/lagrangian/cfdemParticle/etc/bashrc. - -If $CFDEM_SRC_DIR is set correctly, you can type - -cfdemSysTest :pre - -to get some information if the paths are set correctly. - -[Compile LIGGGHTS(R) and CFDEM(R)coupling:] - -If above settings were done correctly, you can compile LIGGGHTS(R) by typing: - -cfdemCompLIG :pre - -and you can then compile CFDEM(R)coupling by typing: - -cfdemCompCFDEM :pre - -You can run the tutorial cases by executing .../etc/testTutorial.sh through the alias {cfdemTestTUT}. -Alternatively you can run each tutorial using the {Allrun.sh} scripts in the tutorial directories. - -In case questions concerning the installation arise, please feel free to contact our forum at www.cfdem.com. - -[Run Your Own Cases:] - -If you want to run your own cases, please do so in $CFDEM_PROJECT_USER_DIR/run which is automatically being generated. E.g. copy one of the tutorial cases there, adapt it to your needs. -Changes in $CFDEM_TUT_DIR will be lost after every {git stash}! - -[Additional Installations:] - -Optionally you can install lpp which will help you convert the DEM (dump) data to VTK format. For standard CFD-DEM runs this will not be necessary. To get the DEM postprocessing tool "lpp" you need python-numpy package installed: - -sudo apt-get install python-numpy :pre - -You can pull the latest version of lpp with: - -cd $HOME/LIGGGHTS :pre -git clone git://cfdem.git.sourceforge.net/gitroot/cfdem/lpp mylpp :pre - -[Backwards Compatibility:] - -Basically CFDEM(R)coupling supports one OpenFOAM(R) version therefore all settings are prepared for that. Nevertheless we try to maintain backwards compatibility as long as it works with reasonable effort. - -The supported OpenFOAM(R) and LIGGGHTS(R) versions are stated in: -src/lagrangian/cfdemParticle/cfdTools/versionInfo.H - -For using other versions you can manipulate: -src/lagrangian/cfdemParticle/etc/OFversion/OFversion.H -(still not all functionality might work then!) - -[Troubleshooting:] - -Troubles with git clone? :ulb,l -:ule - -[a)] The git protocol will not work if your computer is behind a firewall which blocks the relevant TCP port, you can use alternatively (write command in one line): - -git clone https://user@github.com/CFDEMproject/CFDEMcoupling-PUBLIC.git -CFDEMcoupling-PUBLIC-$WM_PROJECT_VERSION - -[b)] If you face the error: "error: SSL certificate problem, verify that the CA cert is OK. Details: error:14090086:SSL routines:SSL3_GET_SERVER_CERTIFICATE:certificate verify failed while accessing https://github.com/...", - -please use: env GIT_SSL_NO_VERIFY=true git clone https://github... - -(see http://stackoverflow.com/questions/3777075/https-github-access) - - -[c)] If you face the error: "Agent admitted failure to sign using the key. Permission denied (publickey).", after ssh -T git@github.com - -please type: "ssh-add" - -(see: https://help.github.com/articles/error-agent-admitted-failure-to-sign) diff --git a/doc/liggghtsCommandModel.html b/doc/liggghtsCommandModel.html deleted file mode 100644 index 2c0ca7e6..00000000 --- a/doc/liggghtsCommandModel.html +++ /dev/null @@ -1,44 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    liggghtsCommandModel command -

    -

    Syntax: -

    -

    Defined in liggghtsCommmands dictionary. -

    -
    liggghtsCommandModels
    -(
    -    model_x
    -    model_y
    -); 
    -
    -
    • model = name of the liggghtsCommandModel to be applied -
    -

    Examples: -

    -
    liggghtsCommandModels
    -(
    -   runLiggghts
    -   writeLiggghts
    -); 
    -
    -

    Note: This examples list might not be complete - please look for other models (liggghtsCommandModel_XY) in this documentation. -

    -

    Description: -

    -

    The liggghtsCommandModel is the base class to execute DEM commands within a CFD run. -

    -

    Restrictions: -

    -

    Works only with MPI coupling. -

    -

    Default: none. -

    - diff --git a/doc/liggghtsCommandModel.txt b/doc/liggghtsCommandModel.txt index 37fbe266..41797b98 100644 --- a/doc/liggghtsCommandModel.txt +++ b/doc/liggghtsCommandModel.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -liggghtsCommandModel command :h3 +liggghtsCommandModels command :h3 [Syntax:] -Defined in liggghtsCommmands dictionary. +Defined in "liggghtsCommmands"_CFDEMcoupling_dicts.html#liggghtsCommands +dictionary. liggghtsCommandModels ( @@ -27,14 +28,19 @@ liggghtsCommandModels writeLiggghts ); :pre -Note: This examples list might not be complete - please look for other models (liggghtsCommandModel_XY) in this documentation. +NOTE: This examples list might not be complete - please look for other models +(liggghtsCommandModel XY) in this documentation. [Description:] -The liggghtsCommandModel is the base class to execute DEM commands within a CFD run. +The liggghtsCommandModel is the base class to execute DEM commands within a CFD +run. -[Restrictions:] +[Restrictions:] Works only with MPI coupling. -[Default:] none. +[Default:] + +none + diff --git a/doc/liggghtsCommandModel_execute.html b/doc/liggghtsCommandModel_execute.html deleted file mode 100644 index 58909fe3..00000000 --- a/doc/liggghtsCommandModel_execute.html +++ /dev/null @@ -1,97 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    liggghtsCommandModel_execute command -

    -

    Syntax: -

    -

    Defined in liggghtsCommmands dictionary. -

    -
    liggghtsCommandModels
    -(
    -   execute
    -);
    -executeProps0
    -{
    -    command
    -    (
    -        run
    -        $couplingInterval
    -    );
    -    runFirst switch1; 
    -    runLast switch2;
    -    runEveryCouplingStep switch3;
    -    runEveryWriteStep switch4;
    -    verbose;
    -} 
    -
    -
    • command = LIGGGHTS command to be executed. Each word in a new line, numbers and symbols need special treatment (e.g. $couplingInterval will be replaced by correct coupling interval in the simulation) - -
    • switch1 = switch (choose on/off) if the command is executed only at first time step - -
    • switch2 = switch (choose on/off) if the command is executed only at last time step - -
    • switch3 = switch (choose on/off) if the command is executed at every coupling step - -
    • switch4 = switch (choose on/off) if the command is executed at every writing step - -
    • verbose = (normally off) for verbose run - - -
    -

    Examples: -

    -
    liggghtsCommandModels
    -(
    -   execute
    -   execute
    -);
    -executeProps0
    -{
    -    command
    -    (
    -        run
    -        $couplingInterval
    -    );
    -    runFirst off;
    -    runLast off;
    -    runEveryCouplingStep on;
    -}
    -executeProps1
    -{
    -    command
    -    (
    -        write_restart
    -        noBlanks
    -        dotdot
    -        slash
    -        DEM
    -        slash
    -        liggghts.restart_
    -        timeStamp
    -    );
    -    runFirst off;
    -    runLast off;
    -    runEveryCouplingStep off;
    -    runEveryWriteStep on;
    -} 
    -
    -

    Description: -

    -

    The execute liggghtsCommand Model can be used to execute a LIGGGHTS command during a CFD run. In above example execute_0 for instance executes "run $couplingInterval" every coupling step. $couplingInterval is automatically replaced by the correct number of DEM steps. Additionally execute_1 executes "write_restart ../DEM/liggghts.restart_$timeStamp" every writing step, where $timeStamp is automatically set. -

    -

    These rather complex execute commands can be replaced by the "readLiggghts" and "writeLiggghts" commands! -

    -

    Restrictions: None. -

    -

    Related commands: -

    -

    liggghtsCommandModel -

    - diff --git a/doc/liggghtsCommandModel_execute.txt b/doc/liggghtsCommandModel_execute.txt index 5db5f2af..7e61c19f 100644 --- a/doc/liggghtsCommandModel_execute.txt +++ b/doc/liggghtsCommandModel_execute.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -liggghtsCommandModel_execute command :h3 +liggghtsCommandModel execute command :h3 [Syntax:] -Defined in liggghtsCommmands dictionary. +Defined in "liggghtsCommmands"_CFDEMcoupling_dicts.html#liggghtsCommands +dictionary. liggghtsCommandModels ( @@ -22,18 +23,18 @@ executeProps0 run $couplingInterval ); - runFirst switch1; - runLast switch2; + runFirst switch1; + runLast switch2; runEveryCouplingStep switch3; - runEveryWriteStep switch4; + runEveryWriteStep switch4; verbose; \} :pre -{command} = LIGGGHTS command to be executed. Each word in a new line, numbers and symbols need special treatment (e.g. $couplingInterval will be replaced by correct coupling interval in the simulation) :ulb,l -{switch1} = switch (choose on/off) if the command is executed only at first time step :l -{switch2} = switch (choose on/off) if the command is executed only at last time step :l -{switch3} = switch (choose on/off) if the command is executed at every coupling step :l -{switch4} = switch (choose on/off) if the command is executed at every writing step :l +{command} = LIGGGHTS command to be executed. Each word in a new line, numbers and symbols need special treatment (e.g. $couplingInterval will be replaced by correct coupling interval in the simulation) :ulb,l +{switch1} = (optional, default off) if the command is executed only at first time step :l +{switch2} = (optional, default off) if the command is executed only at last time step (requires {switch1} to be off) :l +{switch3} = (optional, default off) if the command is executed at every coupling step (requires {switch1} and {switch2} to be off) :l +{switch4} = (optional, default off) if the command is executed at every writing step (requires {switch1} to {switch3} to be off) :l {verbose} = (normally off) for verbose run :l :ule @@ -51,8 +52,8 @@ executeProps0 run $couplingInterval ); - runFirst off; - runLast off; + runFirst off; + runLast off; runEveryCouplingStep on; \} executeProps1 @@ -68,19 +69,27 @@ executeProps1 liggghts.restart_ timeStamp ); - runFirst off; - runLast off; + runFirst off; + runLast off; runEveryCouplingStep off; - runEveryWriteStep on; + runEveryWriteStep on; \} :pre [Description:] -The execute liggghtsCommand Model can be used to execute a LIGGGHTS command during a CFD run. In above example execute_0 for instance executes "run $couplingInterval" every coupling step. $couplingInterval is automatically replaced by the correct number of DEM steps. Additionally execute_1 executes "write_restart ../DEM/liggghts.restart_$timeStamp" every writing step, where $timeStamp is automatically set. +The {execute} liggghtsCommandModel can be used to execute a LIGGGHTS command +during a CFD run. In above example {execute_0} for instance executes +"run $couplingInterval" every coupling step. {$couplingInterval} is automatically +replaced by the correct number of DEM steps. Additionally, {execute_1} executes +"write_restart ../DEM/liggghts.restart_$timeStamp" every writing step, where +{$timeStamp} is automatically set. -These rather complex execute commands can be replaced by the "readLiggghts" and "writeLiggghts" commands! :h4 +NOTE: These rather complex execute commands can be replaced by the +{runLiggghts} and {writeLiggghts} commands! -[Restrictions:] None. +[Restrictions:] + +none [Related commands:] diff --git a/doc/liggghtsCommandModel_readLiggghtsData.html b/doc/liggghtsCommandModel_readLiggghtsData.html deleted file mode 100644 index 1981d499..00000000 --- a/doc/liggghtsCommandModel_readLiggghtsData.html +++ /dev/null @@ -1,49 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    liggghtsCommandModel_readLiggghtsData command -

    -

    Syntax: -

    -

    Defined in liggghtsCommmands dictionary. -

    -
    liggghtsCommandModels
    -(
    -   readLiggghtsData
    -);
    -readLiggghtsDataProps0
    -{
    -    ???
    -} 
    -
    -

    Examples: -

    -
    liggghtsCommandModels
    -(
    -   readLiggghtsData
    -   readLiggghtsData
    -);
    -readLiggghtsDataProps0
    -{
    -    ???
    -} 
    -
    -

    Description: -

    -

    The readLiggghtsData liggghtsCommand Model can be used to ??? -

    -

    Restrictions: -

    -

    Note: Model is not up to date. -

    -

    Related commands: -

    -

    liggghtsCommandModel -

    - diff --git a/doc/liggghtsCommandModel_readLiggghtsData.txt b/doc/liggghtsCommandModel_readLiggghtsData.txt index 510ab556..29e9d71c 100644 --- a/doc/liggghtsCommandModel_readLiggghtsData.txt +++ b/doc/liggghtsCommandModel_readLiggghtsData.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -liggghtsCommandModel_readLiggghtsData command :h3 +liggghtsCommandModel readLiggghtsData command :h3 [Syntax:] -Defined in liggghtsCommmands dictionary. +Defined in "liggghtsCommmands"_CFDEMcoupling_dicts.html#liggghtsCommands +dictionary. liggghtsCommandModels ( @@ -17,30 +18,58 @@ liggghtsCommandModels ); readLiggghtsDataProps0 \{ - ??? + startIndex scalar1; + verbose; + exactTiming; + filePath + ( + "word" + ); + startTime scalar2; + endTime scalar3; + timeInterval scalar4; \} :pre +{scalar1} = start index of data file to be read; the index is appended to {filePath} :ulb,l +{verbose} = (default off) flag for verbose run :l +{exactTiming} = flag indicating that start time should be kept even during a coupling interval :l +{filePath} = path to LIGGGHTS data file. Each word starts in a new line; special characters, i.e. dots and slashes, need special treatment (e.g. dotdot will be replaced by "..") :l +{scalar2} = start reading at this time :l +{scalar3} = end reading at this time :l +{scalar4} = repeat reading at this time interval while increasing the data file index :l +:ule [Examples:] liggghtsCommandModels ( readLiggghtsData - readLiggghtsData ); readLiggghtsDataProps0 \{ - ??? + startIndex 0; + exactTiming; + filePath + ( + dotdot + slash + DEM + slash + packing.data + ); + startTime 0.002; + endTime 0.012; + timeInterval 0.001; \} :pre [Description:] -The readLiggghtsData liggghtsCommand Model can be used to ??? +The {readLiggghtsData} liggghtsCommandModel can be used to read LIGGGHTS data +files into LIGGGHTS during runtime of a coupled simulation. This corresponds to +the {read_data} command in LIGGGHTS with the {add} option, i.e. read in +particles are added to existing particles. - -[Restrictions:] - -Note: Model is not up to date. +IMPORTANT NOTE: Model is outdated. [Related commands:] diff --git a/doc/liggghtsCommandModel_runLiggghts.html b/doc/liggghtsCommandModel_runLiggghts.html deleted file mode 100644 index b9ad8864..00000000 --- a/doc/liggghtsCommandModel_runLiggghts.html +++ /dev/null @@ -1,44 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    liggghtsCommandModel_runLiggghts command -

    -

    Syntax: -

    -

    Defined in liggghtsCommmands dictionary. -

    -
    liggghtsCommandModels
    -(
    -   runLiggghts
    -);
    -//- optional
    -runLiggghtsProps
    -{
    -    preNo true;
    -    verbose; (optional)
    -} 
    -
    -

    Examples: -

    -
    liggghtsCommandModels
    -(
    -   runLiggghts
    -); 
    -
    -

    Description: -

    -

    The liggghtsCommand models can be used to execute a LIGGGHTS command during a CFD run. The "runLiggghts" command executes the command "run $nrDEMsteps", where $nrDEMsteps is automatically set according to the coupling intervals, every coupling step. Optionally a dictionary called runLiggghtsProps can be specified where the "preNo" switch can be set, which uses the command "run $nrDEMsteps pre no" for every time step except the first. -

    -

    Restrictions: Warning: the "pre no" option can cause troubles (dump data of particles changing the domain might be erroneous)! -

    -

    Related commands: -

    -

    liggghtsCommandModel -

    - diff --git a/doc/liggghtsCommandModel_runLiggghts.txt b/doc/liggghtsCommandModel_runLiggghts.txt index a1f0ef41..48a9e12f 100644 --- a/doc/liggghtsCommandModel_runLiggghts.txt +++ b/doc/liggghtsCommandModel_runLiggghts.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -liggghtsCommandModel_runLiggghts command :h3 +liggghtsCommandModel runLiggghts command :h3 [Syntax:] -Defined in liggghtsCommmands dictionary. +Defined in "liggghtsCommmands"_CFDEMcoupling_dicts.html#liggghtsCommands +dictionary. liggghtsCommandModels ( @@ -31,9 +32,19 @@ liggghtsCommandModels [Description:] -The liggghtsCommand models can be used to execute a LIGGGHTS command during a CFD run. The "runLiggghts" command executes the command "run $nrDEMsteps", where $nrDEMsteps is automatically set according to the coupling intervals, every coupling step. Optionally a dictionary called runLiggghtsProps can be specified where the "preNo" switch can be set, which uses the command "run $nrDEMsteps pre no" for every time step except the first. +The LIGGGHTS command models can be used to execute a LIGGGHTS command during a +CFD run. The {runLiggghts} command executes the command "run $nrDEMsteps", where +$nrDEMsteps is automatically set according to the coupling intervals, every +coupling step. -[Restrictions:] Warning: the "pre no" option can cause troubles (dump data of particles changing the domain might be erroneous)! +Optionally a dictionary called runLiggghtsProps can be specified where the +"preNo" switch can be set, which uses the command "run $nrDEMsteps pre no" for +every time step except the first. + +[Restrictions:] + +IMPORTANT NOTE: the "pre no" option can cause troubles (dump data of particles +changing the domain might be erroneous)! [Related commands:] diff --git a/doc/liggghtsCommandModel_writeLiggghts.html b/doc/liggghtsCommandModel_writeLiggghts.html deleted file mode 100644 index 1fa64a67..00000000 --- a/doc/liggghtsCommandModel_writeLiggghts.html +++ /dev/null @@ -1,56 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    liggghtsCommandModel_writeLiggghts command -

    -

    Syntax: -

    -

    Defined in liggghtsCommmands dictionary. -

    -
    liggghtsCommandModels
    -(
    -   writeLiggghts
    -);
    -//- optional
    -writeLiggghtsProps
    -{
    -    writeLast switch1;
    -    writeName "name";
    -    overwrite switch2;
    -    verbose;
    -} 
    -
    -
    • switch1 = switch (choose on/off) to select if only last step is stored or every write step (default on). - -
    • name = name of the restart file to be written in /$caseDir/DEM/ default (default "liggghts.restartCFDEM") - -
    • switch2 = switch (choose on/off) to select if only one restart file $name or many files $name_$timeStamp are written (default off):l -verbose = (default off) for verbose run - - -
    -

    Examples: -

    -
    liggghtsCommandModels
    -(
    -   runLiggghts
    -   writeLiggghts
    -); 
    -
    -

    Description: -

    -

    The liggghtsCommand models can be used to execute a LIGGGHTS command during a CFD write. The "writeLiggghts" command executes the command "write_restart $name", where $name is the name of the restart file, every write step. -

    -

    Restrictions: None. -

    -

    Related commands: -

    -

    liggghtsCommandModel -

    - diff --git a/doc/liggghtsCommandModel_writeLiggghts.txt b/doc/liggghtsCommandModel_writeLiggghts.txt index 7bd7a3d1..a1e0e204 100644 --- a/doc/liggghtsCommandModel_writeLiggghts.txt +++ b/doc/liggghtsCommandModel_writeLiggghts.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -liggghtsCommandModel_writeLiggghts command :h3 +liggghtsCommandModel writeLiggghts command :h3 [Syntax:] -Defined in liggghtsCommmands dictionary. +Defined in "liggghtsCommmands"_CFDEMcoupling_dicts.html#liggghtsCommands +dictionary. liggghtsCommandModels ( @@ -19,15 +20,17 @@ liggghtsCommandModels writeLiggghtsProps \{ writeLast switch1; + path "path"; writeName "name"; overwrite switch2; verbose; \} :pre -{switch1} = switch (choose on/off) to select if only last step is stored or every write step (default on). :ulb,l -{name} = name of the restart file to be written in /$caseDir/DEM/ default (default "liggghts.restartCFDEM") :l -{switch2} = switch (choose on/off) to select if only one restart file $name or many files $name_$timeStamp are written (default off):l -{verbose} = (default off) for verbose run :l +{switch1} = (optional, default on) select if only last step is stored or every write step :ulb,l +{path} = (optional, default "../DEM") alternative path (relative to execution directory) for saving the restart file :l +{name} = (optional, default "liggghts.restartCFDEM") name of the restart file to be written in ../DEM/ :l +{switch2} = (optional, default off) select if only one restart file $name or multiple files $name_$timeStamp are written :l +{verbose} = (optional, default off) for verbose run :l :ule [Examples:] @@ -40,9 +43,14 @@ liggghtsCommandModels [Description:] -The liggghtsCommand models can be used to execute a LIGGGHTS command during a CFD write. The "writeLiggghts" command executes the command "write_restart $name", where $name is the name of the restart file, every write step. +The LIGGGHTS command models can be used to execute a LIGGGHTS command during a +CFD write. The {writeLiggghts} command executes the command +"write_restart $name" - where $name is the name of the restart file - every +write step. -[Restrictions:] None. +[Restrictions:] + +none [Related commands:] diff --git a/doc/locateModel.html b/doc/locateModel.html deleted file mode 100644 index 58c59a0f..00000000 --- a/doc/locateModel.html +++ /dev/null @@ -1,34 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    locateModel command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    locateModel model; 
    -
    -
    • model = name of the locateModel to be applied -
    -

    Examples: -

    -
    locateModel engine; 
    -
    -

    Note: This examples list might not be complete - please look for other models (locateModel_XY) in this documentation. -

    -

    Description: -

    -

    The locateModel is the base class for models which search for the CFD cell and cellID corresponding to a position. In general it is used to find the cell a particle is located in. -

    -

    Restrictions: none. -

    -

    Default: none. -

    - diff --git a/doc/locateModel.txt b/doc/locateModel.txt index b18b9e46..ca02400b 100644 --- a/doc/locateModel.txt +++ b/doc/locateModel.txt @@ -1,7 +1,7 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,7 +9,8 @@ locateModel command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. locateModel model; :pre @@ -19,12 +20,20 @@ model = name of the locateModel to be applied :ul locateModel engine; :pre -Note: This examples list might not be complete - please look for other models (locateModel_XY) in this documentation. +NOTE: This examples list might not be complete - please look for other models +(locateModel XY) in this documentation. [Description:] -The locateModel is the base class for models which search for the CFD cell and cellID corresponding to a position. In general it is used to find the cell a particle is located in. +The locateModel is the base class for models which search for the CFD cell and +cellID corresponding to a position. In general it is used to find the cell a +particle is located in. -[Restrictions:] none. +[Restrictions:] + +none + +[Default:] + +none -[Default:] none. diff --git a/doc/locateModel_engineSearch.html b/doc/locateModel_engineSearch.html deleted file mode 100644 index c68e36f2..00000000 --- a/doc/locateModel_engineSearch.html +++ /dev/null @@ -1,51 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    locateModel_engineSearch command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    locateModel engine;
    -engineProps
    -{
    -    treeSearch switch1;
    -} 
    -
    -
    • switch1 = switch to use tree search algorithm - - -
    -

    Examples: -

    -
    locateModel engine;
    -engineProps
    -{
    -    treeSearch true;
    -} 
    -
    -

    Description: -

    -

    The locateModel "engine" locates the CFD cell and cellID corresponding to a given position. -The engineSearch locate Model can be used with different settings to use different algorithms: -

    -
    • treeSearch false; will execute some geometric (linear) search using the last known cellID - -
    • treeSearch true; will use a recursive tree structure to find the cell (recommended). - - -
    -

    Restrictions: none. -

    -

    Related commands: -

    -

    locateModel -

    - diff --git a/doc/locateModel_engineSearch.txt b/doc/locateModel_engineSearch.txt index fce11bff..7f14f086 100644 --- a/doc/locateModel_engineSearch.txt +++ b/doc/locateModel_engineSearch.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -locateModel_engineSearch command :h3 +locateModel engine command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. locateModel engine; engineProps @@ -30,14 +31,18 @@ engineProps [Description:] -The locateModel "engine" locates the CFD cell and cellID corresponding to a given position. -The engineSearch locate Model can be used with different settings to use different algorithms: +The locateModel {engine} locates the CFD cell and cellID corresponding to a +given position. +The {engine} locate Model can be used with different settings to use different +algorithms: -treeSearch false; will execute some geometric (linear) search using the last known cellID :ulb,l -treeSearch true; will use a recursive tree structure to find the cell (recommended). :l +treeSearch false; will execute some geometric (linear) search using the last known cellID :ulb,l +treeSearch true; will use a recursive tree structure to find the cell (recommended). :l :ule -[Restrictions:] none. +[Restrictions:] + +none [Related commands:] diff --git a/doc/locateModel_engineSearchIB.html b/doc/locateModel_engineSearchIB.html deleted file mode 100644 index 16ec8ce5..00000000 --- a/doc/locateModel_engineSearchIB.html +++ /dev/null @@ -1,70 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    locateModel_engineSearchIB command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    locateModel engineIB;
    -engineIBProps
    -{
    -    engineProps
    -    {
    -        treeSearch switch1;
    -    }
    -    zSplit value1;
    -    xySplit value2;
    -}  
    -
    -
    • switch1 = names of the finite volume scalar fields to be temporally averaged - -
    • value1 = number of z-normal layers for satellite points - -
    • value2 = number of satellite points in each layer - - -
    -

    Examples: -

    -
    locateModel engineIB;
    -engineIBProps
    -{
    -    engineProps
    -    {
    -        treeSearch false;
    -    }
    -    zSplit 8;
    -    xySplit 16;
    -} 
    -
    -

    Description: -

    -

    The locateModel "engine" locates the CFD cell and cellID corresponding to a given position. This locate model is especially designed for parallel immersed boundary method. Each particle is represented by "satellite points" if it is distributed over several processors. -

    -

    The engineSearchIB locate Model can be used with different settings to use different algorithms: -

    -
    • treeSearch false; will execute some geometric (linear) search using the last known cellID (recommended) - -
    • treeSearch true; will use a recursive tree structure to find the cell. - - -
    -

    This model is a modification of the engine search model. Instead of using the centre-cell as starting point for the engine search, further satellite points located on the surface of the sphere are checked. This ensures that (parts of) spheres can be located even when their centre is on another processor. This is especially important for parallel computations, when a sphere is about to move from one processor to another. -

    -

    Restrictions: -

    -

    Only for immersed boundary solvers! -

    -

    Related commands: -

    -

    locateModel -

    - diff --git a/doc/locateModel_engineSearchIB.txt b/doc/locateModel_engineSearchIB.txt index 08b66a1b..fcfeabf9 100644 --- a/doc/locateModel_engineSearchIB.txt +++ b/doc/locateModel_engineSearchIB.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -locateModel_engineSearchIB command :h3 +locateModel engineIB command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. locateModel engineIB; engineIBProps @@ -18,7 +19,7 @@ engineIBProps \{ treeSearch switch1; \} - zSplit value1; + zSplit value1; xySplit value2; \} :pre @@ -36,21 +37,30 @@ engineIBProps \{ treeSearch false; \} - zSplit 8; + zSplit 8; xySplit 16; \} :pre [Description:] -The locateModel "engine" locates the CFD cell and cellID corresponding to a given position. This locate model is especially designed for parallel immersed boundary method. Each particle is represented by "satellite points" if it is distributed over several processors. +The locateModel {engineIB} locates the CFD cell and cellID corresponding to a +given position. This locate model is especially designed for parallel immersed +boundary method. Each particle is represented by "satellite points" if it is +distributed over several processors. -The engineSearchIB locate Model can be used with different settings to use different algorithms: +The {engineIB} locate Model can be used with different settings to use different +algorithms: -treeSearch false; will execute some geometric (linear) search using the last known cellID (recommended) :ulb,l -treeSearch true; will use a recursive tree structure to find the cell. :l +treeSearch false; will execute some geometric (linear) search using the last known cellID (recommended) :ulb,l +treeSearch true; will use a recursive tree structure to find the cell. :l :ule -This model is a modification of the engine search model. Instead of using the centre-cell as starting point for the engine search, further satellite points located on the surface of the sphere are checked. This ensures that (parts of) spheres can be located even when their centre is on another processor. This is especially important for parallel computations, when a sphere is about to move from one processor to another. +This model is a modification of the {engine} search model. Instead of using the +centre-cell as starting point for the engine search, further satellite points +located on the surface of the sphere are checked. This ensures that (parts of) +spheres can be located even when their centre is on another processor. This is +especially important for parallel computations, when a sphere is about to move +from one processor to another. [Restrictions:] diff --git a/doc/locateModel_engineSearchMany2Many.html b/doc/locateModel_engineSearchMany2Many.html deleted file mode 100644 index fba74cd4..00000000 --- a/doc/locateModel_engineSearchMany2Many.html +++ /dev/null @@ -1,59 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    locateModel_engineSearchMany2Many command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    locateModel engineSearchMany2Many;
    -engineSearchMany2ManyProps
    -{
    -    engineProps
    -    {
    -        treeSearch switch1;
    -    }
    -}  
    -
    -switch1 = switch to use tree search algorithm - - -

    Examples: -

    -
    locateModel engineSearchMany2Many;
    -engineSearchMany2ManyProps
    -{
    -    engineProps
    -    {
    -        treeSearch true;
    -    }
    -} 
    -
    -

    Description: -

    -

    The locateModel "engine" locates the CFD cell and cellID corresponding to a given position. This model is a dummy for the "twoWayMany2Many" dataExchangeModel which locates using the specified "engine" during coupling. Using this model with any other dataExchangeModel will cause problems. -

    -

    The engineSearchMany2Many locateModel can be used with different settings to use different algorithms: -

    -
    • treeSearch false; will execute some geometric (linear) search using the last known cellID (recommended) - -
    • treeSearch true; will use a recursive tree structure to find the cell. - - -
    -

    Restrictions: -

    -

    Use only with the twoWayMany2Many dataExchangeModel! -

    -

    Related commands: -

    -

    locateModel -

    - diff --git a/doc/locateModel_engineSearchMany2Many.txt b/doc/locateModel_engineSearchMany2Many.txt index b171c315..a39aba99 100644 --- a/doc/locateModel_engineSearchMany2Many.txt +++ b/doc/locateModel_engineSearchMany2Many.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -locateModel_engineSearchMany2Many command :h3 +locateModel engineSearchMany2Many command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. locateModel engineSearchMany2Many; engineSearchMany2ManyProps @@ -36,12 +37,20 @@ engineSearchMany2ManyProps [Description:] -The locateModel "engine" locates the CFD cell and cellID corresponding to a given position. This model is a dummy for the "twoWayMany2Many" dataExchangeModel which locates using the specified "engine" during coupling. Using this model with any other dataExchangeModel will cause problems. +The locateModel "engine" locates the CFD cell and cellID corresponding to a +given position. +This model is a dummy for the +"twoWayMany2Many dataExchangeModel"_dataExchangeModel_twoWayMany2Many.html which +locates using the specified "engine" during coupling. -The engineSearchMany2Many locateModel can be used with different settings to use different algorithms: +NOTE: Using this model with any other dataExchangeModel will cause problems. -treeSearch false; will execute some geometric (linear) search using the last known cellID (recommended) :ulb,l -treeSearch true; will use a recursive tree structure to find the cell. :l +The {engineSearchMany2Many} locateModel can be used with different settings to +use different algorithms: + +treeSearch false; will execute some geometric (linear) search using the last +known cellID (recommended) :ulb,l +treeSearch true; will use a recursive tree structure to find the cell. :l :ule [Restrictions:] diff --git a/doc/locateModel_standardSearch.html b/doc/locateModel_standardSearch.html deleted file mode 100644 index d5e37a0a..00000000 --- a/doc/locateModel_standardSearch.html +++ /dev/null @@ -1,32 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    locateModel_standardSearch command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    locateModel standard;  
    -
    -

    Examples: -

    -
    locateModel standard; 
    -
    -

    Description: -

    -

    The locateModel "standard" locates the CFD cell and cellID corresponding to a given position. A very straight-forward (robust!) locate algorithm is used. -

    -

    Restrictions: none. -

    -

    Related commands: -

    -

    locateModel -

    - diff --git a/doc/locateModel_standardSearch.txt b/doc/locateModel_standardSearch.txt index 84fb1db8..3afd6324 100644 --- a/doc/locateModel_standardSearch.txt +++ b/doc/locateModel_standardSearch.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -locateModel_standardSearch command :h3 +locateModel standard command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. locateModel standard; :pre @@ -19,10 +20,13 @@ locateModel standard; :pre [Description:] -The locateModel "standard" locates the CFD cell and cellID corresponding to a given position. A very straight-forward (robust!) locate algorithm is used. +The locateModel {standard} locates the CFD cell and cellID corresponding to a +given position. A very straight-forward (robust!) locate algorithm is used. -[Restrictions:] none. +[Restrictions:] + +none [Related commands:] diff --git a/doc/locateModel_turboEngineSearch.html b/doc/locateModel_turboEngineSearch.html deleted file mode 100644 index 7adacd7b..00000000 --- a/doc/locateModel_turboEngineSearch.html +++ /dev/null @@ -1,51 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    locateModel_turboEngineSearch command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    locateModel turboEngine;
    -turboEngineProps
    -{
    -    treeSearch switch1;
    -} 
    -
    -
    • switch1 = switch to use tree search algorithm - - -
    -

    Examples: -

    -
    locateModel turboEngine;
    -turboEngineProps
    -{
    -    treeSearch true;
    -} 
    -
    -

    Description: -

    -

    The locateModel "turboEngine" locates the CFD cell and cellID corresponding to a given position. The algorithm is improved compared to engine search to show better parallel performance. -

    -

    The turboEngineSearch locate Model can be used with different settings to use different algorithms: -

    -
    • faceDecomp false; treeSearch false; will execute some geometric (linear) search using the last known cellID - -faceDecomp false; treeSearch true; will use a recursive tree structure to find the cell. (recommended):l - -
    -

    Restrictions: none. -

    -

    Related commands: -

    -

    locateModel -

    - diff --git a/doc/locateModel_turboEngineSearch.txt b/doc/locateModel_turboEngineSearch.txt index 6e79ead4..73836d85 100644 --- a/doc/locateModel_turboEngineSearch.txt +++ b/doc/locateModel_turboEngineSearch.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -locateModel_turboEngineSearch command :h3 +locateModel turboEngine command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. locateModel turboEngine; turboEngineProps @@ -30,15 +31,22 @@ turboEngineProps [Description:] -The locateModel "turboEngine" locates the CFD cell and cellID corresponding to a given position. The algorithm is improved compared to engine search to show better parallel performance. +The locateModel {turboEngine} locates the CFD cell and cellID corresponding to a +given position. The algorithm is improved compared to engine search to show +better parallel performance. -The turboEngineSearch locate Model can be used with different settings to use different algorithms: +The turboEngineSearch locate Model can be used with different settings to use +different algorithms: -faceDecomp false; treeSearch false; will execute some geometric (linear) search using the last known cellID :ulb,l -faceDecomp false; treeSearch true; will use a recursive tree structure to find the cell. (recommended):l +faceDecomp false; treeSearch false; will execute some geometric (linear) search +using the last known cellID :ulb,l +faceDecomp false; treeSearch true; will use a recursive tree structure to find +the cell. (recommended) :l :ule -[Restrictions:] none. +[Restrictions:] + +none [Related commands:] diff --git a/doc/meshMotionModel.html b/doc/meshMotionModel.html deleted file mode 100644 index c056b6b4..00000000 --- a/doc/meshMotionModel.html +++ /dev/null @@ -1,34 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    meshMotionModel command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    meshMotionModel model; 
    -
    -
    • model = name of the meshMotionModel to be applied -
    -

    Examples: -

    -
    meshMotionModel noMeshMotion; 
    -
    -

    Note: This examples list might not be complete - please look for other models (meshMotionModel_XY) in this documentation. -

    -

    Description: -

    -

    The meshMotionModel is the base class for models which manipulate the CFD mesh according to the DEM mesh motion. -

    -

    Restrictions: none. -

    -

    Default: none. -

    - diff --git a/doc/meshMotionModel.txt b/doc/meshMotionModel.txt index 60410ed0..569870d6 100644 --- a/doc/meshMotionModel.txt +++ b/doc/meshMotionModel.txt @@ -1,7 +1,7 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,7 +9,8 @@ meshMotionModel command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. meshMotionModel model; :pre @@ -19,12 +20,19 @@ model = name of the meshMotionModel to be applied :ul meshMotionModel noMeshMotion; :pre -Note: This examples list might not be complete - please look for other models (meshMotionModel_XY) in this documentation. +NOTE: This examples list might not be complete - please look for other models +(meshMotionModel XY) in this documentation. [Description:] -The meshMotionModel is the base class for models which manipulate the CFD mesh according to the DEM mesh motion. +The {meshMotionModel} is the base class for models which manipulate the CFD mesh +according to the DEM mesh motion. -[Restrictions:] none. +[Restrictions:] + +none + +[Default:] + +none -[Default:] none. diff --git a/doc/meshMotionModel_noMeshMotion.html b/doc/meshMotionModel_noMeshMotion.html deleted file mode 100644 index 5f166bd4..00000000 --- a/doc/meshMotionModel_noMeshMotion.html +++ /dev/null @@ -1,32 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    meshMotionModel_noMeshMotion command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    meshMotionModel noMeshMotion; 
    -
    -

    Examples: -

    -
    meshMotionModel noMeshMotion; 
    -
    -

    Description: -

    -

    The noMeshMotion-model is a dummy meshMotion model. -

    -

    Restrictions: None. -

    -

    Related commands: -

    -

    meshMotionModel -

    - diff --git a/doc/meshMotionModel_noMeshMotion.txt b/doc/meshMotionModel_noMeshMotion.txt index ca47a35b..f8ab98b7 100644 --- a/doc/meshMotionModel_noMeshMotion.txt +++ b/doc/meshMotionModel_noMeshMotion.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -meshMotionModel_noMeshMotion command :h3 +meshMotionModel noMeshMotion command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. meshMotionModel noMeshMotion; :pre @@ -19,9 +20,11 @@ meshMotionModel noMeshMotion; :pre [Description:] -The noMeshMotion-model is a dummy meshMotion model. +The {noMeshMotion} model is a dummy mesh motion model. -[Restrictions:] None. +[Restrictions:] + +none [Related commands:] diff --git a/doc/momCoupleModel.html b/doc/momCoupleModel.html deleted file mode 100644 index 3a37c23a..00000000 --- a/doc/momCoupleModel.html +++ /dev/null @@ -1,45 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    momCoupleModel command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    momCoupleModels
    -(
    -    model
    -); 
    -
    -
    • model = name of the momCoupleModel to be applied -
    -

    Examples: -

    -
    momCoupleModels
    -(
    -    implicitCouple
    -); 
    -
    -

    Note: This examples list might not be complete - please look for other models (momCoupleModel_XY) in this documentation. -

    -

    Forces can be coupled in an implicit way to the fluid solver (i.e., when solving the Navier-Stokes equations, the fluid velocity at the new time will be considered for the coupling force). This implicit coupling is typically done for the drag forces (look for "impForces()" in the implementation of the drag model). Implicit coupling is more stable (especially important for dense flows), but conflicts Newton's third law. Explicit forces are imposed on the flow solver in an explicit fashion (look for "expForces()" in the implementation of the drag model), which is less stable, but does not conflict Newton's third law. -

    -

    Note that the variable "imExSplitFactor" can be set in the couplingProperties in order to treat implicitly defined forces (in the implementation of the force model) as explicit ones. "imExSplitFactor 1.0;" is set by default, meaning that all implicit forces will be considered implicitly, whereas "imExSplitFactor 0.0;" would mean that implicitly defined forces will be treated in an explicit fashion. -

    -

    Note that the switch "treatVoidCellsAsExplicitForce true;" can be set in the couplingProperties in order to change the treatment of cells which are void of particles. This is only relevant if (i) smoothing is used, and (ii) implicit force coupling is performed. By default, the particle veloctiy field (Us) will be smoothed to obtain a meaningful reference quantity for the implicit force coupling. In case "treatVoidCellsAsExplicitForce true;" is set, however, Us will not be smoothed and implicit forces (after the smoothing has been performed) in cells void of particles be treated as explicit ones. This avoids the problem of defining Us in cells that are void of particles, but for which an implicit coupling force is obtained in the smoothing process. -Description: -

    -

    The momCoupleModel is the base class for momentum exchange between DEM and CFD simulation. -

    -

    Restrictions: none. -

    -

    Default: none. -

    - diff --git a/doc/momCoupleModel.txt b/doc/momCoupleModel.txt index 0a7dbf2f..c0c6ca15 100644 --- a/doc/momCoupleModel.txt +++ b/doc/momCoupleModel.txt @@ -1,7 +1,7 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,7 +9,8 @@ momCoupleModel command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. momCoupleModels ( @@ -25,17 +26,46 @@ momCoupleModels implicitCouple ); :pre -Note: This examples list might not be complete - please look for other models (momCoupleModel_XY) in this documentation. +NOTE: This examples list might not be complete - please look for other models +(momCoupleModel XY) in this documentation. -Forces can be coupled in an implicit way to the fluid solver (i.e., when solving the Navier-Stokes equations, the fluid velocity at the new time will be considered for the coupling force). This implicit coupling is typically done for the drag forces (look for "impForces()" in the implementation of the drag model). Implicit coupling is more stable (especially important for dense flows), but conflicts Newton's third law. Explicit forces are imposed on the flow solver in an explicit fashion (look for "expForces()" in the implementation of the drag model), which is less stable, but does not conflict Newton's third law. - -Note that the variable "imExSplitFactor" can be set in the couplingProperties in order to treat implicitly defined forces (in the implementation of the force model) as explicit ones. "imExSplitFactor 1.0;" is set by default, meaning that all implicit forces will be considered implicitly, whereas "imExSplitFactor 0.0;" would mean that implicitly defined forces will be treated in an explicit fashion. - -Note that the switch "treatVoidCellsAsExplicitForce true;" can be set in the couplingProperties in order to change the treatment of cells which are void of particles. This is only relevant if (i) smoothing is used, and (ii) implicit force coupling is performed. By default, the particle veloctiy field (Us) will be smoothed to obtain a meaningful reference quantity for the implicit force coupling. In case "treatVoidCellsAsExplicitForce true;" is set, however, Us will not be smoothed and implicit forces (after the smoothing has been performed) in cells void of particles be treated as explicit ones. This avoids the problem of defining Us in cells that are void of particles, but for which an implicit coupling force is obtained in the smoothing process. [Description:] -The momCoupleModel is the base class for momentum exchange between DEM and CFD simulation. +Forces can be coupled in an implicit way to the fluid solver (i.e., when solving +the Navier-Stokes equations, the fluid velocity at the new time will be +considered for the coupling force). This implicit coupling is typically done for +the drag forces (look for "impForces()" in the implementation of the drag model). +Implicit coupling is more stable (especially important for dense flows), but +conflicts Newton's third law. Explicit forces are imposed on the flow solver in +an explicit fashion (look for "expForces()" in the implementation of the drag +model), which is less stable, but does not conflict Newton's third law. -[Restrictions:] none. +Note that the variable {imExSplitFactor} can be set in the couplingProperties in +order to treat implicitly defined forces (in the implementation of the force +model) as explicit ones. {imExSplitFactor 1.0;} is set by default, meaning that +all implicit forces will be considered implicitly, whereas +{imExSplitFactor 0.0;} would mean that implicitly defined forces will be treated +in an explicit fashion. + +Note that the switch {treatVoidCellsAsExplicitForce true;} can be set in the +couplingProperties in order to change the treatment of cells which are void of +particles. This is only relevant if (i) smoothing is used, and (ii) implicit +force coupling is performed. By default, the particle velocity field (Us) will +be smoothed to obtain a meaningful reference quantity for the implicit force +coupling. In case {treatVoidCellsAsExplicitForce true;} is set, however, Us will +not be smoothed and implicit forces (after the smoothing has been performed) in +cells void of particles be treated as explicit ones. This avoids the problem of +defining Us in cells that are void of particles, but for which an implicit +coupling force is obtained in the smoothing process. + +The {momCoupleModel} is the base class for momentum exchange between DEM and CFD +simulation. + +[Restrictions:] + +none + +[Default:] + +none -[Default:] none. diff --git a/doc/momCoupleModel_explicitCouple.html b/doc/momCoupleModel_explicitCouple.html deleted file mode 100644 index ac6b5ba5..00000000 --- a/doc/momCoupleModel_explicitCouple.html +++ /dev/null @@ -1,52 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    momCoupleModel_explicitCouple command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    momCoupleModels
    -(
    -    explicitCouple
    -);
    -explicitCoupleProps
    -{
    -    fLimit vector;
    -} 
    -
    -
    • vector = limiter vector for explicit force term (default (1e10,1e10,1e10) ) - - -
    -

    Examples: -

    -
    momCoupleModels
    -(
    -    explicitCouple
    -);
    -explicitCoupleProps
    -{
    -    fLimit (1e3 1e2 1e4);
    -} 
    -
    -

    Description: -

    -

    The explicitCouple-model is a momCoupleModel model providing an explicit momentum source term for the CFD solver. -

    -

    Restrictions: -

    -

    Only for solvers that include explicit momentum exchange. -

    -

    Related commands: -

    -

    momCoupleModel -

    - diff --git a/doc/momCoupleModel_explicitCouple.txt b/doc/momCoupleModel_explicitCouple.txt index bdcb4655..4a3fe422 100644 --- a/doc/momCoupleModel_explicitCouple.txt +++ b/doc/momCoupleModel_explicitCouple.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -momCoupleModel_explicitCouple command :h3 +momCoupleModel explicitCouple command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. momCoupleModels ( @@ -36,7 +37,8 @@ explicitCoupleProps [Description:] -The explicitCouple-model is a momCoupleModel model providing an explicit momentum source term for the CFD solver. +The {explicitCouple} model is a momCoupleModel model providing an explicit +momentum source term for the CFD solver. [Restrictions:] diff --git a/doc/momCoupleModel_implicitCouple.html b/doc/momCoupleModel_implicitCouple.html deleted file mode 100644 index f2b1a00a..00000000 --- a/doc/momCoupleModel_implicitCouple.html +++ /dev/null @@ -1,62 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    momCoupleModel_implicitCouple command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    momCoupleModels
    -(
    -    implicitCouple
    -);
    -implicitCoupleProps
    -{
    -    velFieldName "U";
    -    granVelFieldName "Us";
    -    voidfractionFieldName "voidfraction";
    -    minAlphaP number;
    -} 
    -
    -
    • U = name of the finite volume fluid velocity field - -
    • Us = name of the finite volume granular velocity field - -
    • voidfraction = name of the finite volume voidfraction field - -number = minimum value for local particle volume fraction to calculate the exchange filed (default SMALL):l - -
    -

    Examples: -

    -
    momCoupleModels
    -(
    -    implicitCouple
    -);
    -implicitCoupleProps
    -{
    -    velFieldName "U";
    -    granVelFieldName "Us";
    -    voidfractionFieldName "voidfraction";
    -} 
    -
    -

    Description: -

    -

    The implicitCouple-model is a momCoupleModel model providing an implicit momentum source term for the CFD solver. -

    -

    Restrictions: -

    -

    Only for solvers that include implicit momentum exchange. -

    -

    Related commands: -

    -

    momCoupleModel -

    - diff --git a/doc/momCoupleModel_implicitCouple.txt b/doc/momCoupleModel_implicitCouple.txt index 08433eec..c1b4bf84 100644 --- a/doc/momCoupleModel_implicitCouple.txt +++ b/doc/momCoupleModel_implicitCouple.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -momCoupleModel_implicitCouple command :h3 +momCoupleModel implicitCouple command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. momCoupleModels ( @@ -17,16 +18,18 @@ momCoupleModels ); implicitCoupleProps \{ - velFieldName "U"; - granVelFieldName "Us"; + velFieldName "U"; + granVelFieldName "Us"; voidfractionFieldName "voidfraction"; - minAlphaP number; + KslLimit scalar1; + minAlphaP scalar2; \} :pre {U} = name of the finite volume fluid velocity field :ulb,l {Us} = name of the finite volume granular velocity field :l -{voidfraction} = name of the finite volume voidfraction field :l -{number} = minimum value for local particle volume fraction to calculate the exchange filed (default SMALL):l +{voidfraction} = name of the finite volume void fraction field :l +{scalar1} = (optional, default 1e10) limit implicit momentum exchange field :l +{scalar2} = (optional, default SMALL) minimum value for local particle volume fraction to calculate the exchange field :l :ule [Examples:] @@ -37,14 +40,15 @@ momCoupleModels ); implicitCoupleProps \{ - velFieldName "U"; - granVelFieldName "Us"; + velFieldName "U"; + granVelFieldName "Us"; voidfractionFieldName "voidfraction"; \} :pre [Description:] -The implicitCouple-model is a momCoupleModel model providing an implicit momentum source term for the CFD solver. +The {implicitCouple} model is a momCoupleModel model providing an implicit +momentum source term for the CFD solver. [Restrictions:] diff --git a/doc/momCoupleModel_noCouple.html b/doc/momCoupleModel_noCouple.html deleted file mode 100644 index 0ec1e601..00000000 --- a/doc/momCoupleModel_noCouple.html +++ /dev/null @@ -1,40 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    momCoupleModel_noCouple command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    momCoupleModels
    -(
    -    off
    -); 
    -
    -

    Examples: -

    -
    momCoupleModels
    -(
    -    off
    -); 
    -
    -

    Description: -

    -

    The noCouple-model is a dummy momCoupleModel model providing a no momentum source term for the CFD solver. -

    -

    Restrictions: -

    -

    Only for solvers that include no momentum exchange, e.g. immersed boundary. -

    -

    Related commands: -

    -

    momCoupleModel -

    - diff --git a/doc/momCoupleModel_noCouple.txt b/doc/momCoupleModel_noCouple.txt index 6972d30c..22bcfcdd 100644 --- a/doc/momCoupleModel_noCouple.txt +++ b/doc/momCoupleModel_noCouple.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -momCoupleModel_noCouple command :h3 +momCoupleModel off command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. momCoupleModels ( @@ -26,7 +27,8 @@ momCoupleModels [Description:] -The noCouple-model is a dummy momCoupleModel model providing a no momentum source term for the CFD solver. +The {off} model is a dummy momCoupleModel model providing a no momentum source +term for the CFD solver. [Restrictions:] diff --git a/doc/probeModel.html b/doc/probeModel.html deleted file mode 100644 index 72309a36..00000000 --- a/doc/probeModel.html +++ /dev/null @@ -1,42 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    probeModel command -

    -

    Syntax: -

    -

    To be activated via couplingProperties dictionary. -

    -
    probeModel myProbeModel; 
    -
    -

    Use probe model "off" to disable this feature. -

    -
    myProbeModelProps 
    -
    -
    { 
    -
    -
    }; 
    -
    -

    Examples: -

    -

    See particleProbe -

    -

    Note: This examples list might not be complete - please check below for the list of force models that can perform particle probing. -

    -

    Description: -

    -

    The probeModel feature allows to implement various probing features in CFDEM. Currently, only the particleProbe model is implemented, that performs probing of particle forces. -

    -

    Restrictions: -

    -

    None. -

    -

    Default: none. -

    - diff --git a/doc/probeModel.txt b/doc/probeModel.txt index 64826ed1..75882da1 100644 --- a/doc/probeModel.txt +++ b/doc/probeModel.txt @@ -1,7 +1,7 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,30 +9,41 @@ probeModel command :h3 [Syntax:] -To be activated via couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -probeModel myProbeModel; :pre - -Use probe model "off" to disable this feature. - -myProbeModelProps :pre -\{ :pre - -\}; :pre +probeModel model; +modelProps +\{ +\} :pre +model = name of the probeModel to be applied :ul [Examples:] -See "particleProbe"_probeModel_particleProbe.html +probeModel off; :pre -Note: This examples list might not be complete - please check below for the list of force models that can perform particle probing. +NOTE: This examples list might not be complete - please check below for the list +of probe models that can perform particle probing. [Description:] -The probeModel feature allows to implement various probing features in CFDEM. Currently, only the "particleProbe"_probeModel_particleProbe.html model is implemented, that performs probing of particle forces. +The {probeModel} feature allows to implement various probing features in CFDEM. +Currently, only the "particleProbe"_probeModel_particleProbe.html model is +implemented, that performs probing of particle forces. + +Use probe model {off} to disable this feature. [Restrictions:] -None. +none + +[Related commands:] + +"probeModel off"_probeModel_noProbe.html, +"probeModel particleProbe"_probeModel_particleProbe.html + +[Default:] + +none -[Default:] none. diff --git a/doc/probeModel_noProbe.html b/doc/probeModel_noProbe.html deleted file mode 100644 index 63021115..00000000 --- a/doc/probeModel_noProbe.html +++ /dev/null @@ -1,43 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    probeModel_noProbe command -

    -

    Syntax: -

    -

    To be activated via couplingProperties dictionary. -

    -
    forceModels
    -{
    -    myForceModel1
    -    myForceModel2
    -    myForceModel3
    -}; 
    -
    -

    Examples: -

    -
    probeModel off; 
    -
    -

    Note: This examples list might not be complete - please check below for the list of force models that can perform particle probing. -

    -

    Description: -

    -

    Does not perform any probing. -

    -

    Restrictions: -

    -

    None. -

    -

    Related commands which are currently enabled for particle probing: -

    -

    particleProbe -

    -

    Default: none. -

    - diff --git a/doc/probeModel_noProbe.txt b/doc/probeModel_noProbe.txt index b36c75e0..0b806f8d 100644 --- a/doc/probeModel_noProbe.txt +++ b/doc/probeModel_noProbe.txt @@ -1,39 +1,39 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -probeModel_noProbe command :h3 +probeModel off command :h3 [Syntax:] -To be activated via couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -forceModels -\{ - myForceModel1 - myForceModel2 - myForceModel3 -\}; :pre +probeModel off; :pre [Examples:] probeModel off; :pre -Note: This examples list might not be complete - please check below for the list of force models that can perform particle probing. +NOTE: This examples list might not be complete - please check below for the list +of models that can perform particle probing. [Description:] -Does not perform any probing. +This model does not perform any probing. [Restrictions:] -None. +none -[Related commands which are currently enabled for particle probing:] +[Related commands:] "particleProbe"_probeModel_particleProbe.html -[Default:] none. +[Default:] + +none + diff --git a/doc/probeModel_particleProbe.txt b/doc/probeModel_particleProbe.txt new file mode 100644 index 00000000..0d664b46 --- /dev/null +++ b/doc/probeModel_particleProbe.txt @@ -0,0 +1,102 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +probeModel particleProbe command :h3 + +[Syntax:] + +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. + +forceModels +( + forceModel1 + forceModel2 + forceModel3 +); :pre + +probeModel particleProbe; :pre + +particleProbeProps +\{ + particleIDsToSample (ID1 ID2 ID3 ...); // list of particleIDs to sample + verboseToFile; // main switch + verbose; // currently not used + printEvery xEvery; // print every this many CFD time steps + sampleAll; // Activate sampling for all particles + probeDebug; // probes additional fields + includePosition; // will include particle position in the output file + writePrecision xPrecision; // number of significant digits to print +\} :pre + +{forceModeli} = list of force models in the simulation, the particleProbe will be applied to all of these models! :ulb,l +{particleIDsToSample} = list of particle IDs to be sampled. :l +{verboseToFile} = main switch to activate the particle probe (default = off). :l +{verbose} = main switch to activate output to Info (currently not implemented). :l +{xEvery} = integer to specify the interval for sampling (default = 1, i.e., probing occurs every CFD time step). :l +{sampleAll} = switch to activate sampling of all particles. Otherwise (default) only particles specified via "particleIDsToSample" in the couplingProperties dictionary will be sampled. :l + +{probeDebug} = switch to activate probing of debug properties of secondary importance (specific for each force model). :l +{includePosition} = switch to add the particle position in the log file (default = off). :l +{xPrecision} = number of significant digits of the text output (default = 3). :l +:ule + +[Examples:] + +forceModels +( + gradPForce +); :pre + +probeModel particleProbe; :pre + +particleProbeProps +\{ + particleIDsToSample (0 1 2 3); + verboseToFile; // main switch + verbose; // currently not used + printEvery 100; // print every this many CFD time steps + sampleAll; // activate sampling for all particles + probeDebug; // probes additional fields + includePosition; // will include particle position in the output file + writePrecision 4; // number of significant digits to print +\}; :pre + +NOTE: This examples list might not be complete - please check below for the list +of models that can perform particle probing. + +[Description:] + +The {particleProbe} feature keeps track of per-particle quantities (e.g., the +fluid-particle interaction forces) acting on each DEM particle, and handles its +storage during the simulation. Data is saved in the +$caseDir/CFD/particleProbes/startTime directory, where {startTime} is the time +at which the simulation is started (this avoids unwanted deletion of +particleProbe data). + +[Restrictions:] + +none + +[Related commands:] + +The following force models are currently enabled for particle probing: + +Archimedes, ArchimedesIB, BeetstraDrag, DiFeliceDrag, GidaspowDrag, +KochHillDrag, SchillerNaumannDrag, ShirgaonkarIB, virtualMassForce, +"gradPForce"_forceModel_gradPForce.html, "viscForce"_forceModel_viscForce.html, +"MeiLift"_forceModel_MeiLift.html, that is most of the forceModels, see the +{src} directory for details, i.e. use + +grep -r 'probeM(' ./ :pre + +in a CLI terminal. + +[Default:] + +none + diff --git a/doc/regionModel.html b/doc/regionModel.html deleted file mode 100644 index 7d2304f6..00000000 --- a/doc/regionModel.html +++ /dev/null @@ -1,34 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    regionModel command -

    -

    Syntax: -

    -

    Note: In the current CFDEMcoupling version, this model is no longer used. Defined in couplingProperties dictionary. -

    -
    regionModel model; 
    -
    -
    • model = name of the regionModel to be applied -
    -

    Examples: -

    -
    regionModel allRegion; 
    -
    -

    Note: This examples list might not be complete - please look for other models (regionModel_XY) in this documentation. -

    -

    Description: -

    -

    The regionModel is the base class for region models to select a certain region for coupled simulation. -

    -

    Restrictions: none. -

    -

    Default: none. -

    - diff --git a/doc/regionModel.txt b/doc/regionModel.txt index e83d0132..880d09f3 100644 --- a/doc/regionModel.txt +++ b/doc/regionModel.txt @@ -1,15 +1,18 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line regionModel command :h3 -[Syntax:] +NOTE: In the current CFDEMcoupling version, this model is no longer used. -Note: In the current CFDEMcoupling version, this model is no longer used. Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. + +[Syntax:] regionModel model; :pre @@ -19,12 +22,19 @@ model = name of the regionModel to be applied :ul regionModel allRegion; :pre -Note: This examples list might not be complete - please look for other models (regionModel_XY) in this documentation. +NOTE: This examples list might not be complete - please look for other models +(regionModel XY) in this documentation. [Description:] -The regionModel is the base class for region models to select a certain region for coupled simulation. +The {regionModel} is the base class for region models to select a certain region +for coupled simulation. -[Restrictions:] none. +[Restrictions:] + +none + +[Default:] + +none -[Default:] none. diff --git a/doc/regionModel_allRegion.html b/doc/regionModel_allRegion.html deleted file mode 100644 index 048c863e..00000000 --- a/doc/regionModel_allRegion.html +++ /dev/null @@ -1,32 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    regionModel_allRegion command -

    -

    Syntax: -

    -

    Note: In the current CFDEMcoupling version, this model is no longer used. Defined in couplingProperties dictionary. -

    -
    regionModel allRegion; 
    -
    -

    Examples: -

    -
    regionModel allRegion; 
    -
    -

    Description: -

    -

    The allRegion-model is a region model including the whole CFD region for the coupling. -

    -

    Restrictions: None. -

    -

    Related commands: -

    -

    regionModel -

    - diff --git a/doc/regionModel_allRegion.txt b/doc/regionModel_allRegion.txt index c0e37441..92e88a7c 100644 --- a/doc/regionModel_allRegion.txt +++ b/doc/regionModel_allRegion.txt @@ -1,15 +1,18 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -regionModel_allRegion command :h3 +regionModel allRegion command :h3 [Syntax:] -Note: In the current CFDEMcoupling version, this model is no longer used. Defined in couplingProperties dictionary. +NOTE: In the current CFDEMcoupling version, this model is no longer used. + +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. regionModel allRegion; :pre @@ -19,9 +22,11 @@ regionModel allRegion; :pre [Description:] -The allRegion-model is a region model including the whole CFD region for the coupling. +The {allRegion} model is a region model including the whole CFD region for the coupling. -[Restrictions:] None. +[Restrictions:] + +none [Related commands:] diff --git a/doc/smoothingModel.html b/doc/smoothingModel.html deleted file mode 100644 index 78e8f23e..00000000 --- a/doc/smoothingModel.html +++ /dev/null @@ -1,38 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    smoothingModel command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    smoothingModel model; 
    -
    -
    • model = name of the smoothingModel to be applied -
    -

    Examples: -

    -
    smoothingModel off; 
    -
    -
    smoothingModel  constDiffSmoothing; 
    -
    -

    Note: This examples list might not be complete - please look for other models (smoothingModel_XY) in this documentation. -

    -

    ATTENTION: In case a smoothing model is used in conjunction with "PimpleImEx" solvers, the fields "f" and "fSmooth" must be placed in the initial time directory! This is because zeroGradient boundary conditions for the fields "f" and "fSmooth" must be specified, otherwise the smoothing operation will give an Error. -

    -

    Description: -

    -

    The smoothingModel is the base class for models that smoothen the exchange fields (i.e., voidfraction and the Ksl field in case of implicit force coupling). This is relevant in case one uses a small grid resolution compared to the local particle diameter (or parcel diameter in case one uses a parcel approach). -

    -

    Restrictions: These models are in beta testing. -

    -

    Default: none. -

    - diff --git a/doc/smoothingModel.txt b/doc/smoothingModel.txt index 903a4771..b190a273 100644 --- a/doc/smoothingModel.txt +++ b/doc/smoothingModel.txt @@ -1,7 +1,7 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line @@ -9,7 +9,8 @@ smoothingModel command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. smoothingModel model; :pre @@ -17,17 +18,30 @@ model = name of the smoothingModel to be applied :ul [Examples:] -smoothingModel off; :pre -smoothingModel constDiffSmoothing; :pre +smoothingModel off; +smoothingModel constDiffSmoothing; :pre -Note: This examples list might not be complete - please look for other models (smoothingModel_XY) in this documentation. +NOTE: This examples list might not be complete - please look for other models +(smoothingModel XY) in this documentation. -ATTENTION: In case a smoothing model is used in conjunction with "PimpleImEx" solvers, the fields "f" and "fSmooth" must be placed in the initial time directory! This is because zeroGradient boundary conditions for the fields "f" and "fSmooth" must be specified, otherwise the smoothing operation will give an Error. +IMPORTANT NOTE: In case a smoothing model is used in conjunction with +"PimpleImEx" solvers, the fields "f" and "fSmooth" must be placed in the initial +time directory! This is because zeroGradient boundary conditions for the fields +"f" and "fSmooth" must be specified, otherwise the smoothing operation will give +an error. [Description:] -The smoothingModel is the base class for models that smoothen the exchange fields (i.e., voidfraction and the Ksl field in case of implicit force coupling). This is relevant in case one uses a small grid resolution compared to the local particle diameter (or parcel diameter in case one uses a parcel approach). +The {smoothingModel} is the base class for models that smoothen the exchange +fields (i.e., void fraction and the Ksl field in case of implicit force coupling). +This is relevant in case one uses a small grid resolution compared to the local +particle diameter (or parcel diameter in case one uses a parcel approach). -[Restrictions:] These models are in beta testing. +[Restrictions:] + +These models are in beta testing. + +[Default:] + +none -[Default:] none. diff --git a/doc/smoothingModel_constDiffSmoothing.html b/doc/smoothingModel_constDiffSmoothing.html deleted file mode 100644 index cf5904ab..00000000 --- a/doc/smoothingModel_constDiffSmoothing.html +++ /dev/null @@ -1,58 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    smoothingModel_constDiffSmoothing command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    smoothingModel constDiffSmoothing;
    -constDiffSmoothingProps
    -{
    -    lowerLimit number1;
    -    upperLimit number2;
    -    smoothingLength lengthScale;
    -    smoothingLengthReferenceField lengthScaleRefField;
    -} 
    -
    -
    • number1 = scalar fields will be bound to this lower value - -
    • number2 = scalar fields will be bound to this upper value - -
    • lengthScale = length scale over which the exchange fields will be smoothed out - -
    • lengthScaleRefField = length scale over which reference fields (e.g., the average particle velocity) will be smoothed out. Should be always larger than lengthScale. If not specified, will be equal to lengthScale. - - -
    -

    Examples: -

    -
    constDiffSmoothingProps
    -{
    -    lowerLimit 0.1;
    -    upperLimit 1e10;
    -    smoothingLength 1500e-6;
    -    smoothingLengthReferenceField 9000e-6;
    -} 
    -
    -

    Description: -

    -

    The "constDiffSmoothing" model is a basic smoothingModel model which reads a smoothing length scale being used for smoothing the exchange fields (voidfraction, Ksl, f if present). This model can be used for smoothing explicit force coupling fields, as well as implicit force coupling algorithms. -Smoothing for reference fields is performed to "fill in" values in cells in which these reference fields are not specified. Values calculated in the cells (via Lagrangian-To-Euler mapping) are NOT changed! These reference fields are, e.g., the average particle velocity, which are not specified in all cells in case the flow is rather dilute. -

    -

    Restrictions: This model is tested in a limited number of flow situations. -

    -

    ATTENTION: In case a smoothing model is used in conjunction with "PimpleImEx" solvers, the fields "f" and "fSmooth" must be placed in the initial time directory! This is because zeroGradient boundary conditions for the fields "f" and "fSmooth" must be specified, otherwise the smoothing operation will give an Error. -

    -

    Related commands: -

    -

    smoothingModel -

    - diff --git a/doc/smoothingModel_constDiffSmoothing.txt b/doc/smoothingModel_constDiffSmoothing.txt index 54f75cfd..9ff82ecd 100644 --- a/doc/smoothingModel_constDiffSmoothing.txt +++ b/doc/smoothingModel_constDiffSmoothing.txt @@ -1,50 +1,65 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -smoothingModel_constDiffSmoothing command :h3 +smoothingModel constDiffSmoothing command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. smoothingModel constDiffSmoothing; constDiffSmoothingProps \{ - lowerLimit number1; - upperLimit number2; - smoothingLength lengthScale; + lowerLimit number1; + upperLimit number2; + smoothingLength lengthScale; smoothingLengthReferenceField lengthScaleRefField; + verbose; \} :pre {number1} = scalar fields will be bound to this lower value :ulb,l {number2} = scalar fields will be bound to this upper value :l {lengthScale} = length scale over which the exchange fields will be smoothed out :l {lengthScaleRefField} = length scale over which reference fields (e.g., the average particle velocity) will be smoothed out. Should be always larger than lengthScale. If not specified, will be equal to lengthScale. :l +{verbose} = (optional, default false) flag for debugging output :l :ule [Examples:] constDiffSmoothingProps \{ - lowerLimit 0.1; - upperLimit 1e10; - smoothingLength 1500e-6; + lowerLimit 0.1; + upperLimit 1e10; + smoothingLength 1500e-6; smoothingLengthReferenceField 9000e-6; \} :pre [Description:] -The "constDiffSmoothing" model is a basic smoothingModel model which reads a smoothing length scale being used for smoothing the exchange fields (voidfraction, Ksl, f if present). This model can be used for smoothing explicit force coupling fields, as well as implicit force coupling algorithms. -Smoothing for reference fields is performed to "fill in" values in cells in which these reference fields are not specified. Values calculated in the cells (via Lagrangian-To-Euler mapping) are NOT changed! These reference fields are, e.g., the average particle velocity, which are not specified in all cells in case the flow is rather dilute. +The {constDiffSmoothing} model is a basic smoothingModel model which reads a +smoothing length scale being used for smoothing the exchange fields +(void fraction, Ksl, f if present). This model can be used for smoothing explicit +force coupling fields, as well as implicit force coupling algorithms. +Smoothing for reference fields is performed to "fill in" values in cells in +which these reference fields are not specified. Values calculated in the cells +(via Lagrangian-To-Euler mapping) are NOT changed! These reference fields are, +e.g. the average particle velocity, which are not specified in all cells in case +the flow is rather dilute. -[Restrictions:] This model is tested in a limited number of flow situations. +[Restrictions:] -ATTENTION: In case a smoothing model is used in conjunction with "PimpleImEx" solvers, the fields "f" and "fSmooth" must be placed in the initial time directory! This is because zeroGradient boundary conditions for the fields "f" and "fSmooth" must be specified, otherwise the smoothing operation will give an Error. +This model is tested in a limited number of flow situations. +IMPORTANT NOTE: In case a smoothing model is used in conjunction with +"PimpleImEx" solvers, the fields "f" and "fSmooth" must be placed in the initial +time directory! This is because zeroGradient boundary conditions for the fields +"f" and "fSmooth" must be specified, otherwise the smoothing operation will give +an error. [Related commands:] diff --git a/doc/smoothingModel_noSmoothing.html b/doc/smoothingModel_noSmoothing.html deleted file mode 100644 index 40081ed7..00000000 --- a/doc/smoothingModel_noSmoothing.html +++ /dev/null @@ -1,32 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    smoothingModel_noSmoothing command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    smoothingModel off; 
    -
    -

    Examples: -

    -
    smoothingModel off; 
    -
    -

    Description: -

    -

    The "noSmoothing" model is a dummy smoothingModel model which does no smoothing. -

    -

    Restrictions: none. -

    -

    Related commands: -

    -

    smoothingModel -

    - diff --git a/doc/smoothingModel_noSmoothing.txt b/doc/smoothingModel_noSmoothing.txt index 827748e2..6b5bf89a 100644 --- a/doc/smoothingModel_noSmoothing.txt +++ b/doc/smoothingModel_noSmoothing.txt @@ -1,15 +1,16 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -smoothingModel_noSmoothing command :h3 +smoothingModel off command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. smoothingModel off; :pre @@ -19,9 +20,11 @@ smoothingModel off; :pre [Description:] -The "noSmoothing" model is a dummy smoothingModel model which does no smoothing. +The {off} model is a dummy smoothingModel model which performs no smoothing. -[Restrictions:] none. +[Restrictions:] + +none [Related commands:] diff --git a/doc/smoothingModel_temporalSmoothing.txt b/doc/smoothingModel_temporalSmoothing.txt new file mode 100644 index 00000000..7be01983 --- /dev/null +++ b/doc/smoothingModel_temporalSmoothing.txt @@ -0,0 +1,62 @@ +"CFDEMproject Website"_lws - "Main Page"_main :c + +:link(lws,http://www.cfdem.com) +:link(main,CFDEMcoupling_Manual.html) + +:line + +smoothingModel temporalSmoothing command :h3 + +[Syntax:] + +Defined in dictionary depending on the application. + +smoothingModel temporalSmoothing; +temporalSmoothingProps +\{ + lowerLimit number1; + upperLimit number2; + refField referenceField; + gamma smoothingStrength; +\} :pre + +{number1} = scalar fields will be bound to this lower value :ulb,l +{number2} = scalar fields will be bound to this upper value :l +{referenceField} = reference to the un-smoothed field required for the relaxation operation :l +{smoothingStrength} = control parameter for the smoothing, lower value yields stronger smoothing (gamma = 1 results in an equal contribution from the un-smoothed and smoothed fields) :l +:ule + +[Examples:] + +temporalSmoothingProps +\{ + lowerLimit 0.1; + upperLimit 1e10; + referenceField "p"; + gamma 1.0; +\} :pre + +[Description:] + +The {temporalSmoothing} model is a smoothing model that utilizes temporal +relaxation of a desired quantity. This model can be used to filter out +high-frequency fluctuations (e.g. numerical noise) controlled via the control +parameter gamma. +Note that this model does NOT smooth the calculated fields, instead smoothing is +performed on a separate (smooth) field which uses the calculated (un-smooth) +field as a reference. +Thus its usage is limited and CANNOT be used to smooth the exchange fields +similar to other smoothing models. +For further information see Vångö et al., "Unresolved CFD–DEM modeling of +multiphase flow in densely packed particle beds", Appl. Math. Model. (2018). + +[Restrictions:] + +This model does NOT smooth the calculated fields and can therefore NOT be used +as a general smoothing model to smoothen the exchange fields. +Attempting this will generate an error. + +[Related commands:] + +"smoothingModel"_smoothingModel.html + diff --git a/doc/voidFractionModel.html b/doc/voidFractionModel.html deleted file mode 100644 index 0dd37937..00000000 --- a/doc/voidFractionModel.html +++ /dev/null @@ -1,34 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    voidfractionModel command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    voidfractionModel model; 
    -
    -
    • model = name of the voidfractionModel to be applied -
    -

    Examples: -

    -
    voidfractionModel centre; 
    -
    -

    Note: This examples list might not be complete - please look for other models (voidfractionModel_XY) in this documentation. -

    -

    Description: -

    -

    The voidfractionModel is the base class for models to represent the DEM particle's volume in the CFD domain via a voidfraction field. -

    -

    Restrictions: none. -

    -

    Default: none. -

    - diff --git a/doc/voidFractionModel.txt b/doc/voidFractionModel.txt index c4310692..d08db44f 100644 --- a/doc/voidFractionModel.txt +++ b/doc/voidFractionModel.txt @@ -1,30 +1,38 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -voidfractionModel command :h3 +voidFractionModel command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -voidfractionModel model; :pre +voidFractionModel model; :pre -model = name of the voidfractionModel to be applied :ul +model = name of the voidFractionModel to be applied :ul [Examples:] -voidfractionModel centre; :pre +voidFractionModel centre; :pre -Note: This examples list might not be complete - please look for other models (voidfractionModel_XY) in this documentation. +NOTE: This examples list might not be complete - please look for other models +(voidFractionModel XY) in this documentation. [Description:] -The voidfractionModel is the base class for models to represent the DEM particle's volume in the CFD domain via a voidfraction field. +The {voidFractionModel} is the base class for models to represent the DEM +particle's volume in the CFD domain via a void fraction field. -[Restrictions:] none. +[Restrictions:] + +none + +[Default:] + +none -[Default:] none. diff --git a/doc/voidFractionModel_GaussVoidFraction.html b/doc/voidFractionModel_GaussVoidFraction.html deleted file mode 100644 index 2ad4fd92..00000000 --- a/doc/voidFractionModel_GaussVoidFraction.html +++ /dev/null @@ -1,60 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    voidfractionModel_GaussVoidFraction command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    voidfractionModel Gauss;
    -GaussProps
    -{
    -    maxCellsPerParticle number1;
    -    alphaMin number2;
    -    weight number3;
    -    porosity number4;
    -} 
    -
    -
    • number1 = maximum number of cells covered by a particle (search will fail when more than number1 cells are covered by the particle) - -
    • number2 = minimum limit for voidfraction - -
    • number3 = (optional) scaling of the particle volume to account for porosity or agglomerations. - -
    • number4 = (optional) diameter of the particle's representation is artificially increased according to number2 * Vparticle, volume remains unaltered! - - -
    -

    Examples: -

    -
    voidfractionModel Gauss;
    -GaussProps
    -{
    -    maxCellsPerParticle 1000;
    -    alphaMin 0.10;
    -    weight 1.;
    -    porosity 1.;
    -} 
    -
    -

    Description: -

    -

    The Gauss voidFraction model is supposed to be used when a particle (or its representation) is bigger than a CFD cell. The voidfraction field is set in those cell whose centres are inside the particle. The volume is here distributed according to a Gaussian distribution. -

    -

    The region of influence of a particle can be increased artificially by "porosity", which blows up the particles, but keeps their volume (for voidfraction calculation) constant. -

    -

    The particle volume occupied in the CFD domain can be adjusted by the parameter "weight", using Vparticle=dsphere^3*pi/6*weight. -

    -

    Restrictions: none. -

    -

    Related commands: -

    -

    voidfractionModel , bigParticle -

    - diff --git a/doc/voidFractionModel_GaussVoidFraction.txt b/doc/voidFractionModel_GaussVoidFraction.txt index ceca74b2..3468c000 100644 --- a/doc/voidFractionModel_GaussVoidFraction.txt +++ b/doc/voidFractionModel_GaussVoidFraction.txt @@ -1,53 +1,63 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -voidfractionModel_GaussVoidFraction command :h3 +voidFractionModel Gauss command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -voidfractionModel Gauss; +voidFractionModel Gauss; GaussProps \{ maxCellsPerParticle number1; - alphaMin number2; - weight number3; - porosity number4; + alphaMin number2; + weight number3; + porosity number4; \} :pre {number1} = maximum number of cells covered by a particle (search will fail when more than {number1} cells are covered by the particle) :ulb,l -{number2} = minimum limit for voidfraction :l -{number3} = (optional) scaling of the particle volume to account for porosity or agglomerations. :l -{number4} = (optional) diameter of the particle's representation is artificially increased according to {number2} * Vparticle, volume remains unaltered! :l +{number2} = minimum limit for void fraction :l +{number3} = (optional, default 1.0) scaling of the particle volume to account for porosity or agglomerations. :l +{number4} = (optional, default 1.0) diameter of the particle's representation is artificially increased according to {number2} * Vparticle, volume remains unaltered! :l :ule [Examples:] -voidfractionModel Gauss; +voidFractionModel Gauss; GaussProps \{ maxCellsPerParticle 1000; - alphaMin 0.10; - weight 1.; - porosity 1.; + alphaMin 0.10; + weight 1.0; + porosity 1.0; \} :pre [Description:] -The Gauss voidFraction model is supposed to be used when a particle (or its representation) is bigger than a CFD cell. The voidfraction field is set in those cell whose centres are inside the particle. The volume is here distributed according to a Gaussian distribution. +The {Gauss} void fraction model is supposed to be used when a particle (or its +representation) is bigger than a CFD cell. The void fraction field is set in +those cell whose centres are inside the particle. The volume is here distributed +according to a Gaussian distribution. -The region of influence of a particle can be increased artificially by "porosity", which blows up the particles, but keeps their volume (for voidfraction calculation) constant. +The region of influence of a particle can be increased artificially by +"porosity", which blows up the particles, but keeps their volume (for +void fraction calculation) constant. -The particle volume occupied in the CFD domain can be adjusted by the parameter "weight", using Vparticle=dsphere^3*pi/6*weight. +The particle volume occupied in the CFD domain can be adjusted by the parameter +"weight", using Vparticle=dsphere^3*pi/6*weight. -[Restrictions:] none. +[Restrictions:] + +none [Related commands:] -"voidfractionModel"_voidfractionModel.html , "bigParticle"_voidFractionModel_bigParticleVoidFraction.html +"voidFractionModel"_voidFractionModel.html, +"bigParticle"_voidFractionModel_bigParticleVoidFraction.html diff --git a/doc/voidFractionModel_IBVoidFraction.html b/doc/voidFractionModel_IBVoidFraction.html deleted file mode 100644 index bdb61e78..00000000 --- a/doc/voidFractionModel_IBVoidFraction.html +++ /dev/null @@ -1,56 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    voidfractionModel_IBVoidFraction command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    voidfractionModel IB;
    -IBProps
    -{
    -    maxCellsPerParticle number1;
    -    alphaMin number2;
    -    scaleUpVol number3;
    -} 
    -
    -
    • number1 = maximum number of cells covered by a particle (search will fail when more than number1 cells are covered by the particle) - -
    • number2 = minimum limit for voidfraction - -
    • number3 = diameter of the particle's representation is artificially increased according to number3 * Vparticle, volume remains unaltered! - - -
    -

    Examples: -

    -
    voidfractionModel IB;
    -IBProps
    -{
    -    maxCellsPerParticle 1000;
    -    alphaMin 0.10;
    -    scaleUpVol 5.0;
    -} 
    -
    -

    Description: -

    -

    The IB voidFraction model is supposed to be used when a particle (or its representation) is bigger than a CFD cell. The voidfraction field is set in those cell whose centres are inside the particle. The model is specially designed for cfdemSolverIB and creates a smooth transition of the voidfraction at the particle surface. Cells which are only partially covered by solid are marked by voidfraction values between 0 and 1 respectively. -

    -

    The region of influence of a particle can be increased artificially by "scaleUpVol", which blows up the particles, but keeps their volume (for voidfraction calculation) constant. -

    -

    Code of this sub-model contributed by Alice Hager, JKU. -

    -

    Restrictions: none. -

    -

    Related commands: -

    -

    voidfractionModel -

    - diff --git a/doc/voidFractionModel_IBVoidFraction.txt b/doc/voidFractionModel_IBVoidFraction.txt index d300c8b9..753e26ec 100644 --- a/doc/voidFractionModel_IBVoidFraction.txt +++ b/doc/voidFractionModel_IBVoidFraction.txt @@ -1,50 +1,62 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -voidfractionModel_IBVoidFraction command :h3 +voidFractionModel IB command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -voidfractionModel IB; +voidFractionModel IB; IBProps \{ maxCellsPerParticle number1; - alphaMin number2; - scaleUpVol number3; + alphaMin number2; + scaleUpVol number3; \} :pre -{number1} = maximum number of cells covered by a particle (search will fail when more than {number1} cells are covered by the particle) :ulb,l -{number2} = minimum limit for voidfraction :l -{number3} = diameter of the particle's representation is artificially increased according to {number3} * Vparticle, volume remains unaltered! :l +{number1} = maximum number of cells covered by a particle (search will fail when +more than {number1} cells are covered by the particle) :ulb,l +{number2} = minimum limit for void fraction :l +{number3} = diameter of the particle's representation is artificially increased +according to {number3} * Vparticle, volume remains unaltered! :l :ule [Examples:] -voidfractionModel IB; +voidFractionModel IB; IBProps \{ maxCellsPerParticle 1000; - alphaMin 0.10; - scaleUpVol 5.0; + alphaMin 0.10; + scaleUpVol 5.0; \} :pre [Description:] -The IB voidFraction model is supposed to be used when a particle (or its representation) is bigger than a CFD cell. The voidfraction field is set in those cell whose centres are inside the particle. The model is specially designed for cfdemSolverIB and creates a smooth transition of the voidfraction at the particle surface. Cells which are only partially covered by solid are marked by voidfraction values between 0 and 1 respectively. +The {IB} void fraction model is supposed to be used when a particle (or its +representation) is bigger than a CFD cell. The void fraction field is set in +those cell whose centres are inside the particle. The model is specially +designed for cfdemSolverIB and creates a smooth transition of the void fraction +at the particle surface. Cells which are only partially covered by solid are +marked by void fraction values between 0 and 1 respectively. -The region of influence of a particle can be increased artificially by "scaleUpVol", which blows up the particles, but keeps their volume (for voidfraction calculation) constant. +The region of influence of a particle can be increased artificially by +"scaleUpVol", which blows up the particles, but keeps their volume (for +void fraction calculation) constant. -Code of this sub-model contributed by Alice Hager, JKU. +Code of this sub-model was contributed by Alice Hager, JKU. -[Restrictions:] none. +[Restrictions:] + +none [Related commands:] -"voidfractionModel"_voidfractionModel.html +"voidFractionModel"_voidFractionModel.html diff --git a/doc/voidFractionModel_bigParticleVoidFraction.html b/doc/voidFractionModel_bigParticleVoidFraction.html deleted file mode 100644 index ad0b0c05..00000000 --- a/doc/voidFractionModel_bigParticleVoidFraction.html +++ /dev/null @@ -1,62 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    voidfractionModel_bigParticleVoidFraction command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    voidfractionModel bigParticle;
    -bigParticleProps
    -{
    -    maxCellsPerParticle number1;
    -    alphaMin number2;
    -    weight number3;
    -    porosity number4;
    -} 
    -
    -
    • number1 = maximum number of cells covered by a particle (search will fail when more than number1 cells are covered by the particle) - -
    • number2 = minimum limit for voidfraction - -
    • number3 = (optional) scaling of the particle volume to account for porosity or agglomerations. - -
    • number4 = (optional) diameter of the particle's representation is artificially increased according to number2 * Vparticle, volume remains unaltered! - - -
    -

    Examples: -

    -
    voidfractionModel bigParticle;
    -bigParticleProps
    -{
    -    maxCellsPerParticle 1000;
    -    alphaMin 0.10;
    -    weight 1.;
    -    porosity 5.0;
    -} 
    -
    -

    Description: -

    -

    The bigParticle voidFraction model is supposed to be used when a particle (or its representation) is bigger than a CFD cell. The voidfraction field is set in those cell whose centres are inside the particle which results in a stairstep representation of the bodies within the mesh (i.e. voidfraction is either 1 (fluid) of zero (solid)). For archiving accurate results, approx. 8 cells per particle diameter are necessary. -

    -

    The region of influence of a particle can be increased artificially by "porosity", which blows up the particles, but keeps their volume (for voidfraction calculation) constant. -

    -

    The particle volume occupied in the CFD domain can be adjusted by the parameter "weight", using Vparticle=dsphere^3*pi/6*weight. -

    -

    Parts of this sub-model contributed by Alice Hager, JKU. -

    -

    Restrictions: none. -

    -

    Related commands: -

    -

    voidfractionModel -

    - diff --git a/doc/voidFractionModel_bigParticleVoidFraction.txt b/doc/voidFractionModel_bigParticleVoidFraction.txt index d6d43299..5e05b4b0 100644 --- a/doc/voidFractionModel_bigParticleVoidFraction.txt +++ b/doc/voidFractionModel_bigParticleVoidFraction.txt @@ -1,55 +1,66 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -voidfractionModel_bigParticleVoidFraction command :h3 +voidFractionModel bigParticle command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -voidfractionModel bigParticle; +voidFractionModel bigParticle; bigParticleProps \{ maxCellsPerParticle number1; - alphaMin number2; - weight number3; - porosity number4; + alphaMin number2; + weight number3; + porosity number4; \} :pre {number1} = maximum number of cells covered by a particle (search will fail when more than {number1} cells are covered by the particle) :ulb,l -{number2} = minimum limit for voidfraction :l -{number3} = (optional) scaling of the particle volume to account for porosity or agglomerations. :l -{number4} = (optional) diameter of the particle's representation is artificially increased according to {number2} * Vparticle, volume remains unaltered! :l +{number2} = minimum limit for void fraction :l +{number3} = (optional, default 1.0) scaling of the particle volume to account for porosity or agglomerations. :l +{number4} = (optional, default 1.0) diameter of the particle's representation is artificially increased according to {number2} * Vparticle, volume remains unaltered! :l :ule [Examples:] -voidfractionModel bigParticle; +voidFractionModel bigParticle; bigParticleProps \{ maxCellsPerParticle 1000; - alphaMin 0.10; - weight 1.; - porosity 5.0; + alphaMin 0.10; + weight 1.0; + porosity 5.0; \} :pre [Description:] -The bigParticle voidFraction model is supposed to be used when a particle (or its representation) is bigger than a CFD cell. The voidfraction field is set in those cell whose centres are inside the particle which results in a stairstep representation of the bodies within the mesh (i.e. voidfraction is either 1 (fluid) of zero (solid)). For archiving accurate results, approx. 8 cells per particle diameter are necessary. +The {bigParticle} void fraction model is supposed to be used when a particle (or +its representation) is bigger than a CFD cell. The void fraction field is set in +those cell whose centres are inside the particle which results in a stairstep +representation of the bodies within the mesh (i.e. void fraction is either 1 +(fluid) of zero (solid)). For archiving accurate results, approx. 8 cells per +particle diameter are necessary. -The region of influence of a particle can be increased artificially by "porosity", which blows up the particles, but keeps their volume (for voidfraction calculation) constant. +The region of influence of a particle can be increased artificially by +"porosity", which blows up the particles, but keeps their volume (for +void fraction calculation) constant. -The particle volume occupied in the CFD domain can be adjusted by the parameter "weight", using Vparticle=dsphere^3*pi/6*weight. +The particle volume occupied in the CFD domain can be adjusted by the parameter +"weight", using Vparticle=dsphere^3*pi/6*weight. -Parts of this sub-model contributed by Alice Hager, JKU. +Parts of this sub-model were contributed by Alice Hager, JKU. -[Restrictions:] none. +[Restrictions:] + +none [Related commands:] -"voidfractionModel"_voidfractionModel.html +"voidFractionModel"_voidFractionModel.html diff --git a/doc/voidFractionModel_centreVoidFraction.html b/doc/voidFractionModel_centreVoidFraction.html deleted file mode 100644 index 94ccd154..00000000 --- a/doc/voidFractionModel_centreVoidFraction.html +++ /dev/null @@ -1,50 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    voidfractionModel_centreVoidFraction command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    voidfractionModel centre;
    -centreProps
    -{
    -    alphaMin number1;
    -    weight number2;
    -} 
    -
    -
    • number1 = minimum limit for voidfraction - -
    • number2 = (optional) scaling of the particle volume to account for porosity or agglomerations. - - -
    -

    Examples: -

    -
    voidfractionModel centre;
    -centreProps
    -{
    -    alphaMin 0.1;
    -    weight 1.;
    -} 
    -
    -

    Description: -

    -

    The centre voidFraction model calculates the voidfraction in a CFD cell accounting for the volume of the particles whose centres are inside the cell. -

    -

    The particle volume occupied in the CFD domain can be adjusted by the parameter "weight", using Vparticle=dsphere^3*pi/6*weight. -

    -

    Restrictions: none. -

    -

    Related commands: -

    -

    voidfractionModel -

    - diff --git a/doc/voidFractionModel_centreVoidFraction.txt b/doc/voidFractionModel_centreVoidFraction.txt index 60141f57..597293fd 100644 --- a/doc/voidFractionModel_centreVoidFraction.txt +++ b/doc/voidFractionModel_centreVoidFraction.txt @@ -1,45 +1,50 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -voidfractionModel_centreVoidFraction command :h3 +voidFractionModel centre command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -voidfractionModel centre; +voidFractionModel centre; centreProps \{ alphaMin number1; - weight number2; + weight number2; \} :pre -{number1} = minimum limit for voidfraction :ulb,l +{number1} = minimum limit for void fraction :ulb,l {number2} = (optional) scaling of the particle volume to account for porosity or agglomerations. :l :ule [Examples:] -voidfractionModel centre; +voidFractionModel centre; centreProps \{ alphaMin 0.1; - weight 1.; + weight 1.0; \} :pre [Description:] -The centre voidFraction model calculates the voidfraction in a CFD cell accounting for the volume of the particles whose centres are inside the cell. +The {centre} void fraction model calculates the void fraction in a CFD cell +accounting for the volume of the particles whose centres are inside the cell. -The particle volume occupied in the CFD domain can be adjusted by the parameter "weight", using Vparticle=dsphere^3*pi/6*weight. +The particle volume occupied in the CFD domain can be adjusted by the parameter +"weight", using Vparticle=dsphere^3*pi/6*weight. -[Restrictions:] none. +[Restrictions:] + +none [Related commands:] -"voidfractionModel"_voidfractionModel.html +"voidFractionModel"_voidFractionModel.html diff --git a/doc/voidFractionModel_dividedVoidFraction.html b/doc/voidFractionModel_dividedVoidFraction.html deleted file mode 100644 index b6cbc2f6..00000000 --- a/doc/voidFractionModel_dividedVoidFraction.html +++ /dev/null @@ -1,60 +0,0 @@ - -
    CFDEMproject WWW Site - CFDEM Commands -
    - - - - -
    - -

    voidfractionModel_dividedVoidFraction command -

    -

    Syntax: -

    -

    Defined in couplingProperties dictionary. -

    -
    voidfractionModel divided;
    -dividedProps
    -{
    -    alphaMin number1;
    -    interpolation;
    -    weight number2;
    -    porosity number3;
    -} 
    -
    -
    • number1 = minimum limit for voidfraction - -
    • interpolation = flag to interpolate voidfraction to particle positions (normally off) - -
    • number2 = (optional) scaling of the particle volume to account for porosity or agglomerations. - -
    • number3 = (optional) diameter of the particle's representation is artificially increased according to number2 * Vparticle, volume remains unaltered! - - -
    -

    Examples: -

    -
    voidfractionModel divided;
    -dividedProps
    -{
    -    alphaMin 0.2;
    -} 
    -
    -

    Description: -

    -

    The divided voidFraction model is supposed to be used when a particle (or its representation) is in the size range of a CFD cell. Satellite points are used to divide the particle's volume to the touched cells. -

    -

    The region of influence of a particle can be increased artificially by "porosity", which blows up the particles, but keeps their volume (for voidfraction calculation) constant. -

    -

    The particle volume occupied in the CFD domain can be adjusted by the parameter "weight", using Vparticle=dsphere^3*pi/6*weight. -

    -

    In the basic implementation of solvers, the void fraction is calculated based on all particles. Depending on the solver used, the void fraction calculation is also performed for a certain type of particles. -The void fraction calculation is based on a three-step approach (reset, set and interpolate), i.e., the void fraction is time interpolated from a previous and a next void fraction field. Appropriate names for these fields have to be specified in the sub-dictionaries voidFracFieldNamesPrev and voidFracFieldNamesNext in the couplingProperties dictionary. -

    -

    Restrictions: none. -

    -

    Related commands: -

    -

    voidfractionModel -

    - diff --git a/doc/voidFractionModel_dividedVoidFraction.txt b/doc/voidFractionModel_dividedVoidFraction.txt index b2ce76f5..1922ef3f 100644 --- a/doc/voidFractionModel_dividedVoidFraction.txt +++ b/doc/voidFractionModel_dividedVoidFraction.txt @@ -1,34 +1,39 @@ -"CFDEMproject WWW Site"_lws - "CFDEM Commands"_lc :c +"CFDEMproject Website"_lws - "Main Page"_main :c :link(lws,http://www.cfdem.com) -:link(lc,CFDEMcoupling_Manual.html#comm) +:link(main,CFDEMcoupling_Manual.html) :line -voidfractionModel_dividedVoidFraction command :h3 +voidFractionModel divided command :h3 [Syntax:] -Defined in couplingProperties dictionary. +Defined in "couplingProperties"_CFDEMcoupling_dicts.html#couplingProperties +dictionary. -voidfractionModel divided; +voidFractionModel divided; dividedProps \{ - alphaMin number1; + alphaMin number1; interpolation; - weight number2; - porosity number3; + weight number2; + porosity number3; + procBoundaryCorrection switch1; + verbose; \} :pre -{number1} = minimum limit for voidfraction :ulb,l -{interpolation} = flag to interpolate voidfraction to particle positions (normally off) :l +{number1} = minimum limit for void fraction :ulb,l +{interpolation} = flag to interpolate void fraction to particle positions (normally off) :l {number2} = (optional) scaling of the particle volume to account for porosity or agglomerations. :l {number3} = (optional) diameter of the particle's representation is artificially increased according to {number2} * Vparticle, volume remains unaltered! :l +{switch1} = (optional, default false) allow for correction at processor boundaries. This requires the use of engineIB and vice versa. :l +{verbose} = (optional, default false) flag for debugging output :l :ule [Examples:] -voidfractionModel divided; +voidFractionModel divided; dividedProps \{ alphaMin 0.2; @@ -36,18 +41,57 @@ dividedProps [Description:] -The divided voidFraction model is supposed to be used when a particle (or its representation) is in the size range of a CFD cell. Satellite points are used to divide the particle's volume to the touched cells. +The {divided} void fraction model is supposed to be used when a particle (or its +representation) is in the size range of a CFD cell. Satellite points are used to +divide the particle's volume to the touched cells. -The region of influence of a particle can be increased artificially by "porosity", which blows up the particles, but keeps their volume (for voidfraction calculation) constant. +The particle has radius R and its volume is divided into 29 non-overlapping +regions of equal volume. The centroids of these volumes are then used to +reproduce each volume. The first volume is a sphere with the center coinciding +with the particle center. The radius of this subsphere can be found as follows: -The particle volume occupied in the CFD domain can be adjusted by the parameter "weight", using Vparticle=dsphere^3*pi/6*weight. +:c,image(Eqs/voidfractionModel_divided_pic2.png) -In the basic implementation of solvers, the void fraction is calculated based on all particles. Depending on the solver used, the void fraction calculation is also performed for a certain type of particles. -The void fraction calculation is based on a three-step approach (reset, set and interpolate), i.e., the void fraction is time interpolated from a previous and a next void fraction field. Appropriate names for these fields have to be specified in the sub-dictionaries voidFracFieldNamesPrev and voidFracFieldNamesNext in the couplingProperties dictionary. +The rest of the volume is a spherical layer that is divided into 2 layers of +equal volume. Position of the border between these two spherical layers in +radial direction can be easily obtained: -[Restrictions:] none. +:c,image(Eqs/voidfractionModel_divided_pic3.png) + +Each of these spherical layers is later divided into 14 elements of equal volume. +Position of the centroid point in radial direction of each volume in the first +spherical layer is as follows + +:c,image(Eqs/voidfractionModel_divided_pic4.png) + +Similarly, for the second spherical layer remembering that the external radius +is the particle radius: + +:c,image(Eqs/voidfractionModel_divided_pic5.png) + +The region of influence of a particle can be increased artificially by +{porosity}, which blows up the particles, but keeps their volume (for +void fraction calculation) constant. + +The particle volume occupied in the CFD domain can be adjusted by the parameter +{weight}, using + +:c,image(Eqs/voidfractionModel_divided_pic6.png). + +In the basic implementation of solvers, the void fraction is calculated based on +all particles. Depending on the solver used, the void fraction calculation is +also performed for a certain type of particles. +The void fraction calculation is based on a three-step approach (reset, set and +interpolate), i.e. the void fraction is time interpolated from a previous and a +next void fraction field. Appropriate names for these fields have to be +specified in the sub-dictionaries voidFracFieldNamesPrev and +voidFracFieldNamesNext in the couplingProperties dictionary. + +[Restrictions:] + +none [Related commands:] -"voidfractionModel"_voidfractionModel.html +"voidFractionModel"_voidFractionModel.html diff --git a/etc/bashrc b/etc/bashrc index 159fdf83..e069a93e 100755 --- a/etc/bashrc +++ b/etc/bashrc @@ -17,7 +17,7 @@ #------------------------------------------------------------------------------ export CFDEM_PROJECT=CFDEM -export CFDEM_VERSION=18.03 +export CFDEM_VERSION=18.10 ################################################################################ # USER EDITABLE PART: Changes made here may be lost with the next upgrade diff --git a/etc/cshrc b/etc/cshrc index e2ac96a0..b56a1c47 100755 --- a/etc/cshrc +++ b/etc/cshrc @@ -15,7 +15,7 @@ #------------------------------------------------------------------------------ setenv CFDEM_PROJECT CFDEM -setenv CFDEM_VERSION 18.03 +setenv CFDEM_VERSION 18.10 ################################################################################ # USER EDITABLE PART: Changes made here may be lost with the next upgrade diff --git a/etc/library-list.txt b/etc/library-list.txt index e00d6b96..8e14f45d 100644 --- a/etc/library-list.txt +++ b/etc/library-list.txt @@ -1,3 +1,4 @@ lagrangian/cfdemParticle/dir lagrangian/cfdemParticleComp/dir finiteVolume/dir +../applications/solvers/cfdemSolverMultiphase/multiphaseMixture/dir diff --git a/etc/solver-list.txt b/etc/solver-list.txt index 4bf3e896..c370a4d4 100644 --- a/etc/solver-list.txt +++ b/etc/solver-list.txt @@ -5,3 +5,4 @@ cfdemSolverRhoSimple/dir cfdemSolverIB/dir cfdemSolverPisoScalar/dir cfdemSolverRhoPimpleChem/dir +cfdemSolverMultiphase/dir diff --git a/src/lagrangian/cfdemParticle/Make/files b/src/lagrangian/cfdemParticle/Make/files index a184d5c1..e4eb3b00 100644 --- a/src/lagrangian/cfdemParticle/Make/files +++ b/src/lagrangian/cfdemParticle/Make/files @@ -80,6 +80,8 @@ $(forceModels)/Fines/FanningDynFines.C $(forceModels)/Fines/ErgunStatFines.C $(forceModels)/granKineticEnergy/granKineticEnergy.C $(forceModels)/pdCorrelation/pdCorrelation.C +$(forceModels)/surfaceTensionForce/surfaceTensionForce.C +$(forceModels)/gradPForceSmooth/gradPForceSmooth.C $(forceModelsMS)/forceModelMS/forceModelMS.C $(forceModelsMS)/forceModelMS/newForceModelMS.C @@ -169,5 +171,6 @@ $(smoothingModels)/smoothingModel/smoothingModel.C $(smoothingModels)/smoothingModel/newSmoothingModel.C $(smoothingModels)/noSmoothing/noSmoothing.C $(smoothingModels)/constDiffSmoothing/constDiffSmoothing.C +$(smoothingModels)/temporalSmoothing/temporalSmoothing.C LIB = $(CFDEM_LIB_DIR)/lib$(CFDEM_LIB_NAME) diff --git a/src/lagrangian/cfdemParticle/cfdTools/checkModelType.H b/src/lagrangian/cfdemParticle/cfdTools/checkModelType.H index a91bb786..a758d183 100644 --- a/src/lagrangian/cfdemParticle/cfdTools/checkModelType.H +++ b/src/lagrangian/cfdemParticle/cfdTools/checkModelType.H @@ -21,7 +21,7 @@ found=false; forAll(particleCloud.forceModels(),i) { - if(particleCloud.forceModels()[i]=="gradPForce") + if(particleCloud.forceModels()[i]=="gradPForce" || particleCloud.forceModels()[i]=="gradPForceSmooth") found=true; } if(!found) @@ -56,7 +56,7 @@ found=false; forAll(particleCloud.forceModels(),i) { - if(particleCloud.forceModels()[i]=="gradPForce" || particleCloud.forceModels()[i]=="viscForce") + if(particleCloud.forceModels()[i]=="gradPForce" || particleCloud.forceModels()[i]=="gradPForceSmooth" || particleCloud.forceModels()[i]=="viscForce") found=true; } if(found) @@ -80,7 +80,7 @@ found=false; forAll(particleCloud.forceModels(),i) { - if(particleCloud.forceModels()[i]=="gradPForce") + if(particleCloud.forceModels()[i]=="gradPForce" || particleCloud.forceModels()[i]=="gradPForceSmooth") found=true; } if(!found) @@ -99,3 +99,6 @@ Warning << "You chose model type -none- you might get erroneous results!" << endl; else FatalError <<"no suitable model type specified:" << modelType << "\n" << abort(FatalError); + + if (particleCloud.smoothingM().type() == "temporalSmoothing") + FatalError << "the temporalSmoothing model does not support smoothing of the exchange fields, please see documentation!" << endl; diff --git a/src/lagrangian/cfdemParticle/cfdTools/versionInfo.H b/src/lagrangian/cfdemParticle/cfdTools/versionInfo.H index 43650545..637262b3 100755 --- a/src/lagrangian/cfdemParticle/cfdTools/versionInfo.H +++ b/src/lagrangian/cfdemParticle/cfdTools/versionInfo.H @@ -34,8 +34,8 @@ Description #ifndef versionInfo_H #define versionInfo_H -word CFDEMversion="PFM 18.03"; -word compatibleLIGGGHTSversion="PFM 18.03"; +word CFDEMversion="PFM 18.10"; +word compatibleLIGGGHTSversion="PFM 18.10"; word OFversion="4.x"; Info << "\nCFDEMcoupling version: " << CFDEMversion << endl; diff --git a/src/lagrangian/cfdemParticle/cfdemCloud/cfdemCloud.C b/src/lagrangian/cfdemParticle/cfdemCloud/cfdemCloud.C index 1be5d2b1..d5c4efab 100644 --- a/src/lagrangian/cfdemParticle/cfdemCloud/cfdemCloud.C +++ b/src/lagrangian/cfdemParticle/cfdemCloud/cfdemCloud.C @@ -78,14 +78,15 @@ cfdemCloud::cfdemCloud IOobject::NO_WRITE ) ), - solveFlow_(true), - verbose_(false), - ignore_(false), + solveFlow_(couplingProperties_.lookupOrDefault("solveFlow", true)), + verbose_(couplingProperties_.found("verbose")), + ignore_(couplingProperties_.found("ignore")), allowCFDsubTimestep_(true), - limitDEMForces_(false), + limitDEMForces_(couplingProperties_.found("limitDEMForces")), getParticleDensities_(couplingProperties_.lookupOrDefault("getParticleDensities",false)), getParticleEffVolFactors_(couplingProperties_.lookupOrDefault("getParticleEffVolFactors",false)), getParticleTypes_(couplingProperties_.lookupOrDefault("getParticleTypes",false)), + maxDEMForce_(0.), modelType_(couplingProperties_.lookup("modelType")), positions_(NULL), velocities_(NULL), @@ -117,9 +118,9 @@ cfdemCloud::cfdemCloud cgOK_(true), impDEMdrag_(false), impDEMdragAcc_(false), - imExSplitFactor_(1.0), - treatVoidCellsAsExplicitForce_(false), - useDDTvoidfraction_(false), + imExSplitFactor_(couplingProperties_.lookupOrDefault("imExSplitFactor",1.0)), + treatVoidCellsAsExplicitForce_(couplingProperties_.lookupOrDefault("treatVoidCellsAsExplicitForce",false)), + useDDTvoidfraction_(couplingProperties_.found("useDDTvoidfraction")), ddtVoidfraction_ ( IOobject @@ -154,22 +155,6 @@ cfdemCloud::cfdemCloud turbulenceModelType_ ) ), - locateModel_ - ( - locateModel::New - ( - couplingProperties_, - *this - ) - ), - /*momCoupleModel_ - ( - momCoupleModel::New - ( - couplingProperties_, - *this - ) - ),*/ dataExchangeModel_ ( dataExchangeModel::New @@ -178,6 +163,16 @@ cfdemCloud::cfdemCloud *this ) ), + forceModel_(nrForceModels()), + locateModel_ + ( + locateModel::New + ( + couplingProperties_, + *this + ) + ), + momCoupleModel_(nrMomCoupleModels()), IOModel_ ( IOModel::New @@ -235,17 +230,15 @@ cfdemCloud::cfdemCloud couplingProperties_, *this ) - ) + ), + liggghtsCommand_(liggghtsCommandModelList_.size()), + otherForceModel_(otherForceModels_.size()) { #include "versionInfo.H" global buildInfo(couplingProperties_,*this); buildInfo.info(); Info << "If BC are important, please provide volScalarFields -imp/expParticleForces-" << endl; - if (couplingProperties_.found("solveFlow")) - solveFlow_=Switch(couplingProperties_.lookup("solveFlow")); - if (couplingProperties_.found("imExSplitFactor")) - imExSplitFactor_ = readScalar(couplingProperties_.lookup("imExSplitFactor")); if(imExSplitFactor_ > 1.0) FatalError << "You have set imExSplitFactor > 1 in your couplingProperties. Must be <= 1." @@ -254,79 +247,90 @@ cfdemCloud::cfdemCloud FatalError << "You have set imExSplitFactor < 0 in your couplingProperties. Must be >= 0." << abort(FatalError); - if (couplingProperties_.found("treatVoidCellsAsExplicitForce")) - treatVoidCellsAsExplicitForce_ = readBool(couplingProperties_.lookup("treatVoidCellsAsExplicitForce")); - if (couplingProperties_.found("verbose")) verbose_=true; - if (couplingProperties_.found("ignore")) ignore_=true; - if (couplingProperties_.found("limitDEMForces")) + if (limitDEMForces_) { - limitDEMForces_=true; maxDEMForce_ = readScalar(couplingProperties_.lookup("limitDEMForces")); } + if (turbulenceModelType_=="LESProperties") + { Info << "WARNING - LES functionality not yet tested!" << endl; + } - if (couplingProperties_.found("useDDTvoidfraction")) - useDDTvoidfraction_=true; - else + if (!useDDTvoidfraction_) + { Info << "ignoring ddt(voidfraction)" << endl; + } - bool adjustTimeStep = mesh_.time().controlDict().lookupOrDefault("adjustTimeStep", false); + const bool adjustTimeStep = mesh_.time().controlDict().lookupOrDefault("adjustTimeStep", false); if (adjustTimeStep) FatalError << "CFDEMcoupling does not support adjustable time steps." << abort(FatalError); - momCoupleModel_ = new autoPtr[momCoupleModels_.size()]; - for (int i=0;i[nrForceModels()]; - for (int i=0;i[liggghtsCommandModelList_.size()]; - for (int i=0;i[otherForceModels_.size()]; - for (int i=0;i("cgWarnOnly", true)); + setCG(dataExchangeM().getCG()); + Switch cgWarnOnly(couplingProperties_.lookupOrDefault("cgWarnOnly", true)); + if (!cgOK_ && cg_ > 1) { - if (cgWarnOnly_) + if (cgWarnOnly) Warning << "at least one of your models is not fit for cg !!!" << endl; else FatalError << "at least one of your models is not fit for cg !!!" << abort(FatalError); @@ -520,9 +524,10 @@ void cfdemCloud::checkCG(bool ok) void cfdemCloud::setPos(double**& pos) { - for(int index = 0;index < numberOfParticles(); ++index) + for(int index = 0; index < numberOfParticles(); ++index) { - for(int i=0;i<3;i++){ + for(int i=0; i<3; i++) + { positions_[index][i] = pos[index][i]; } } @@ -575,16 +580,9 @@ scalar cfdemCloud::voidfraction(int index) const return voidfractions()[index][0]; } -label cfdemCloud::liggghtsCommandModelIndex(word name) const +label cfdemCloud::liggghtsCommandModelIndex(const word& name) const { - forAll(liggghtsCommandModelList_,i) - { - if(liggghtsCommand()[i]().name() == name) - { - return i; - } - } - return -1; + return findIndex(liggghtsCommandModelList_, name); } // * * * * * * * * * * * * * * * WRITE * * * * * * * * * * * * * // @@ -784,7 +782,7 @@ tmp cfdemCloud::ddtVoidfraction() const return tmp (ddtVoidfraction_ * 1.) ; } -void cfdemCloud::calcDdtVoidfraction(volScalarField& voidfraction) const +void cfdemCloud::calcDdtVoidfraction(volScalarField& voidfraction) { // version if ddt is calculated only at coupling time //Info << "calculating ddt(voidfraction) based on couplingTime" << endl; @@ -841,7 +839,7 @@ void cfdemCloud::otherForces(volVectorField& forcefield) forcefield.primitiveFieldRef() = vector::zero; forcefield.boundaryFieldRef() = vector::zero; for (int i=0;i* forceModel_; + autoPtr dataExchangeModel_; + + PtrList forceModel_; autoPtr locateModel_; - autoPtr* momCoupleModel_; - - autoPtr dataExchangeModel_; + PtrList momCoupleModel_; autoPtr IOModel_; @@ -202,9 +202,9 @@ protected: autoPtr meshMotionModel_; - autoPtr* liggghtsCommand_; + PtrList liggghtsCommand_; - autoPtr* otherForceModel_; + PtrList otherForceModel_; // Protected member functions virtual void getDEMdata(); @@ -244,7 +244,7 @@ public: // public Member Functions // Access - bool allowCFDsubTimestep() { return allowCFDsubTimestep_; } + bool allowCFDsubTimestep() const { return allowCFDsubTimestep_; } void setAllowCFDsubTimestep(bool b) { allowCFDsubTimestep_ = b; } @@ -272,7 +272,7 @@ public: scalar voidfraction(int) const; - label liggghtsCommandModelIndex(word) const; + label liggghtsCommandModelIndex(const word&) const; inline void setCG(double); @@ -373,10 +373,12 @@ public: inline const wordList& forceModels() const; + inline voidFractionModel& voidFractionM(); inline const voidFractionModel& voidFractionM() const; inline const locateModel& locateM() const; + inline momCoupleModel& momCoupleM(int); inline const momCoupleModel& momCoupleM(int) const; inline dataExchangeModel& dataExchangeM(); @@ -385,6 +387,7 @@ public: inline probeModel& probeM(); + inline averagingModel& averagingM(); inline const averagingModel& averagingM() const; inline const clockModel& clockM() const; @@ -395,7 +398,7 @@ public: inline const wordList& liggghtsCommandModelList() const; - inline autoPtr* liggghtsCommand() const; + inline liggghtsCommandModel& liggghtsCommand(const label); inline const turbulenceModel& turbulence() const; @@ -418,7 +421,7 @@ public: tmp ddtVoidfraction() const; - void calcDdtVoidfraction(volScalarField& voidfraction) const; + void calcDdtVoidfraction(volScalarField& voidfraction); //tmp ddtVoidfractionU(volVectorField& ,volScalarField&) const; @@ -428,7 +431,7 @@ public: void otherForces(volVectorField&); - bool checkPeriodicCells() { return checkPeriodicCells_; } + bool checkPeriodicCells() const { return checkPeriodicCells_; } }; diff --git a/src/lagrangian/cfdemParticle/cfdemCloud/cfdemCloudI.H b/src/lagrangian/cfdemParticle/cfdemCloud/cfdemCloudI.H index 02b3a7dc..504c1682 100644 --- a/src/lagrangian/cfdemParticle/cfdemCloud/cfdemCloudI.H +++ b/src/lagrangian/cfdemParticle/cfdemCloud/cfdemCloudI.H @@ -87,7 +87,7 @@ inline const fvMesh& cfdemCloud::mesh() const inline bool cfdemCloud::solveFlow() const { - return bool(solveFlow_); + return solveFlow_; } inline bool cfdemCloud::verbose() const @@ -299,6 +299,11 @@ inline const locateModel& cfdemCloud::locateM() const return locateModel_; } +inline momCoupleModel& cfdemCloud::momCoupleM(int i) +{ + return momCoupleModel_[i]; +} + inline const momCoupleModel& cfdemCloud::momCoupleM(int i) const { return momCoupleModel_[i]; @@ -319,14 +324,24 @@ inline probeModel& cfdemCloud::probeM() return probeModel_(); } +inline voidFractionModel& cfdemCloud::voidFractionM() +{ + return voidFractionModel_(); +} + inline const voidFractionModel& cfdemCloud::voidFractionM() const { - return voidFractionModel_; + return voidFractionModel_(); +} + +inline averagingModel& cfdemCloud::averagingM() +{ + return averagingModel_(); } inline const averagingModel& cfdemCloud::averagingM() const { - return averagingModel_; + return averagingModel_(); } inline const clockModel& cfdemCloud::clockM() const @@ -349,9 +364,9 @@ inline const wordList& cfdemCloud::liggghtsCommandModelList() const return liggghtsCommandModelList_; } -inline autoPtr* cfdemCloud::liggghtsCommand() const +inline liggghtsCommandModel& cfdemCloud::liggghtsCommand(const label modeli) { - return liggghtsCommand_; + return liggghtsCommand_[modeli]; } inline const turbulenceModel& cfdemCloud::turbulence() const diff --git a/src/lagrangian/cfdemParticle/derived/cfdemCloudEnergy/cfdemCloudEnergy.C b/src/lagrangian/cfdemParticle/derived/cfdemCloudEnergy/cfdemCloudEnergy.C index 1facf46c..f552c157 100644 --- a/src/lagrangian/cfdemParticle/derived/cfdemCloudEnergy/cfdemCloudEnergy.C +++ b/src/lagrangian/cfdemParticle/derived/cfdemCloudEnergy/cfdemCloudEnergy.C @@ -42,6 +42,7 @@ cfdemCloudEnergy::cfdemCloudEnergy energyModels_(couplingProperties_.lookup("energyModels")), implicitEnergyModel_(false), chemistryModels_(couplingProperties_.lookup("chemistryModels")), + energyModel_(nrEnergyModels()), thermCondModel_ ( thermCondModel::New @@ -49,26 +50,34 @@ cfdemCloudEnergy::cfdemCloudEnergy couplingProperties_, *this ) - ) + ), + chemistryModel_(nrChemistryModels()) { - energyModel_ = new autoPtr[nrEnergyModels()]; - for (int i=0;i[nrChemistryModels()]; - for (int i=0;i* energyModel_; + PtrList energyModel_; autoPtr thermCondModel_; - autoPtr* chemistryModel_; + PtrList chemistryModel_; void calcEnergyContributions(); @@ -98,15 +98,13 @@ public: label nrEnergyModels() const; - inline const wordList& energyModels() const; - bool implicitEnergyModel() const; int nrChemistryModels(); - inline const wordList& energyModels(); + inline const wordList& energyModels() const; - inline const wordList& chemistryModels(); + inline const wordList& chemistryModels() const; void energyContributions(volScalarField&); diff --git a/src/lagrangian/cfdemParticle/derived/cfdemCloudEnergy/cfdemCloudEnergyI.H b/src/lagrangian/cfdemParticle/derived/cfdemCloudEnergy/cfdemCloudEnergyI.H index 49e13c0f..99d623d9 100644 --- a/src/lagrangian/cfdemParticle/derived/cfdemCloudEnergy/cfdemCloudEnergyI.H +++ b/src/lagrangian/cfdemParticle/derived/cfdemCloudEnergy/cfdemCloudEnergyI.H @@ -30,7 +30,7 @@ inline const wordList& cfdemCloudEnergy::energyModels() const return energyModels_; } -inline const wordList& cfdemCloudEnergy::chemistryModels() +inline const wordList& cfdemCloudEnergy::chemistryModels() const { return chemistryModels_; } diff --git a/src/lagrangian/cfdemParticle/derived/cfdemCloudIB/cfdemCloudIB.H b/src/lagrangian/cfdemParticle/derived/cfdemCloudIB/cfdemCloudIB.H index d1db244d..88041fc8 100644 --- a/src/lagrangian/cfdemParticle/derived/cfdemCloudIB/cfdemCloudIB.H +++ b/src/lagrangian/cfdemParticle/derived/cfdemCloudIB/cfdemCloudIB.H @@ -58,12 +58,12 @@ class cfdemCloudIB { protected: - mutable double **angularVelocities_; + double **angularVelocities_; label pRefCell_; scalar pRefValue_; - mutable bool haveEvolvedOnce_; - mutable bool skipLagrangeToEulerMapping_; + bool haveEvolvedOnce_; + bool skipLagrangeToEulerMapping_; public: diff --git a/src/lagrangian/cfdemParticle/subModels/IOModel/IOModel/IOModel.C b/src/lagrangian/cfdemParticle/subModels/IOModel/IOModel/IOModel.C index a6b62e6c..3a773c16 100644 --- a/src/lagrangian/cfdemParticle/subModels/IOModel/IOModel/IOModel.C +++ b/src/lagrangian/cfdemParticle/subModels/IOModel/IOModel/IOModel.C @@ -59,14 +59,14 @@ bool IOModel::dumpNow() const return time_.outputTime(); } -fileName IOModel::createTimeDir(fileName path) const +fileName IOModel::createTimeDir(const fileName& path) const { fileName timeDirPath(path/time_.timeName()); mkDir(timeDirPath,0777); return timeDirPath; } -fileName IOModel::createLagrangianDir(fileName path) const +fileName IOModel::createLagrangianDir(const fileName& path) const { fileName lagrangianDirPath(path/"lagrangian"); mkDir(lagrangianDirPath,0777); @@ -75,7 +75,7 @@ fileName IOModel::createLagrangianDir(fileName path) const return cfdemCloudDirPath; } -fileName IOModel::buildFilePath(word dirName) const +fileName IOModel::buildFilePath(const word& dirName) const { // create file structure fileName path(""); @@ -94,7 +94,7 @@ fileName IOModel::buildFilePath(word dirName) const return path; } -void IOModel::streamDataToPath(fileName path, double** array,int nPProc,word name,word type,word className) const +void IOModel::streamDataToPath(const fileName& path, const double* const* array,int nPProc,const word& name,const word& type,const word& className) const { OFstream fileStream(path/name); @@ -107,7 +107,7 @@ void IOModel::streamDataToPath(fileName path, double** array,int nPProc,word nam << " object " << name << ";\n" << "}" << nl; - fileStream << nPProc <<"\n"; + fileStream << nPProc << "\n"; if (type == "origProcId") { @@ -118,7 +118,7 @@ void IOModel::streamDataToPath(fileName path, double** array,int nPProc,word nam fileStream << token::BEGIN_LIST << nl; - int ** cellIDs = particleCloud_.cellIDs(); + const int * const* cellIDs = particleCloud_.cellIDs(); for (int index = 0; index < particleCloud_.numberOfParticles(); ++index) { if (cellIDs[index][0] > -1) // particle Found @@ -160,7 +160,7 @@ IOModel::IOModel parOutput_(true) { if ( - particleCloud_.dataExchangeM().myType()=="oneWayVTK" || + particleCloud_.dataExchangeM().type()=="oneWayVTK" || dict_.found("serialOutput") ) { diff --git a/src/lagrangian/cfdemParticle/subModels/IOModel/IOModel/IOModel.H b/src/lagrangian/cfdemParticle/subModels/IOModel/IOModel/IOModel.H index f0329302..4785882b 100644 --- a/src/lagrangian/cfdemParticle/subModels/IOModel/IOModel/IOModel.H +++ b/src/lagrangian/cfdemParticle/subModels/IOModel/IOModel/IOModel.H @@ -115,13 +115,13 @@ public: bool dumpNow() const; - fileName createTimeDir(fileName) const; + fileName createTimeDir(const fileName&) const; - fileName createLagrangianDir(fileName) const; + fileName createLagrangianDir(const fileName&) const; - fileName buildFilePath(word) const; + fileName buildFilePath(const word&) const; - void streamDataToPath(fileName,double**,int,word,word type,word className) const; + void streamDataToPath(const fileName&,const double* const*,int,const word&,const word& type,const word& className) const; }; diff --git a/src/lagrangian/cfdemParticle/subModels/averagingModel/averagingModel/averagingModel.C b/src/lagrangian/cfdemParticle/subModels/averagingModel/averagingModel/averagingModel.C index 5a0614f3..b6526912 100644 --- a/src/lagrangian/cfdemParticle/subModels/averagingModel/averagingModel/averagingModel.C +++ b/src/lagrangian/cfdemParticle/subModels/averagingModel/averagingModel/averagingModel.C @@ -332,13 +332,13 @@ void averagingModel::resetVectorAverage(volVectorField& prev,volVectorField& nex next.primitiveFieldRef() = vector::zero; } -void averagingModel::resetWeightFields() const +void averagingModel::resetWeightFields() { UsWeightField_.ref() = 0; } -void averagingModel::undoWeightFields(double**const& mask) const +void averagingModel::undoWeightFields(double**const& mask) { for(int index=0; index< particleCloud_.numberOfParticles(); index++) { diff --git a/src/lagrangian/cfdemParticle/subModels/averagingModel/averagingModel/averagingModel.H b/src/lagrangian/cfdemParticle/subModels/averagingModel/averagingModel/averagingModel.H index 93b334eb..cbe071d7 100644 --- a/src/lagrangian/cfdemParticle/subModels/averagingModel/averagingModel/averagingModel.H +++ b/src/lagrangian/cfdemParticle/subModels/averagingModel/averagingModel/averagingModel.H @@ -61,11 +61,11 @@ protected: cfdemCloud& particleCloud_; - mutable volScalarField UsWeightField_; + volScalarField UsWeightField_; - mutable volVectorField UsPrev_; + volVectorField UsPrev_; - mutable volVectorField UsNext_; + volVectorField UsNext_; // Protected member functions @@ -194,23 +194,25 @@ public: void resetVectorAverage(volVectorField& prev,volVectorField& next,bool single=false) const; - void resetWeightFields() const; + void resetWeightFields(); - void undoWeightFields(double**const&) const; + void undoWeightFields(double**const&); tmp UsInterp() const; - virtual void setParticleType(label type) const {}; + virtual void setParticleType(label type) const {} - virtual bool checkParticleType(label) const {return true;}; //consider all particles by default + virtual bool checkParticleType(label) const {return true;} //consider all particles by default // Access - inline volVectorField& UsPrev() const {return UsPrev_;}; + inline volVectorField& UsPrev() {return UsPrev_;} + inline const volVectorField& UsPrev() const {return UsPrev_;} - inline volVectorField& UsNext() const {return UsNext_;}; - - inline volScalarField& UsWeightField() const {return UsWeightField_;}; + inline volVectorField& UsNext() {return UsNext_;} + inline const volVectorField& UsNext() const {return UsNext_;} + inline volScalarField& UsWeightField() {return UsWeightField_;} + inline const volScalarField& UsWeightField() const {return UsWeightField_;} }; diff --git a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/dataExchangeModel/dataExchangeModel.C b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/dataExchangeModel/dataExchangeModel.C index ddee3673..723db484 100755 --- a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/dataExchangeModel/dataExchangeModel.C +++ b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/dataExchangeModel/dataExchangeModel.C @@ -195,7 +195,7 @@ void dataExchangeModel::destroy(double* array) const //==== -bool dataExchangeModel::couple(int i) const +bool dataExchangeModel::couple(int i) { bool coupleNow = false; if (doCoupleNow()) diff --git a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/dataExchangeModel/dataExchangeModel.H b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/dataExchangeModel/dataExchangeModel.H index e864bfee..6153b593 100755 --- a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/dataExchangeModel/dataExchangeModel.H +++ b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/dataExchangeModel/dataExchangeModel.H @@ -62,7 +62,7 @@ protected: int maxNumberOfParticles_; - mutable int couplingStep_; + int couplingStep_; scalar DEMts_; @@ -176,7 +176,7 @@ public: virtual void destroy(double*) const; //==== - virtual bool couple(int) const; + virtual bool couple(int); virtual scalar timeStepFraction() const; @@ -257,9 +257,8 @@ public: particleCloud_.cellIDs_[i][0]=ID[i]; } - virtual word myType() const=0; - virtual void setCG() { Warning << "setCG() not executed correctly!" << endl; } + virtual scalar getCG() const { Warning << "getCG() not executed correctly!" << endl; return 1.; } }; diff --git a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/noDataExchange/noDataExchange.H b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/noDataExchange/noDataExchange.H index c695d06e..1fda4c54 100644 --- a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/noDataExchange/noDataExchange.H +++ b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/noDataExchange/noDataExchange.H @@ -100,7 +100,6 @@ public: const char* datatype = "" ) const {} - word myType() const { return typeName; } }; diff --git a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/oneWayVTK/oneWayVTK.H b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/oneWayVTK/oneWayVTK.H index c8e0cfdf..72731202 100644 --- a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/oneWayVTK/oneWayVTK.H +++ b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/oneWayVTK/oneWayVTK.H @@ -110,7 +110,6 @@ public: const char* datatype = "" ) const; - word myType() const{ return typeName; } }; diff --git a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayFiles/twoWayFiles.H b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayFiles/twoWayFiles.H index 5ec8d3ec..e5f15814 100644 --- a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayFiles/twoWayFiles.H +++ b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayFiles/twoWayFiles.H @@ -114,7 +114,6 @@ public: const char* datatype = "" ) const; - word myType() const{ return typeName; } }; diff --git a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMPI/twoWayMPI.C b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMPI/twoWayMPI.C index 9411b6a1..875399fa 100644 --- a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMPI/twoWayMPI.C +++ b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMPI/twoWayMPI.C @@ -204,7 +204,7 @@ void twoWayMPI::destroy(double* array) const } //============ -bool twoWayMPI::couple(int i) const +bool twoWayMPI::couple(int i) { bool coupleNow = false; if (i==0) @@ -229,10 +229,11 @@ bool twoWayMPI::couple(int i) const // Check if exact timing is needed // get time for execution // store time for execution in list - if(particleCloud_.liggghtsCommand()[i]().exactTiming()) + liggghtsCommandModel& lcm = particleCloud_.liggghtsCommand(i); + if(lcm.exactTiming()) { exactTiming = true; - DynamicList h = particleCloud_.liggghtsCommand()[i]().executionsWithinPeriod(TSstart(),TSend()); + DynamicList h = lcm.executionsWithinPeriod(TSstart(),TSend()); forAll(h,j) { @@ -261,7 +262,7 @@ bool twoWayMPI::couple(int i) const Info << "Foam::twoWayMPI::couple(i): lcModel=" << lcModel << endl; } - if(particleCloud_.liggghtsCommand()[i]().type()=="runLiggghts") + if(lcm.type()=="runLiggghts") runComNr=i; } @@ -278,22 +279,22 @@ bool twoWayMPI::couple(int i) const { // set run command till interrupt DEMstepsRun += DEMstepsToInterrupt[j]; - particleCloud_.liggghtsCommand()[runComNr]().set(DEMstepsToInterrupt[j]); - const char* command = particleCloud_.liggghtsCommand()[runComNr]().command(0); + particleCloud_.liggghtsCommand(runComNr).set(DEMstepsToInterrupt[j]); + const char* command = particleCloud_.liggghtsCommand(runComNr).command(0); Info << "Executing run command: '"<< command <<"'"<< endl; lmp->input->one(command); // run liggghts command with exact timing - command = particleCloud_.liggghtsCommand()[lcModel[j]]().command(0); + command = particleCloud_.liggghtsCommand(lcModel[j]).command(0); Info << "Executing command: '"<< command <<"'"<< endl; lmp->input->one(command); } // do the run - if(particleCloud_.liggghtsCommand()[runComNr]().runCommand(couplingStep())) + if(particleCloud_.liggghtsCommand(runComNr).runCommand(couplingStep())) { - particleCloud_.liggghtsCommand()[runComNr]().set(couplingInterval() - DEMstepsRun); - const char* command = particleCloud_.liggghtsCommand()[runComNr]().command(0); + particleCloud_.liggghtsCommand(runComNr).set(couplingInterval() - DEMstepsRun); + const char* command = particleCloud_.liggghtsCommand(runComNr).command(0); Info << "Executing run command: '"<< command <<"'"<< endl; lmp->input->one(command); } @@ -301,16 +302,13 @@ bool twoWayMPI::couple(int i) const // do the other non exact timing models forAll(particleCloud_.liggghtsCommandModelList(),i) { - if - ( - ! particleCloud_.liggghtsCommand()[i]().exactTiming() && - particleCloud_.liggghtsCommand()[i]().runCommand(couplingStep()) - ) + liggghtsCommandModel& lcm = particleCloud_.liggghtsCommand(i); + if (! lcm.exactTiming() && lcm.runCommand(couplingStep()) ) { - commandLines=particleCloud_.liggghtsCommand()[i]().commandLines(); + commandLines = lcm.commandLines(); for(int j=0;jinput->one(command); } @@ -322,12 +320,13 @@ bool twoWayMPI::couple(int i) const { forAll(particleCloud_.liggghtsCommandModelList(),i) { - if(particleCloud_.liggghtsCommand()[i]().runCommand(couplingStep())) + liggghtsCommandModel& lcm = particleCloud_.liggghtsCommand(i); + if (lcm.runCommand(couplingStep())) { - commandLines=particleCloud_.liggghtsCommand()[i]().commandLines(); + commandLines = lcm.commandLines(); for(int j=0;jinput->one(command); } diff --git a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMPI/twoWayMPI.H b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMPI/twoWayMPI.H index dbf40c9a..dd0079e9 100644 --- a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMPI/twoWayMPI.H +++ b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMPI/twoWayMPI.H @@ -151,16 +151,15 @@ public: void destroy(int*) const; //============== - bool couple(int) const; + bool couple(int); int getNumberOfParticles() const; int getNumberOfClumps() const; int getNumberOfTypes() const; double* getTypeVol() const; - word myType() const { return typeName; } - void setCG() { particleCloud_.setCG(lmp->force->cg()); } + scalar getCG() const { return lmp->force->cg(); } }; diff --git a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMany2Many/twoWayMany2Many.C b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMany2Many/twoWayMany2Many.C index 74d50569..90334d17 100644 --- a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMany2Many/twoWayMany2Many.C +++ b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMany2Many/twoWayMany2Many.C @@ -384,7 +384,7 @@ void inline twoWayMany2Many::destroy(int* array) const //============== -bool twoWayMany2Many::couple(int i) const +bool twoWayMany2Many::couple(int i) { bool coupleNow = false; if (i==0) @@ -401,12 +401,12 @@ bool twoWayMany2Many::couple(int i) const forAll(particleCloud_.liggghtsCommandModelList(),i) { - if (particleCloud_.liggghtsCommand()[i]().runCommand(couplingStep())) + if (particleCloud_.liggghtsCommand(i).runCommand(couplingStep())) { - label commandLines = particleCloud_.liggghtsCommand()[i]().commandLines(); + label commandLines = particleCloud_.liggghtsCommand(i).commandLines(); for (int j=0; jinput->one(command); } diff --git a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMany2Many/twoWayMany2Many.H b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMany2Many/twoWayMany2Many.H index 96d8fc25..a9697249 100644 --- a/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMany2Many/twoWayMany2Many.H +++ b/src/lagrangian/cfdemParticle/subModels/dataExchangeModel/twoWayMany2Many/twoWayMany2Many.H @@ -201,15 +201,14 @@ public: void inline destroy(int*) const; //============== - bool couple(int) const; + bool couple(int); int getNumberOfParticles() const; int getNumberOfClumps() const; void syncIDs() const; void locateParticle(int*, bool) const; - word myType() const { return typeName; } - void setCG() { particleCloud_.setCG(lmp->force->cg()); } + scalar getCG() const { return lmp->force->cg(); } }; diff --git a/src/lagrangian/cfdemParticle/subModels/energyModel/heatTransferGunnImplicit/heatTransferGunnImplicit.C b/src/lagrangian/cfdemParticle/subModels/energyModel/heatTransferGunnImplicit/heatTransferGunnImplicit.C deleted file mode 100644 index 79941b51..00000000 --- a/src/lagrangian/cfdemParticle/subModels/energyModel/heatTransferGunnImplicit/heatTransferGunnImplicit.C +++ /dev/null @@ -1,161 +0,0 @@ -/*---------------------------------------------------------------------------*\ -License - - This 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. - - This code 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 this code. If not, see . - - Copyright (C) 2015- Thomas Lichtenegger, JKU Linz, Austria - -\*---------------------------------------------------------------------------*/ - -#include "error.H" -#include "heatTransferGunnImplicit.H" -#include "addToRunTimeSelectionTable.H" -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -defineTypeNameAndDebug(heatTransferGunnImplicit, 0); - -addToRunTimeSelectionTable(energyModel, heatTransferGunnImplicit, dictionary); - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -// Construct from components -heatTransferGunnImplicit::heatTransferGunnImplicit -( - const dictionary& dict, - cfdemCloudEnergy& sm -) -: - heatTransferGunn(dict,sm), - QPartFluidCoeffName_(propsDict_.lookupOrDefault("QPartFluidCoeffName","QPartFluidCoeff")), - QPartFluidCoeff_ - ( IOobject - ( - QPartFluidCoeffName_, - sm.mesh().time().timeName(), - sm.mesh(), - IOobject::READ_IF_PRESENT, - IOobject::AUTO_WRITE - ), - sm.mesh(), - dimensionedScalar("zero", dimensionSet(1,-1,-3,-1,0,0,0), 0.0) - ), - partHeatFluxCoeff_(NULL) -{ - allocateMyArrays(); - - // no limiting necessary for implicit heat transfer - maxSource_ = 1e30; -} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -heatTransferGunnImplicit::~heatTransferGunnImplicit() -{ - particleCloud_.dataExchangeM().destroy(partHeatFluxCoeff_,1); -} - -// * * * * * * * * * * * * * * * private Member Functions * * * * * * * * * * * * * // -void heatTransferGunnImplicit::allocateMyArrays() const -{ -// heatTransferGunn::allocateMyArrays(); - double initVal=0.0; - particleCloud_.dataExchangeM().allocateArray(partHeatFluxCoeff_,initVal,1); -} -// * * * * * * * * * * * * * * * * Member Fct * * * * * * * * * * * * * * * // - -void heatTransferGunnImplicit::calcEnergyContribution() -{ - allocateMyArrays(); - - heatTransferGunn::calcEnergyContribution(); - - QPartFluidCoeff_.primitiveFieldRef() = 0.0; - - particleCloud_.averagingM().setScalarSum - ( - QPartFluidCoeff_, - partHeatFluxCoeff_, - particleCloud_.particleWeights(), - NULL - ); - - QPartFluidCoeff_.primitiveFieldRef() /= -QPartFluidCoeff_.mesh().V(); - -// QPartFluidCoeff_.correctBoundaryConditions(); - -} - -void heatTransferGunnImplicit::addEnergyCoefficient(volScalarField& Qsource) const -{ - Qsource += QPartFluidCoeff_; -} - -void heatTransferGunnImplicit::heatFlux(label index, scalar h, scalar As, scalar Tfluid) -{ - partHeatFlux_[index][0] = -h * As * partTemp_[index][0]; -} - -void heatTransferGunnImplicit::heatFluxCoeff(label index, scalar h, scalar As) -{ - partHeatFluxCoeff_[index][0] = h * As; -} - -void heatTransferGunnImplicit::giveData(int call) -{ - if(call == 1) - { - //Info << "total convective particle-fluid heat flux [W] (Eulerian) = " << gSum(QPartFluid_*1.0*QPartFluid_.mesh().V()) << endl; - - particleCloud_.dataExchangeM().giveData(partHeatFluxName_,"scalar-atom", partHeatFlux_); - } -} - -void heatTransferGunnImplicit::postFlow() -{ - label cellI; - scalar Tfluid(0.0); - scalar Tpart(0.0); - interpolationCellPoint TInterpolator_(tempField_); - - for(int index = 0;index < particleCloud_.numberOfParticles(); ++index) - { - cellI = particleCloud_.cellIDs()[index][0]; - if(cellI >= 0) - { - if(interpolation_) - { - vector position = particleCloud_.position(index); - Tfluid = TInterpolator_.interpolate(position,cellI); - } - else - Tfluid = tempField_[cellI]; - - Tpart = partTemp_[index][0]; - partHeatFlux_[index][0] = (Tfluid - Tpart) * partHeatFluxCoeff_[index][0]; - } - } - - giveData(1); -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// ************************************************************************* // diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/KochHillRWDrag/KochHillRWDrag.C b/src/lagrangian/cfdemParticle/subModels/forceModel/KochHillRWDrag/KochHillRWDrag.C index 5303c7fd..513f2cf7 100755 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/KochHillRWDrag/KochHillRWDrag.C +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/KochHillRWDrag/KochHillRWDrag.C @@ -64,25 +64,21 @@ KochHillRWDrag::KochHillRWDrag : forceModel(dict,sm), propsDict_(dict.subDict(typeName + "Props")), - verbose_(false), + verbose_(propsDict_.found("verbose")), velFieldName_(propsDict_.lookup("velFieldName")), U_(sm.mesh().lookupObject (velFieldName_)), voidfractionFieldName_(propsDict_.lookup("voidfractionFieldName")), voidfraction_(sm.mesh().lookupObject (voidfractionFieldName_)), UsFieldName_(propsDict_.lookupOrDefault("granVelFieldName",word("Us"))), UsField_(sm.mesh().lookupObject (UsFieldName_)), - interpolation_(false), + interpolation_(propsDict_.found("interpolation")), scale_(1.), - randomTauE_(false), + randomTauE_(propsDict_.found("randomTauE")), partTime_(NULL), partUfluct_(NULL), RanGen_(label(0)) { - if (propsDict_.found("verbose")) verbose_ = true; - if (propsDict_.found("interpolation")) interpolation_ = true; - if (propsDict_.found("randomTauE")) randomTauE_ = true; - // init force sub model setForceSubModels(propsDict_); diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/KochHillRWDrag/KochHillRWDrag.H b/src/lagrangian/cfdemParticle/subModels/forceModel/KochHillRWDrag/KochHillRWDrag.H index 16d3f463..5a8b762d 100755 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/KochHillRWDrag/KochHillRWDrag.H +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/KochHillRWDrag/KochHillRWDrag.H @@ -65,7 +65,7 @@ class KochHillRWDrag private: dictionary propsDict_; - bool verbose_; + const bool verbose_; word velFieldName_; @@ -79,7 +79,7 @@ private: const volVectorField& UsField_; // the average particle velocity field - bool interpolation_; // use interpolated field values + const bool interpolation_; // use interpolated field values mutable scalar scale_; @@ -87,7 +87,7 @@ private: scalar rhoP_; - bool randomTauE_; + const bool randomTauE_; mutable double **partTime_; // Lagrangian array diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/SchillerNaumannDrag/SchillerNaumannDrag.C b/src/lagrangian/cfdemParticle/subModels/forceModel/SchillerNaumannDrag/SchillerNaumannDrag.C index 0c89a4aa..afe0e546 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/SchillerNaumannDrag/SchillerNaumannDrag.C +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/SchillerNaumannDrag/SchillerNaumannDrag.C @@ -64,7 +64,7 @@ SchillerNaumannDrag::SchillerNaumannDrag : forceModel(dict,sm), propsDict_(dict.subDict(typeName + "Props")), - verbose_(false), + verbose_(propsDict_.found("verbose")), velFieldName_(propsDict_.lookup("velFieldName")), U_(sm.mesh().lookupObject (velFieldName_)) { @@ -76,8 +76,6 @@ SchillerNaumannDrag::SchillerNaumannDrag particleCloud_.probeM().scalarFields_.append("Cd"); //other are debug particleCloud_.probeM().writeHeader(); - if (propsDict_.found("verbose")) verbose_=true; - // init force sub model setForceSubModels(propsDict_); diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/SchillerNaumannDrag/SchillerNaumannDrag.H b/src/lagrangian/cfdemParticle/subModels/forceModel/SchillerNaumannDrag/SchillerNaumannDrag.H index 4b7dc8d2..2fa743d5 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/SchillerNaumannDrag/SchillerNaumannDrag.H +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/SchillerNaumannDrag/SchillerNaumannDrag.H @@ -60,7 +60,7 @@ class SchillerNaumannDrag private: dictionary propsDict_; - bool verbose_; + const bool verbose_; word velFieldName_; diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/ShirgaonkarIB/ShirgaonkarIB.C b/src/lagrangian/cfdemParticle/subModels/forceModel/ShirgaonkarIB/ShirgaonkarIB.C index d0002a81..a2bbcb56 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/ShirgaonkarIB/ShirgaonkarIB.C +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/ShirgaonkarIB/ShirgaonkarIB.C @@ -63,8 +63,8 @@ ShirgaonkarIB::ShirgaonkarIB : forceModel(dict,sm), propsDict_(dict.subDict(typeName + "Props")), - verbose_(false), - twoDimensional_(false), + verbose_(propsDict_.found("verbose")), + twoDimensional_(propsDict_.found("twoDimensional")), depth_(1), velFieldName_(propsDict_.lookup("velFieldName")), U_(sm.mesh().lookupObject (velFieldName_)), @@ -76,10 +76,8 @@ ShirgaonkarIB::ShirgaonkarIB particleCloud_.probeM().vectorFields_.append("dragForce"); //first entry must the be the force particleCloud_.probeM().writeHeader(); - if (propsDict_.found("verbose")) verbose_=true; - if (propsDict_.found("twoDimensional")) + if (twoDimensional_) { - twoDimensional_=true; depth_ = propsDict_.lookup("depth"); Info << "2-dimensional simulation - make sure DEM side is 2D" << endl; Info << "depth of domain is assumed to be :" << depth_ << endl; @@ -148,7 +146,10 @@ void ShirgaonkarIB::setForce() const // write particle based data to global array forceSubM(0).partToArray(index,drag,vector::zero); - if(verbose_) Info << "impForces = " << impForces()[index][0]<<","< forceModel::provideScalarField() @@ -180,17 +178,21 @@ void forceModel::setForceSubModels(dictionary& dict) forceSubModels_.setSize(1, "ImEx"); } - delete[] forceSubModel_; - forceSubModel_ = new autoPtr[nrForceSubModels()]; + forceSubModel_.clear(); + forceSubModel_.setSize(nrForceSubModels()); Info << "nrForceSubModels()=" << nrForceSubModels() << endl; - for (int i=0;i* forceSubModel_; + mutable PtrList forceSubModel_; public: @@ -137,15 +137,10 @@ public: inline volVectorField& expParticleForces() const { return expParticleForces_; } - inline double ** impForces() const { return particleCloud_.impForces_; } - inline double ** expForces() const { return particleCloud_.expForces_; } - inline double ** DEMForces() const { return particleCloud_.DEMForces_; } - inline double ** Cds() const { return particleCloud_.Cds_; } - inline double ** fluidVel() const { return particleCloud_.fluidVel_; } inline bool coupleForce() const { return coupleForce_; } @@ -157,7 +152,7 @@ public: inline const wordList& forceSubModels() { return forceSubModels_; } - inline forceSubModel& forceSubM(int i) const { return forceSubModel_[i](); } + inline forceSubModel& forceSubM(int i) const { return forceSubModel_[i]; } inline int nrForceSubModels() const { return forceSubModels_.size(); } diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/forceSubModels/forceSubModel/forceSubModel.C b/src/lagrangian/cfdemParticle/subModels/forceModel/forceSubModels/forceSubModel/forceSubModel.C index fe3e98df..3931e65d 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/forceSubModels/forceSubModel/forceSubModel.C +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/forceSubModels/forceSubModel/forceSubModel.C @@ -143,14 +143,14 @@ void forceSubModel::partToArray if(switches_[SW_TREAT_FORCE_EXPLICIT]) // treatExplicit { for(int j=0;j<3;j++) - myForceM().expForces()[index][j] += dragTot[j]; + particleCloud_.expForces()[index][j] += dragTot[j]; } else //implicit treatment, taking explicit force contribution into account { for(int j=0;j<3;j++) { - myForceM().impForces()[index][j] += dragTot[j] - dragEx[j]; //only consider implicit part! - myForceM().expForces()[index][j] += dragEx[j]; + particleCloud_.impForces()[index][j] += dragTot[j] - dragEx[j]; //only consider implicit part! + particleCloud_.expForces()[index][j] += dragEx[j]; } } } @@ -159,14 +159,14 @@ void forceSubModel::partToArray if(switches_[SW_IMPL_FORCE_DEM]) // implForceDEM { for(int j=0;j<3;j++) - myForceM().fluidVel()[index][j]=Ufluid[j]; + particleCloud_.fluidVels()[index][j] = Ufluid[j]; - myForceM().Cds()[index][0] = Cd; + particleCloud_.Cds()[index][0] = Cd; } else { for(int j=0;j<3;j++) - myForceM().DEMForces()[index][j] += dragTot[j]; + particleCloud_.DEMForces()[index][j] += dragTot[j]; } } diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/gradPForceSmooth/gradPForceSmooth.C b/src/lagrangian/cfdemParticle/subModels/forceModel/gradPForceSmooth/gradPForceSmooth.C new file mode 100644 index 00000000..65f72b1a --- /dev/null +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/gradPForceSmooth/gradPForceSmooth.C @@ -0,0 +1,247 @@ +/*---------------------------------------------------------------------------*\ +License + + This 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. + + This code 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 this code. If not, see . + + Copyright (C) 2018- Mathias Vångö, JKU Linz, Austria + +\*---------------------------------------------------------------------------*/ + +#include "error.H" + +#include "gradPForceSmooth.H" +#include "addToRunTimeSelectionTable.H" +#include "smoothingModel.H" +#include "fvCFD.H" + + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + +// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // + +defineTypeNameAndDebug(gradPForceSmooth, 0); + +addToRunTimeSelectionTable +( + forceModel, + gradPForceSmooth, + dictionary +); + + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +// Construct from components +gradPForceSmooth::gradPForceSmooth +( + const dictionary& dict, + cfdemCloud& sm +) +: + forceModel(dict,sm), + propsDict_(dict.subDict(typeName + "Props")), + pFieldName_(propsDict_.lookup("pFieldName")), + p_(sm.mesh().lookupObject (pFieldName_)), + velocityFieldName_(propsDict_.lookup("velocityFieldName")), + U_(sm.mesh().lookupObject (velocityFieldName_)), + useRho_(false), + useU_(false), + addedMassCoeff_(0.0), + smoothingModel_ + ( + smoothingModel::New + ( + propsDict_, + sm + ) + ), + pSmooth_ + ( + IOobject + ( + "pSmooth", + sm.mesh().time().timeName(), + sm.mesh(), + IOobject::MUST_READ, + IOobject::AUTO_WRITE + ), + sm.mesh() + ) +{ + // init force sub model + setForceSubModels(propsDict_); + + // define switches which can be read from dict + forceSubM(0).setSwitchesList(0,true); // activate treatExplicit switch + forceSubM(0).setSwitchesList(1,true); // activate treatForceDEM switch + forceSubM(0).setSwitchesList(4,true); // activate search for interpolate switch + + // read those switches defined above, if provided in dict + forceSubM(0).readSwitches(); + + if (modelType_ == "B") + { + FatalError <<"using model gradPForceSmooth with model type B is not valid\n" << abort(FatalError); + }else if (modelType_ == "Bfull") + { + if(forceSubM(0).switches()[1]) + { + Info << "Using treatForceDEM false!" << endl; + forceSubM(0).setSwitches(1,false); // treatForceDEM = false + } + }else // modelType_=="A" + { + if(!forceSubM(0).switches()[1]) + { + Info << "Using treatForceDEM true!" << endl; + forceSubM(0).setSwitches(1,true); // treatForceDEM = true + } + } + + if (propsDict_.found("useU")) useU_=true; + if (propsDict_.found("useAddedMass")) + { + addedMassCoeff_ = readScalar(propsDict_.lookup("useAddedMass")); + Info << "gradP will also include added mass with coefficient: " << addedMassCoeff_ << endl; + Info << "WARNING: use fix nve/sphere/addedMass in LIGGGHTS input script to correctly account for added mass effects!" << endl; + } + + if(p_.dimensions()==dimensionSet(0,2,-2,0,0)) + useRho_ = true; + + particleCloud_.checkCG(true); + + particleCloud_.probeM().initialize(typeName, "gradP.logDat"); + particleCloud_.probeM().vectorFields_.append("gradPForceSmooth"); //first entry must the be the force + particleCloud_.probeM().scalarFields_.append("Vs"); + particleCloud_.probeM().scalarFields_.append("rho"); + particleCloud_.probeM().writeHeader(); + + pSmooth_ = p_; + } + + +// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // + +gradPForceSmooth::~gradPForceSmooth() +{} + + +// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // + +void gradPForceSmooth::setForce() const +{ + volVectorField gradPField = fvc::grad(p_); + if(pFieldName_ == "p_rgh") + { + const volScalarField& rho_ = particleCloud_.mesh().lookupObject("rho"); + const volScalarField& gh_ = particleCloud_.mesh().lookupObject("gh"); + + //Smooth p_rgh, easier to handle boundaries + smoothingM().smoothen(pSmooth_); + + //Superpose hydrostatic pressure + volScalarField pFull = pSmooth_ + rho_*gh_; + + gradPField = fvc::grad(pFull); + + }else{ + + smoothingM().smoothen(pSmooth_); + gradPField = fvc::grad(pSmooth_); + + } + + /*if (useU_) + { + // const volScalarField& voidfraction_ = particleCloud_.mesh().lookupObject ("voidfraction"); + volScalarField U2 = U_&U_;// *voidfraction_*voidfraction_; + if (useRho_) + gradPField = fvc::grad(0.5*U2); + else + gradPField = fvc::grad(0.5*forceSubM(0).rhoField()*U2); + }*/ + vector gradP; + scalar Vs; + scalar rho; + vector position; + vector force; + label cellI; + + interpolationCellPoint gradPInterpolator_(gradPField); + #include "setupProbeModel.H" + + for(int index = 0;index < particleCloud_.numberOfParticles(); index++) + { + //if(mask[index][0]) + //{ + force=vector(0,0,0); + cellI = particleCloud_.cellIDs()[index][0]; + + if (cellI > -1) // particle Found + { + position = particleCloud_.position(index); + + if(forceSubM(0).interpolation()) // use intepolated values for alpha (normally off!!!) + { + gradP = gradPInterpolator_.interpolate(position,cellI); + }else + { + gradP = gradPField[cellI]; + } + + Vs = particleCloud_.particleVolume(index); + rho = forceSubM(0).rhoField()[cellI]; + + // calc particle's pressure gradient force + if (useRho_) + force = -Vs*gradP*rho*(1.0+addedMassCoeff_); + else + force = -Vs*gradP*(1.0+addedMassCoeff_); + + if(forceSubM(0).verbose() && index >=0 && index <2) + { + Info << "index = " << index << endl; + Info << "gradP = " << gradP << endl; + Info << "force = " << force << endl; + } + + //Set value fields and write the probe + if(probeIt_) + { + #include "setupProbeModelfields.H" + vValues.append(force); //first entry must the be the force + sValues.append(Vs); + sValues.append(rho); + particleCloud_.probeM().writeProbe(index, sValues, vValues); + } + } + + // write particle based data to global array + forceSubM(0).partToArray(index,force,vector::zero); + + //} + } +} + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// ************************************************************************* // diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/gradPForceSmooth/gradPForceSmooth.H b/src/lagrangian/cfdemParticle/subModels/forceModel/gradPForceSmooth/gradPForceSmooth.H new file mode 100644 index 00000000..dca59f0d --- /dev/null +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/gradPForceSmooth/gradPForceSmooth.H @@ -0,0 +1,108 @@ +/*---------------------------------------------------------------------------*\ +License + + This 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. + + This code 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 this code. If not, see . + + Copyright (C) 2018- Mathias Vångö, JKU Linz, Austria + +Class + gradPForceSmooth + +Description + This code is an extention of the gradPForce class by allowing the pressure- + field to be smoothened prior to the force calculation (without altering the + original field). + +SourceFiles + gradPForceSmooth.C + +\*---------------------------------------------------------------------------*/ + +#ifndef gradPForceSmooth_H +#define gradPForceSmooth_H + +#include "forceModel.H" +#include "interpolationCellPoint.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ +/*---------------------------------------------------------------------------*\ + Class gradPForceSmooth Declaration +\*---------------------------------------------------------------------------*/ + +class gradPForceSmooth +: + public forceModel +{ +private: + dictionary propsDict_; + + word pFieldName_; + + const volScalarField& p_; + + word velocityFieldName_; + + const volVectorField& U_; + + bool useRho_; + + bool useU_; // if false: substitution p=0.5*rho*U^2 + + mutable double addedMassCoeff_; //added mass coefficient + + autoPtr smoothingModel_; + + mutable volScalarField pSmooth_; + +public: + + //- Runtime type information + TypeName("gradPForceSmooth"); + + + // Constructors + + //- Construct from components + gradPForceSmooth + ( + const dictionary& dict, + cfdemCloud& sm + ); + + // Destructor + + ~gradPForceSmooth(); + + + // Member Functions + void setForce() const; + inline const smoothingModel& smoothingM() const + { + return smoothingModel_; + } +}; + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#endif + +// ************************************************************************* // diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/noDrag/noDrag.C b/src/lagrangian/cfdemParticle/subModels/forceModel/noDrag/noDrag.C index f431f890..6cef7052 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/noDrag/noDrag.C +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/noDrag/noDrag.C @@ -61,13 +61,11 @@ noDrag::noDrag ) : forceModel(dict,sm), - propsDict_(dict), - verbose_(false), - noDEMForce_(false) + propsDict_(dict.subOrEmptyDict(word(typeName + "Props"))), + verbose_(propsDict_.found("verbose")), + noDEMForce_(propsDict_.found("noDEMForce")), + keepCFDForce_(propsDict_.found("keepCFDForce")) { - if(dict.found(word(typeName + "Props"))) - propsDict_=dictionary(dict.subDict(typeName + "Props")); - // init force sub model setForceSubModels(propsDict_); @@ -77,10 +75,6 @@ noDrag::noDrag // read those switches defined above, if provided in dict forceSubM(0).readSwitches(); - if (propsDict_.found("noDEMForce")) noDEMForce_=true; - - if (propsDict_.found("keepCFDForce")) keepCFDForce_=true; - coupleForce_=false; } @@ -112,16 +106,16 @@ void noDrag::setForce() const // set force on particle (old code) if(!keepCFDForce_) { - if(treatExplicit) for(int j=0;j<3;j++) expForces()[index][j] = 0.; - else for(int j=0;j<3;j++) impForces()[index][j] = 0.; + if(treatExplicit) for(int j=0;j<3;j++) particleCloud_.expForces()[index][j] = 0.; + else for(int j=0;j<3;j++) particleCloud_.impForces()[index][j] = 0.; } if(noDEMForce_) { - for(int j=0;j<3;j++) DEMForces()[index][j] = 0.; + for(int j=0;j<3;j++) particleCloud_.DEMForces()[index][j] = 0.; if(particleCloud_.impDEMdrag()) { - Cds()[index][0] = 0.; - for(int j=0;j<3;j++) fluidVel()[index][j] = 0.; + particleCloud_.Cds()[index][0] = 0.; + for(int j=0;j<3;j++) particleCloud_.fluidVels()[index][j] = 0.; } } //========================== diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/noDrag/noDrag.H b/src/lagrangian/cfdemParticle/subModels/forceModel/noDrag/noDrag.H index 89282670..df7a9316 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/noDrag/noDrag.H +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/noDrag/noDrag.H @@ -57,11 +57,11 @@ class noDrag private: dictionary propsDict_; - bool verbose_; + const bool verbose_; - bool noDEMForce_; + const bool noDEMForce_; - bool keepCFDForce_; + const bool keepCFDForce_; public: diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/particleCellVolume/particleCellVolume.C b/src/lagrangian/cfdemParticle/subModels/forceModel/particleCellVolume/particleCellVolume.C index 54c956b1..e09af175 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/particleCellVolume/particleCellVolume.C +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/particleCellVolume/particleCellVolume.C @@ -64,10 +64,10 @@ particleCellVolume::particleCellVolume forceModel(dict,sm), propsDict_(dict.subDict(typeName + "Props")), mesh_(particleCloud_.mesh()), - startTime_(0.), + startTime_(propsDict_.lookupOrDefault("startTime",0.0)), scalarFieldName_("voidfraction"), scalarField_ - ( + ( IOobject ( "particleCellVolume", @@ -80,7 +80,7 @@ particleCellVolume::particleCellVolume dimensionedScalar("zero", dimensionSet(0,0,0,0,0), 0) ), scalarField2_ - ( + ( IOobject ( "cellVolume", @@ -94,15 +94,8 @@ particleCellVolume::particleCellVolume ), upperThreshold_(readScalar(propsDict_.lookup("upperThreshold"))), lowerThreshold_(readScalar(propsDict_.lookup("lowerThreshold"))), - verbose_(false) + verbose_(propsDict_.found("verbose")) { - if (propsDict_.found("startTime")){ - startTime_=readScalar(propsDict_.lookup("startTime")); - } - - if (propsDict_.found("verbose")){ - verbose_ = true; - } } diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/particleCellVolume/particleCellVolume.H b/src/lagrangian/cfdemParticle/subModels/forceModel/particleCellVolume/particleCellVolume.H index 4beb226f..b70f5329 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/particleCellVolume/particleCellVolume.H +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/particleCellVolume/particleCellVolume.H @@ -60,7 +60,7 @@ private: const fvMesh& mesh_; - scalar startTime_; + const scalar startTime_; const word scalarFieldName_; @@ -72,7 +72,7 @@ private: mutable scalar lowerThreshold_; - Switch verbose_; + const Switch verbose_; public: diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/surfaceTensionForce/surfaceTensionForce.C b/src/lagrangian/cfdemParticle/subModels/forceModel/surfaceTensionForce/surfaceTensionForce.C new file mode 100644 index 00000000..13d651ed --- /dev/null +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/surfaceTensionForce/surfaceTensionForce.C @@ -0,0 +1,110 @@ +/*---------------------------------------------------------------------------*\ +License + + This 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. + + This code 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 this code. If not, see . + + Copyright (C) 2018- Mathias Vångö, JKU Linz, Austria + +\*---------------------------------------------------------------------------*/ + +#include "error.H" + +#include "surfaceTensionForce.H" +#include "addToRunTimeSelectionTable.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + +// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // + +defineTypeNameAndDebug(surfaceTensionForce, 0); + +addToRunTimeSelectionTable +( + forceModel, + surfaceTensionForce, + dictionary +); + + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +// Construct from components +surfaceTensionForce::surfaceTensionForce +( + const dictionary& dict, + cfdemCloud& sm +) +: + forceModel(dict,sm), + propsDict_(dict.subDict(typeName + "Props")), + stfFieldName_(propsDict_.lookupOrDefault("stfFieldName", "surfaceTensionForce")), + stf_(sm.mesh().lookupObject (stfFieldName_)) +{ + + + // init force sub model + setForceSubModels(propsDict_); + + // define switches which can be read from dict + forceSubM(0).setSwitchesList(0,true); // activate treatExplicit switch + + // read those switches defined above, if provided in dict + forceSubM(0).readSwitches(); + + Info << "check if interpolation really works - use directly interpolationCellPoint ???" << endl; + particleCloud_.checkCG(false); +} + + +// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // + +surfaceTensionForce::~surfaceTensionForce() +{} + + +// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // + +void surfaceTensionForce::setForce() const +{ + volVectorField reconstructedStf = fvc::reconstruct(stf_*particleCloud_.mesh().magSf()); + for(int index = 0;index < particleCloud_.numberOfParticles(); ++index) + { + //if(mask[index][0]) + //{ + // definition of spherical particle + label cellI = particleCloud_.cellIDs()[index][0]; + scalar Vp = particleCloud_.particleVolume(index); + if(cellI >-1.0) // particle found on proc domain + { + vector surfaceTensionForcep = Foam::vector(0,0,0); + + surfaceTensionForcep = Vp * reconstructedStf[cellI]; + + // write particle based data to global array + forceSubM(0).partToArray(index,surfaceTensionForcep,vector::zero); + + } // end if particle found on proc domain + //}// end if in mask + }// end loop particles +} + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// ************************************************************************* // diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/surfaceTensionForce/surfaceTensionForce.H b/src/lagrangian/cfdemParticle/subModels/forceModel/surfaceTensionForce/surfaceTensionForce.H new file mode 100644 index 00000000..580f80a5 --- /dev/null +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/surfaceTensionForce/surfaceTensionForce.H @@ -0,0 +1,90 @@ +/*---------------------------------------------------------------------------*\ +License + + This 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. + + This code 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 this code. If not, see . + + Copyright (C) 2018- Mathias Vångö, JKU Linz, Austria + +Description + Applies a pre-calculated surface tension force to the particles. + +Class + surfaceTensionForce + +SourceFiles + surfaceTensionForce.C + +\*---------------------------------------------------------------------------*/ + +#ifndef surfaceTensionForce_H +#define surfaceTensionForce_H + +#include "forceModel.H" +#include "interpolationCellPoint.H" + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + +/*---------------------------------------------------------------------------*\ + Class surfaceTensionForce Declaration +\*---------------------------------------------------------------------------*/ + +class surfaceTensionForce +: + public forceModel +{ +private: + dictionary propsDict_; + + word stfFieldName_; + + const surfaceScalarField& stf_; + +public: + + //- Runtime type information + TypeName("surfaceTensionForce"); + + + // Constructors + + //- Construct from components + surfaceTensionForce + ( + const dictionary& dict, + cfdemCloud& sm + ); + + // Destructor + + ~surfaceTensionForce(); + + + // Member Functions + void setForce() const; +}; + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#endif + +// ************************************************************************* // diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/virtualMassForce/virtualMassForce.C b/src/lagrangian/cfdemParticle/subModels/forceModel/virtualMassForce/virtualMassForce.C index 2d33a4fb..122b50e7 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/virtualMassForce/virtualMassForce.C +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/virtualMassForce/virtualMassForce.C @@ -70,7 +70,7 @@ virtualMassForce::virtualMassForce phiFieldName_(propsDict_.lookup("phiFieldName")), phi_(sm.mesh().lookupObject (phiFieldName_)), UrelOld_(NULL), - splitUrelCalculation_(false), + splitUrelCalculation_(propsDict_.lookupOrDefault("splitUrelCalculation",false)), Cadd_(0.5) { @@ -88,14 +88,10 @@ virtualMassForce::virtualMassForce forceSubM(0).readSwitches(); //Extra switches/settings - if(propsDict_.found("splitUrelCalculation")) + if(splitUrelCalculation_) { - splitUrelCalculation_ = readBool(propsDict_.lookup("splitUrelCalculation")); - if(splitUrelCalculation_) - { - Info << "Virtual mass model: will split the Urel calculation\n"; - Info << "WARNING: be sure that LIGGGHTS integration takes ddtv_p implicitly into account! \n"; - } + Info << "Virtual mass model: will split the Urel calculation\n"; + Info << "WARNING: be sure that LIGGGHTS integration takes ddtv_p implicitly into account! \n"; } if(propsDict_.found("Cadd")) { diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/virtualMassForce/virtualMassForce.H b/src/lagrangian/cfdemParticle/subModels/forceModel/virtualMassForce/virtualMassForce.H index ff2ee4df..b645fc4b 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/virtualMassForce/virtualMassForce.H +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/virtualMassForce/virtualMassForce.H @@ -69,7 +69,7 @@ private: mutable double **UrelOld_; - mutable bool splitUrelCalculation_; //indicator to split calculation of Urel between CFDEM and LIGGGHTS + const bool splitUrelCalculation_; //indicator to split calculation of Urel between CFDEM and LIGGGHTS //requires the integration fix to take dv/dt into account! mutable double Cadd_; //indicator to split calculation of Urel between CFDEM and LIGGGHTS diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/volWeightedAverage/volWeightedAverage.C b/src/lagrangian/cfdemParticle/subModels/forceModel/volWeightedAverage/volWeightedAverage.C index d4d3d603..c5cffe6f 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/volWeightedAverage/volWeightedAverage.C +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/volWeightedAverage/volWeightedAverage.C @@ -64,25 +64,17 @@ volWeightedAverage::volWeightedAverage forceModel(dict,sm), propsDict_(dict.subDict(typeName + "Props")), mesh_(particleCloud_.mesh()), - startTime_(0.), + startTime_(propsDict_.lookupOrDefault("startTime", 0.)), scalarFieldNames_(propsDict_.lookup("scalarFieldNames")), vectorFieldNames_(propsDict_.lookup("vectorFieldNames")), upperThreshold_(readScalar(propsDict_.lookup("upperThreshold"))), lowerThreshold_(readScalar(propsDict_.lookup("lowerThreshold"))), - verbose_(false) + verbose_(propsDict_.found("verbose")) { - if (propsDict_.found("startTime")){ - startTime_=readScalar(propsDict_.lookup("startTime")); - } - - if (propsDict_.found("verbose")){ - verbose_ = true; - } - // create vol weighted average scalar fields scalarFields_.setSize(scalarFieldNames_.size()); - for (int i=0;i < scalarFieldNames_.size(); i++) + for (int i=0; i < scalarFieldNames_.size(); i++) { word fieldName = "volAverage_" + scalarFieldNames_[i]; diff --git a/src/lagrangian/cfdemParticle/subModels/forceModel/volWeightedAverage/volWeightedAverage.H b/src/lagrangian/cfdemParticle/subModels/forceModel/volWeightedAverage/volWeightedAverage.H index 0aa4743e..b2b7d968 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModel/volWeightedAverage/volWeightedAverage.H +++ b/src/lagrangian/cfdemParticle/subModels/forceModel/volWeightedAverage/volWeightedAverage.H @@ -60,7 +60,7 @@ private: const fvMesh& mesh_; - scalar startTime_; + const scalar startTime_; const wordList scalarFieldNames_; @@ -70,11 +70,11 @@ private: mutable PtrList vectorFields_; - mutable scalar upperThreshold_; + const scalar upperThreshold_; - mutable scalar lowerThreshold_; + const scalar lowerThreshold_; - Switch verbose_; + const Switch verbose_; public: diff --git a/src/lagrangian/cfdemParticle/subModels/forceModelMS/forceModelMS/forceModelMS.C b/src/lagrangian/cfdemParticle/subModels/forceModelMS/forceModelMS/forceModelMS.C index ebf9e656..fc6f8bd9 100644 --- a/src/lagrangian/cfdemParticle/subModels/forceModelMS/forceModelMS/forceModelMS.C +++ b/src/lagrangian/cfdemParticle/subModels/forceModelMS/forceModelMS/forceModelMS.C @@ -92,10 +92,10 @@ void forceModelMS::setForcesOnParticle() const << nrigidC <<", ind = " << ind <<", index=" << index <<"\n" << endl; nrigidC = 1000; } - if(forceSubM(0).switches()[0]) for(int j=0;j<3;j++) expForces()[index][j] += cloudRefMS().expForcesCM()[ind][j] / nrigidC; + if(forceSubM(0).switches()[0]) for(int j=0;j<3;j++) particleCloud_.expForces()[index][j] += cloudRefMS().expForcesCM()[ind][j] / nrigidC; else{ for(int j=0;j<3;j++){ - impForces()[index][j] += cloudRefMS().impForcesCM()[ind][j] / nrigidC; + particleCloud_.impForces()[index][j] += cloudRefMS().impForcesCM()[ind][j] / nrigidC; } } } diff --git a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/execute/execute.C b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/execute/execute.C index c13c59e6..3b8a4c94 100644 --- a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/execute/execute.C +++ b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/execute/execute.C @@ -63,36 +63,44 @@ execute::execute : liggghtsCommandModel(dict,sm,i), nrModel_(i), - myName_("notYetGiven"), - propsDict_(dict), - commandList_(0), + propsDict_(), + commandList_(), command_(""), scalarList_(0), labelList_(0), timeStamp_(false) { - // define dictionary - char h[80]; - sprintf(h,"%d",nrModel_); - myName_=word(typeName + "Props" + h); - propsDict_=dictionary(dict.subDict(myName_)); + // read propsDict + OStringStream oStrStream; + oStrStream << nrModel_; - // read command from dict + propsDict_ = dict.subOrEmptyDict(typeName + "Props" + oStrStream.str()); + + // read command list commandList_ = wordList(propsDict_.lookup("command")); // read list of scalars - if(propsDict_.found("scalars")) scalarList_ = scalarList(propsDict_.lookup("scalars")); + if (propsDict_.found("scalars")) + { + scalarList_ = scalarList(propsDict_.lookup("scalars")); + } // read list of labels - if(propsDict_.found("labels")) labelList_ = labelList(propsDict_.lookup("labels")); + if (propsDict_.found("labels")) + { + labelList_ = labelList(propsDict_.lookup("labels")); + } // check if verbose - if (propsDict_.found("verbose")) verbose_=true; + if (propsDict_.found("verbose")) + { + verbose_ = true; + } parseCommandList(commandList_, labelList_, scalarList_, command_, propsDict_, timeStamp_); Info << "liggghtsCommand " << command_ << endl; - strCommand_=string(command_); + strCommand_ = string(command_); checkTimeMode(propsDict_); @@ -115,7 +123,7 @@ const char* execute::command(int commandLine) bool execute::runCommand(int couplingStep) { - if(timeStamp_) strCommand_=addTimeStamp(command_); + if (timeStamp_) strCommand_ = addTimeStamp(command_); checkTimeSettings(propsDict_); return runThisCommand(couplingStep); diff --git a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/execute/execute.H b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/execute/execute.H index 813eb546..1d9df4ae 100644 --- a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/execute/execute.H +++ b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/execute/execute.H @@ -59,8 +59,6 @@ private: int nrModel_; - word myName_; - dictionary propsDict_; wordList commandList_; @@ -96,11 +94,11 @@ public: // Member Functions - word name(){return myName_;} + word name() const {return propsDict_.dictName();} - const char* command(int); + const char* command(int); - bool runCommand(int); + bool runCommand(int); }; diff --git a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/liggghtsCommandModel/liggghtsCommandModel.C b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/liggghtsCommandModel/liggghtsCommandModel.C index 9b6ef7f4..9c6236d8 100644 --- a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/liggghtsCommandModel/liggghtsCommandModel.C +++ b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/liggghtsCommandModel/liggghtsCommandModel.C @@ -88,24 +88,25 @@ void liggghtsCommandModel::checkTimeMode(dictionary& propsDict) { runFirst_=Switch(propsDict.lookup("runFirst")); - if(!runFirst_) + if (!runFirst_) { // check if being run only at last coupling step runLast_=Switch(propsDict.lookup("runLast")); - if(!runLast_) + if (!runLast_) { // check if being run every coupling step runEveryCouplingStep_=Switch(propsDict.lookup("runEveryCouplingStep")); - if(!runEveryCouplingStep_) + if (!runEveryCouplingStep_) { runEveryWriteStep_=Switch(propsDict.lookup("runEveryWriteStep")); } } } - if(verbose_){ + if (verbose_) + { Info << "runFirst = " << runFirst_ << endl; Info << "runLast = " << runLast_ << endl; Info << "runEveryCouplingStep = " << runEveryCouplingStep_ << endl; @@ -115,13 +116,13 @@ void liggghtsCommandModel::checkTimeMode(dictionary& propsDict) void liggghtsCommandModel::checkTimeSettings(const dictionary& propsDict) { - if(!runFirst_) //lastRun or runEveryCouplingStep or every n steps or every writeStep + if (!runFirst_) //lastRun or runEveryCouplingStep or every n steps or every writeStep { scalar DEMts = particleCloud_.dataExchangeM().DEMts(); scalar couplingInterval = particleCloud_.dataExchangeM().couplingInterval(); scalar simStartTime = particleCloud_.mesh().time().startTime().value(); - if(runLast_) // last run + if (runLast_) // last run { // read time options from subdict endTime_ = particleCloud_.mesh().time().endTime().value()-simStartTime; @@ -163,7 +164,8 @@ void liggghtsCommandModel::checkTimeSettings(const dictionary& propsDict) couplingStepInterval_ =-1; } - if(verbose_){ + if (verbose_) + { Info << "firstCouplingStep = " << firstCouplingStep_ << endl; Info << "lastCouplingStep = " << lastCouplingStep_ << endl; Info << "couplingStepInterval = " << couplingStepInterval_ << endl; @@ -173,14 +175,15 @@ void liggghtsCommandModel::checkTimeSettings(const dictionary& propsDict) bool liggghtsCommandModel::runThisCommand(int couplingStep) { - if(verbose_) Info << "couplingStep = " << couplingStep << endl; + if (verbose_) Info << "couplingStep = " << couplingStep << endl; bool runIt=false; - if( - (!runEveryWriteStep_ && firstCouplingStep_ <= couplingStep && lastCouplingStep_ >= couplingStep) || - (runEveryWriteStep_ && particleCloud_.mesh().time().outputTime()) - ) + if + ( + (!runEveryWriteStep_ && firstCouplingStep_ <= couplingStep && lastCouplingStep_ >= couplingStep) || + (runEveryWriteStep_ && particleCloud_.mesh().time().outputTime()) + ) { - if(couplingStep >= nextRun_) + if (couplingStep >= nextRun_) { runIt=true; nextRun_=couplingStep + couplingStepInterval_; @@ -209,7 +212,7 @@ DynamicList liggghtsCommandModel::executionsWithinPeriod(scalar TSstart, DynamicList executions(0); // current TS within active period - if(startTime_+SMALLTSstart-SMALL ) + if (startTime_+SMALLTSstart-SMALL ) { Info << "working time within this TS" << endl; @@ -217,7 +220,7 @@ DynamicList liggghtsCommandModel::executionsWithinPeriod(scalar TSstart, int startNr = 0; scalar t = startTime_ + startNr * timeInterval_; - if(timeInterval_ > SMALL) + if (timeInterval_ > SMALL) { while (TSend - t > SMALL) { @@ -227,7 +230,7 @@ DynamicList liggghtsCommandModel::executionsWithinPeriod(scalar TSstart, t -= timeInterval_; } // check if first exec found within TS - if(TSstart < t + SMALL && t +SMALL < TSend) + if (TSstart < t + SMALL && t +SMALL < TSend) { // check for more executions while (t < endTime_ + SMALL && TSend - t > SMALL) @@ -280,15 +283,18 @@ void liggghtsCommandModel::parseCommandList(wordList& commandList,labelList& lab { add = ""; addBlank = false; - }else if (add=="blanks") // add a blank here and after the following words + } + else if (add=="blanks") // add a blank here and after the following words { add = ""; addBlank = true; - }else if (add=="timeStamp") // add a time stamp + } + else if (add=="timeStamp") // add a time stamp { add = ""; timeStamp=true; - }else if (add=="number") // next command will be a number read from labelList + } + else if (add=="number") // next command will be a number read from labelList { /*if (!propsDict.found("scalars")) { @@ -299,7 +305,8 @@ void liggghtsCommandModel::parseCommandList(wordList& commandList,labelList& lab sprintf(h,"%f",scalarList[numberCount]); add = h; numberCount ++; - }else if (add=="label") // next command will be a number read from labelList + } + else if (add=="label") // next command will be a number read from labelList { /*if (!propsDict.found("labels")) { @@ -316,7 +323,8 @@ void liggghtsCommandModel::parseCommandList(wordList& commandList,labelList& lab if (addBlank) { command += add + " "; - }else + } + else { command += add; } diff --git a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/liggghtsCommandModel/liggghtsCommandModel.H b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/liggghtsCommandModel/liggghtsCommandModel.H index c2765377..ad31344d 100644 --- a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/liggghtsCommandModel/liggghtsCommandModel.H +++ b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/liggghtsCommandModel/liggghtsCommandModel.H @@ -91,6 +91,7 @@ protected: label commandLines_; + // verbose_ can/will be overwritten by the constructors of the derived classes bool verbose_; public: @@ -164,15 +165,15 @@ public: // Access - int nextRun(){return nextRun_;} + int nextRun() const {return nextRun_;} - int lastRun(){return lastRun_;} + int lastRun() const {return lastRun_;} - virtual word name()=0; + virtual word name() const=0; - bool exactTiming(){return exactTiming_;} + bool exactTiming() const {return exactTiming_;} - label commandLines(){return commandLines_;} + label commandLines() const {return commandLines_;} void parseCommandList(wordList&, labelList&, scalarList&, word&, dictionary&, bool&); }; diff --git a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/readLiggghtsData/readLiggghtsData.C b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/readLiggghtsData/readLiggghtsData.C index 3605ce97..31cdb2da 100644 --- a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/readLiggghtsData/readLiggghtsData.C +++ b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/readLiggghtsData/readLiggghtsData.C @@ -63,26 +63,29 @@ readLiggghtsData::readLiggghtsData : liggghtsCommandModel(dict,sm,i), nrModel_(i), - insertionNr_(0.), + propsDict_(), + insertionNr_(), command_("read_data"), - myName_("notYetGiven"), - propsDict_(dict), filePathList_(0) { - // define dictionary - char h[80]; - sprintf(h,"%d",nrModel_); - myName_=word(typeName + "Props" + h); - propsDict_=dictionary(dict.subDict(myName_)); + // read propsDict + OStringStream oStrStream; + oStrStream << nrModel_; + + propsDict_ = dict.subOrEmptyDict(typeName + "Props" + oStrStream.str()); + + // read insertion nr + insertionNr_ = readLabel(propsDict_.lookup("startIndex")); + + + exactTiming_ = propsDict_.found("exactTiming"); - if (propsDict_.found("exactTiming")) - exactTiming_=true; Info << "exactTiming==" << exactTiming_ << endl; - if (propsDict_.found("verbose")) verbose_=true; - - // read first index of data file to be injected - insertionNr_=readScalar(propsDict_.lookup("startIndex")); + if (propsDict_.found("verbose")) + { + verbose_ = true; + } // read command from dict filePathList_ = wordList(propsDict_.lookup("filePath")); @@ -115,10 +118,10 @@ readLiggghtsData::~readLiggghtsData() const char* readLiggghtsData::command(int commandLine) { char h[50]; - sprintf(h,"_%d",insertionNr_); + sprintf(h, "_%d", insertionNr_); word add = h; insertionNr_++; - strCommand_=string(command_ + add + " add"); + strCommand_ = string(command_ + add + " add"); return strCommand_.c_str(); } diff --git a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/readLiggghtsData/readLiggghtsData.H b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/readLiggghtsData/readLiggghtsData.H index 345d2c4d..c52fc893 100644 --- a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/readLiggghtsData/readLiggghtsData.H +++ b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/readLiggghtsData/readLiggghtsData.H @@ -58,14 +58,12 @@ private: int nrModel_; + dictionary propsDict_; + int insertionNr_; word command_; - word myName_; - - dictionary propsDict_; - wordList filePathList_; public: @@ -91,11 +89,11 @@ public: // Member Functions - word name(){return myName_;}; + word name() const {return propsDict_.dictName();} - const char* command(int); + const char* command(int); - bool runCommand(int); + bool runCommand(int); }; diff --git a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/runLiggghts/runLiggghts.C b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/runLiggghts/runLiggghts.C index 2969a052..8b7f41b0 100644 --- a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/runLiggghts/runLiggghts.C +++ b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/runLiggghts/runLiggghts.C @@ -62,24 +62,15 @@ runLiggghts::runLiggghts ) : liggghtsCommandModel(dict,sm,i), - propsDict_(dict), + propsDict_(dict.subOrEmptyDict(typeName + "Props")), command_("run"), - preNo_(true), - stdInterval_(0) + preNo_(propsDict_.lookupOrDefault("preNo", true)) { - word myName=word(typeName + "Props"); - if (dict.found(myName)) - { - propsDict_=dictionary(dict.subDict(myName)); - preNo_=Switch(propsDict_.lookup("preNo")); + verbose_ = propsDict_.found("verbose"); - // check if verbose - if (propsDict_.found("verbose")) verbose_=true; - } + runEveryCouplingStep_ = true; - runEveryCouplingStep_=true; - - strCommand_=createCommand(command_); + strCommand_ = createCommand(command_); checkTimeSettings(dict_); } @@ -100,11 +91,10 @@ const char* runLiggghts::command(int commandLine) string runLiggghts::createCommand( word command, int interval, word appendix, word appendix2, word appendix3, word appendix4) { - fileName add; - char h[50]; - sprintf(h,"%d",interval); - add = h; - command += " " + add + " " + appendix + " " + appendix2 + " " + appendix3 + " " + appendix4; + OStringStream oStrStream; + oStrStream << interval; + + command += " " + oStrStream.str() + " " + appendix + " " + appendix2 + " " + appendix3 + " " + appendix4; return string(command); } @@ -113,9 +103,13 @@ bool runLiggghts::runCommand(int couplingStep) { //change command to "run xxx pre no" if (preNo_ && (couplingStep > firstCouplingStep_)) - strCommand_=createCommand(command_, particleCloud_.dataExchangeM().couplingInterval(),"pre","no","post","no"); + { + strCommand_ = createCommand(command_, particleCloud_.dataExchangeM().couplingInterval(),"pre","no","post","no"); + } else - strCommand_=createCommand(command_, particleCloud_.dataExchangeM().couplingInterval()); + { + strCommand_ = createCommand(command_, particleCloud_.dataExchangeM().couplingInterval()); + } return runThisCommand(couplingStep); } @@ -123,9 +117,13 @@ bool runLiggghts::runCommand(int couplingStep) void runLiggghts::set(int interval) { if (preNo_) + { strCommand_ = createCommand(command_, interval,"pre","no","post","no"); + } else + { strCommand_ = createCommand(command_, interval); + } } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/runLiggghts/runLiggghts.H b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/runLiggghts/runLiggghts.H index 39aaa3ee..6068730d 100644 --- a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/runLiggghts/runLiggghts.H +++ b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/runLiggghts/runLiggghts.H @@ -63,8 +63,6 @@ private: bool preNo_; - int stdInterval_; - public: //- Runtime type information @@ -88,15 +86,15 @@ public: // Member Functions - const char* command(int); + const char* command(int); - string createCommand(word="",int=0,word="",word="",word="",word=""); + string createCommand(word="",int=0,word="",word="",word="",word=""); - bool runCommand(int); + bool runCommand(int); - word name(){return "runLiggghts";}; + word name() const {return "runLiggghts";} - void set(int); + void set(int); }; diff --git a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/writeLiggghts/writeLiggghts.C b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/writeLiggghts/writeLiggghts.C index 19547a66..1e0bd5a0 100644 --- a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/writeLiggghts/writeLiggghts.C +++ b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/writeLiggghts/writeLiggghts.C @@ -62,60 +62,61 @@ writeLiggghts::writeLiggghts ) : liggghtsCommandModel(dict,sm,i), - propsDict_(dict), + propsDict_(dict.subOrEmptyDict(typeName + "Props")), command_("write_restart"), path_(word("..")/word("DEM")), writeName_("liggghts.restartCFDEM"), - writeLast_(true), + writeLast_(propsDict_.lookupOrDefault("writeLast" ,true)), overwrite_(false) { - if (dict.found(typeName + "Props")) + // check if verbose + verbose_ = propsDict_.found("verbose"); + + if (propsDict_.found("path")) { - propsDict_=dictionary(dict.subDict(typeName + "Props")); - - // check if verbose - if (propsDict_.found("verbose")) verbose_=true; - - if(propsDict_.found("writeLast")) + path_ = fileName(propsDict_.lookup("path")); + if (!checkPath(path_)) { - writeLast_=Switch(propsDict_.lookup("writeLast")); + FatalError << "The path you provided in writeLiggghtsProps is incorrect: " << path_ << "\n" << abort(FatalError); } - - if (propsDict_.found("path")) + else { - path_=fileName(propsDict_.lookup("path")); - if (!checkPath(path_)) - FatalError<<"The path you provided in writeLiggghtsProps is incorrect: " << path_ << "\n" << abort(FatalError); - else - Info << "Using user defined path to write LIGGGHTS restart file: " << path_ << endl; - } - - if(propsDict_.found("writeName")) - { - propsDict_.lookup("writeName") >> writeName_; - } - - if (!writeLast_ && propsDict_.found("overwrite")) - { - overwrite_=Switch(propsDict_.lookup("overwrite")); + Info << "Using user defined path to write LIGGGHTS restart file: " << path_ << endl; } } - if(writeLast_) - runLast_=true; + + if (propsDict_.found("writeName")) + { + propsDict_.lookup("writeName") >> writeName_; + } + + if (!writeLast_ && propsDict_.found("overwrite")) + { + overwrite_ = Switch(propsDict_.lookup("overwrite")); + } + + if (writeLast_) + { + runLast_ = true; + } else { //Warning << "Using invalid options of writeLiggghts, please use 'writeLast' option." << endl; - runEveryWriteStep_=true; + runEveryWriteStep_ = true; } command_ += " " + path_ + "/" + writeName_; - if(overwrite_) + if (overwrite_) + { strCommand_=string(command_); + } else + { command_ += "_"; + } - Info << "writeLiggghts: A restart file writeName_"<< command_ <<" is written." << endl; + Info << "writeLiggghts: A restart file writeName_" << command_ << " is written." << endl; checkTimeSettings(dict_); } @@ -136,7 +137,7 @@ const char* writeLiggghts::command(int commandLine) bool writeLiggghts::runCommand(int couplingStep) { - if(!overwrite_) strCommand_=addTimeStamp(command_); + if (!overwrite_) strCommand_ = addTimeStamp(command_); return runThisCommand(couplingStep); } diff --git a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/writeLiggghts/writeLiggghts.H b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/writeLiggghts/writeLiggghts.H index c6e1fdc6..c7b59a40 100644 --- a/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/writeLiggghts/writeLiggghts.H +++ b/src/lagrangian/cfdemParticle/subModels/liggghtsCommandModel/writeLiggghts/writeLiggghts.H @@ -93,11 +93,11 @@ public: // Member Functions - const char* command(int); + const char* command(int); - bool runCommand(int); + bool runCommand(int); - word name(){return "writeLiggghts";}; + word name() const {return "writeLiggghts";} }; diff --git a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/explicitCouple/explicitCouple.C b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/explicitCouple/explicitCouple.C index da5238ac..ddf325fb 100644 --- a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/explicitCouple/explicitCouple.C +++ b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/explicitCouple/explicitCouple.C @@ -106,7 +106,7 @@ explicitCouple::~explicitCouple() // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -tmp explicitCouple::expMomSource() const +tmp explicitCouple::expMomSource() { const scalar tsf = particleCloud_.dataExchangeM().timeStepFraction(); @@ -136,7 +136,7 @@ tmp explicitCouple::expMomSource() const ); } -void explicitCouple::resetMomSourceField() const +void explicitCouple::resetMomSourceField() { fPrev_.ref() = fNext_.ref(); fNext_.primitiveFieldRef() = vector::zero; diff --git a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/explicitCouple/explicitCouple.H b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/explicitCouple/explicitCouple.H index 9ab43367..a343ae4e 100644 --- a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/explicitCouple/explicitCouple.H +++ b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/explicitCouple/explicitCouple.H @@ -58,9 +58,9 @@ private: dictionary propsDict_; - mutable volVectorField fPrev_; + volVectorField fPrev_; - mutable volVectorField fNext_; + volVectorField fNext_; vector fLimit_; // limit for for exchange field @@ -87,9 +87,9 @@ public: // Member Functions - tmp expMomSource() const; + tmp expMomSource(); - void resetMomSourceField() const; + void resetMomSourceField(); }; diff --git a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/implicitCouple/implicitCouple.C b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/implicitCouple/implicitCouple.C index fae64de7..9656eda8 100644 --- a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/implicitCouple/implicitCouple.C +++ b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/implicitCouple/implicitCouple.C @@ -120,7 +120,7 @@ implicitCouple::~implicitCouple() // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -tmp implicitCouple::impMomSource() const +tmp implicitCouple::impMomSource() { const scalar tsf = particleCloud_.dataExchangeM().timeStepFraction(); @@ -157,7 +157,7 @@ tmp implicitCouple::impMomSource() const ); } -void implicitCouple::resetMomSourceField() const +void implicitCouple::resetMomSourceField() { KslPrev_.ref() = KslNext_.ref(); KslNext_.primitiveFieldRef() = 0; diff --git a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/implicitCouple/implicitCouple.H b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/implicitCouple/implicitCouple.H index 209410c6..2ee1a8ca 100644 --- a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/implicitCouple/implicitCouple.H +++ b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/implicitCouple/implicitCouple.H @@ -73,9 +73,9 @@ private: scalar KslLimit_; // limit for for exchange field - mutable volScalarField KslPrev_; + volScalarField KslPrev_; - mutable volScalarField KslNext_; + volScalarField KslNext_; public: @@ -98,9 +98,9 @@ public: // Member Functions - tmp impMomSource() const; + tmp impMomSource(); - void resetMomSourceField() const; + void resetMomSourceField(); }; diff --git a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/momCoupleModel/momCoupleModel.C b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/momCoupleModel/momCoupleModel.C index 9478883a..9d6b4521 100644 --- a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/momCoupleModel/momCoupleModel.C +++ b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/momCoupleModel/momCoupleModel.C @@ -45,7 +45,7 @@ defineRunTimeSelectionTable(momCoupleModel, dictionary); // * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -tmp momCoupleModel::impMomSource() const +tmp momCoupleModel::impMomSource() { FatalError<<"the solver calls for impMomSource()\n" <<", please set 'momCoupleModel' to type 'implicitCouple'\n" @@ -55,7 +55,7 @@ tmp momCoupleModel::impMomSource() const return tsource; } -tmp momCoupleModel::expMomSource() const +tmp momCoupleModel::expMomSource() { FatalError<<"the solver calls for expMomSource()\n" <<", please set 'momCoupleModel' to type 'explicitCouple'\n" diff --git a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/momCoupleModel/momCoupleModel.H b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/momCoupleModel/momCoupleModel.H index 7e66ec7d..e1621957 100644 --- a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/momCoupleModel/momCoupleModel.H +++ b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/momCoupleModel/momCoupleModel.H @@ -111,12 +111,12 @@ public: // Member Functions // implicit momentum source field - virtual tmp impMomSource() const; + virtual tmp impMomSource(); // explicit momentum source field - virtual tmp expMomSource() const; + virtual tmp expMomSource(); - virtual void resetMomSourceField() const=0; + virtual void resetMomSourceField() = 0; virtual void setSourceField(volVectorField &) const; }; diff --git a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/noCouple/noCouple.C b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/noCouple/noCouple.C index ffd629ec..867b13c6 100644 --- a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/noCouple/noCouple.C +++ b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/noCouple/noCouple.C @@ -72,7 +72,7 @@ noCouple::~noCouple() // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -void noCouple::resetMomSourceField() const +void noCouple::resetMomSourceField() { FatalError<<"the solver calls for resetMomSourceField() although you use IB method where this is not needed!\n" <<", check your solver! - PANIC -\n"; diff --git a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/noCouple/noCouple.H b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/noCouple/noCouple.H index fb75ecb8..d2b65f4a 100644 --- a/src/lagrangian/cfdemParticle/subModels/momCoupleModel/noCouple/noCouple.H +++ b/src/lagrangian/cfdemParticle/subModels/momCoupleModel/noCouple/noCouple.H @@ -78,7 +78,7 @@ public: // Member Functions - void resetMomSourceField() const; + void resetMomSourceField(); }; diff --git a/src/lagrangian/cfdemParticle/subModels/probeModel/particleProbe/particleProbe.C b/src/lagrangian/cfdemParticle/subModels/probeModel/particleProbe/particleProbe.C index ca5bab6e..5a0441d9 100644 --- a/src/lagrangian/cfdemParticle/subModels/probeModel/particleProbe/particleProbe.C +++ b/src/lagrangian/cfdemParticle/subModels/probeModel/particleProbe/particleProbe.C @@ -68,32 +68,22 @@ particleProbe::particleProbe propsDict_(dict.subDict(typeName + "Props")), name_(typeName), particleCloud_(sm), - verbose_(false), - verboseToFile_(false), - writePrecision_(3), + verbose_(propsDict_.found("verbose")), + verboseToFile_(propsDict_.found("verboseToFile")), + writePrecision_(propsDict_.lookupOrDefault("writePrecision", 3)), dirName_("particleProbes"), rank_(-1), sPtr(NULL), - printEvery_(1), - sampleAll_(false), - probeDebug_(false), - includePosition_(false), + printEvery_(propsDict_.lookupOrDefault("printEvery", 1)), + sampleAll_(propsDict_.found("sampleAll")), + probeDebug_(propsDict_.found("probeDebug")), + includePosition_(propsDict_.found("includePosition")), particleIDsToSample_(propsDict_.lookup("particleIDsToSample")), itemCounter_(0), currItemId_(0), printCounter_(0), printNow_(false) { - if (propsDict_.found("verbose")) verbose_=true; - if (propsDict_.found("verboseToFile")) verboseToFile_=true; - - if (propsDict_.found("printEvery")) printEvery_ = readScalar(propsDict_.lookup("printEvery")); - if (propsDict_.found("sampleAll")) sampleAll_ = true; - if (propsDict_.found("probeDebug")) probeDebug_ = true; - if (propsDict_.found("includePosition")) includePosition_ = true; - - if (propsDict_.found("writePrecision")) writePrecision_ = readScalar(propsDict_.lookup("writePrecision")); - } // * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // diff --git a/src/lagrangian/cfdemParticle/subModels/probeModel/particleProbe/particleProbe.H b/src/lagrangian/cfdemParticle/subModels/probeModel/particleProbe/particleProbe.H index e840f790..2b632d33 100644 --- a/src/lagrangian/cfdemParticle/subModels/probeModel/particleProbe/particleProbe.H +++ b/src/lagrangian/cfdemParticle/subModels/probeModel/particleProbe/particleProbe.H @@ -67,11 +67,11 @@ private: cfdemCloud& particleCloud_; - bool verbose_; + const bool verbose_; - bool verboseToFile_; + const bool verboseToFile_; - int writePrecision_; + const int writePrecision_; word dirName_; @@ -79,13 +79,13 @@ private: mutable OFstream* sPtr; - int printEvery_; + const int printEvery_; - bool sampleAll_; + const bool sampleAll_; - bool probeDebug_; + const bool probeDebug_; - bool includePosition_; + const bool includePosition_; const labelList particleIDsToSample_; diff --git a/src/lagrangian/cfdemParticle/subModels/smoothingModel/constDiffSmoothing/constDiffSmoothing.C b/src/lagrangian/cfdemParticle/subModels/smoothingModel/constDiffSmoothing/constDiffSmoothing.C index dc739cc2..3f1f907e 100644 --- a/src/lagrangian/cfdemParticle/subModels/smoothingModel/constDiffSmoothing/constDiffSmoothing.C +++ b/src/lagrangian/cfdemParticle/subModels/smoothingModel/constDiffSmoothing/constDiffSmoothing.C @@ -65,17 +65,15 @@ constDiffSmoothing::constDiffSmoothing propsDict_(dict.subDict(typeName + "Props")), lowerLimit_(readScalar(propsDict_.lookup("lowerLimit"))), upperLimit_(readScalar(propsDict_.lookup("upperLimit"))), - smoothingLength_(dimensionedScalar("smoothingLength",dimensionSet(0,1,0,0,0,0,0), readScalar(propsDict_.lookup("smoothingLength")))), - smoothingLengthReferenceField_(dimensionedScalar("smoothingLengthReferenceField",dimensionSet(0,1,0,0,0,0,0), readScalar(propsDict_.lookup("smoothingLength")))), + smoothingLength_(dimensionedScalar("smoothingLength", dimLength, readScalar(propsDict_.lookup("smoothingLength")))), + smoothingLengthReferenceField_(dimensionedScalar("smoothingLengthReferenceField", dimLength, readScalar(propsDict_.lookup("smoothingLength")))), DT_("DT", dimensionSet(0,2,-1,0,0), 0.), - verbose_(false) + verbose_(propsDict_.found("verbose")) { - - if(propsDict_.found("verbose")) - verbose_ = true; - if(propsDict_.found("smoothingLengthReferenceField")) + { smoothingLengthReferenceField_.value() = double(readScalar(propsDict_.lookup("smoothingLengthReferenceField"))); + } checkFields(sSmoothField_); checkFields(vSmoothField_); diff --git a/src/lagrangian/cfdemParticle/subModels/smoothingModel/constDiffSmoothing/constDiffSmoothing.H b/src/lagrangian/cfdemParticle/subModels/smoothingModel/constDiffSmoothing/constDiffSmoothing.H index 2fc23eda..dd144aff 100644 --- a/src/lagrangian/cfdemParticle/subModels/smoothingModel/constDiffSmoothing/constDiffSmoothing.H +++ b/src/lagrangian/cfdemParticle/subModels/smoothingModel/constDiffSmoothing/constDiffSmoothing.H @@ -60,12 +60,12 @@ class constDiffSmoothing private: dictionary propsDict_; - scalar lowerLimit_; - scalar upperLimit_; - dimensionedScalar smoothingLength_; + const scalar lowerLimit_; + const scalar upperLimit_; + const dimensionedScalar smoothingLength_; dimensionedScalar smoothingLengthReferenceField_; mutable dimensionedScalar DT_; - bool verbose_; + const bool verbose_; public: diff --git a/src/lagrangian/cfdemParticle/subModels/smoothingModel/temporalSmoothing/temporalSmoothing.C b/src/lagrangian/cfdemParticle/subModels/smoothingModel/temporalSmoothing/temporalSmoothing.C new file mode 100644 index 00000000..5b9abaa3 --- /dev/null +++ b/src/lagrangian/cfdemParticle/subModels/smoothingModel/temporalSmoothing/temporalSmoothing.C @@ -0,0 +1,166 @@ +/*---------------------------------------------------------------------------*\ +License + + This 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. + + This code 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 this code. If not, see . + + Copyright (C) 2018- Mathias Vångö, JKU Linz, Austria + +\*---------------------------------------------------------------------------*/ + +#include "error.H" + +#include "temporalSmoothing.H" +#include "addToRunTimeSelectionTable.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + +// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // + +defineTypeNameAndDebug(temporalSmoothing, 0); + +addToRunTimeSelectionTable +( + smoothingModel, + temporalSmoothing, + dictionary +); + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +// Construct from components +temporalSmoothing::temporalSmoothing +( + const dictionary& dict, + cfdemCloud& sm +) +: + smoothingModel(dict,sm), + propsDict_(dict.subDict(typeName + "Props")), + lowerLimit_(readScalar(propsDict_.lookup("lowerLimit"))), + upperLimit_(readScalar(propsDict_.lookup("upperLimit"))), + verbose_(false), + refFieldName_(propsDict_.lookup("refField")), + gamma_(readScalar(propsDict_.lookup("gamma"))) +{ + + if(propsDict_.found("verbose")) + verbose_ = true; + + checkFields(sSmoothField_); + checkFields(vSmoothField_); +} + +// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // + +temporalSmoothing::~temporalSmoothing() +{} + +// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // +bool temporalSmoothing::doSmoothing() const +{ + return true; +} + + +void Foam::temporalSmoothing::smoothen(volScalarField& fieldSrc) const +{ + // Create scalar smooth field from virgin scalar smooth field template + volScalarField sSmoothField = sSmoothField_; + + sSmoothField.dimensions().reset(fieldSrc.dimensions()); + sSmoothField.ref()=fieldSrc.internalField(); + sSmoothField.correctBoundaryConditions(); + sSmoothField.oldTime().dimensions().reset(fieldSrc.dimensions()); + sSmoothField.oldTime()=fieldSrc; + sSmoothField.oldTime().correctBoundaryConditions(); + + volScalarField refField = particleCloud_.mesh().lookupObject(refFieldName_); + + // do smoothing + dimensionedScalar deltaT = sSmoothField.mesh().time().deltaT(); + solve + ( + fvm::ddt(sSmoothField) + - + gamma_/deltaT * (refField - fvm::Sp(1.0,sSmoothField)) + ); + + // bound sSmoothField_ + forAll(sSmoothField,cellI) + { + sSmoothField[cellI]=max(lowerLimit_,min(upperLimit_,sSmoothField[cellI])); + } + + // get data from working sSmoothField - will copy only values at new time + fieldSrc=sSmoothField; + fieldSrc.correctBoundaryConditions(); + + if(verbose_) + { + Info << "min/max(fieldoldTime) (unsmoothed): " << min(sSmoothField.oldTime()) << tab << max(sSmoothField.oldTime()) << endl; + Info << "min/max(fieldSrc): " << min(fieldSrc) << tab << max(fieldSrc) << endl; + Info << "min/max(fieldSrc.oldTime): " << min(fieldSrc.oldTime()) << tab << max(fieldSrc.oldTime()) << endl; + } + +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +void Foam::temporalSmoothing::smoothen(volVectorField& fieldSrc) const +{ + // Create scalar smooth field from virgin scalar smooth field template + volVectorField vSmoothField = vSmoothField_; + + vSmoothField.dimensions().reset(fieldSrc.dimensions()); + vSmoothField.ref()=fieldSrc.internalField(); + vSmoothField.correctBoundaryConditions(); + vSmoothField.oldTime().dimensions().reset(fieldSrc.dimensions()); + vSmoothField.oldTime()=fieldSrc; + vSmoothField.oldTime().correctBoundaryConditions(); + + volVectorField refField = particleCloud_.mesh().lookupObject(refFieldName_); + + dimensionedScalar deltaT = vSmoothField.mesh().time().deltaT(); + solve + ( + fvm::ddt(vSmoothField) + - + gamma_/deltaT * (refField - fvm::Sp(1.0,vSmoothField)) + ); + + // get data from working vSmoothField + fieldSrc=vSmoothField; + fieldSrc.correctBoundaryConditions(); + + if(verbose_) + { + Info << "min/max(fieldoldTime) (unsmoothed): " << min(vSmoothField.oldTime()) << tab << max(vSmoothField.oldTime()) << endl; + Info << "min/max(fieldSrc): " << min(fieldSrc) << tab << max(fieldSrc) << endl; + Info << "min/max(fieldSrc.oldTime): " << min(fieldSrc.oldTime()) << tab << max(fieldSrc.oldTime()) << endl; + } + +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +void Foam::temporalSmoothing::smoothenReferenceField(volVectorField& fieldSrc) const +{ + FatalError << "Smoothen reference field is not implemented for this smoothing model!" << abort(FatalError); +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// ************************************************************************* // diff --git a/src/lagrangian/cfdemParticle/subModels/energyModel/heatTransferGunnImplicit/heatTransferGunnImplicit.H b/src/lagrangian/cfdemParticle/subModels/smoothingModel/temporalSmoothing/temporalSmoothing.H similarity index 59% rename from src/lagrangian/cfdemParticle/subModels/energyModel/heatTransferGunnImplicit/heatTransferGunnImplicit.H rename to src/lagrangian/cfdemParticle/subModels/smoothingModel/temporalSmoothing/temporalSmoothing.H index edd99248..5b134c26 100644 --- a/src/lagrangian/cfdemParticle/subModels/energyModel/heatTransferGunnImplicit/heatTransferGunnImplicit.H +++ b/src/lagrangian/cfdemParticle/subModels/smoothingModel/temporalSmoothing/temporalSmoothing.H @@ -14,76 +14,77 @@ License You should have received a copy of the GNU General Public License along with this code. If not, see . - Copyright (C) 2015- Thomas Lichtenegger, JKU Linz, Austria - - Description - Correlation for Nusselt number according to - Gunn, D. J. International Journal of Heat and Mass Transfer 21.4 (1978) + Copyright (C) 2018- Mathias Vångö, JKU Linz, Austria +Class + temporalSmoothing + +Description + Smoothens a field using a temporal relaxation approach with a specified + reference field. + +SourceFiles + temporalSmoothing.C \*---------------------------------------------------------------------------*/ -#ifndef heatTransferGunnImplicit_H -#define heatTransferGunnImplicit_H +#ifndef temporalSmoothing_H +#define temporalSmoothing_H -#include "fvCFD.H" -#include "cfdemCloudEnergy.H" -#include "heatTransferGunn.H" +#include "smoothingModel.H" +//#include "wallFvPatch.H" // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // namespace Foam { /*---------------------------------------------------------------------------*\ - Class heatTransferGunnImplicit Declaration + Class temporalSmoothing Declaration \*---------------------------------------------------------------------------*/ -class heatTransferGunnImplicit +class temporalSmoothing : - public heatTransferGunn + public smoothingModel { + private: - - word QPartFluidCoeffName_; - - volScalarField QPartFluidCoeff_; - mutable double **partHeatFluxCoeff_; // Lagrangian array + dictionary propsDict_; + scalar lowerLimit_; + scalar upperLimit_; + bool verbose_; + word refFieldName_; + scalar gamma_; - void allocateMyArrays() const; - - void giveData(int); - - void heatFlux(label, scalar, scalar, scalar); - - void heatFluxCoeff(label, scalar, scalar); - public: //- Runtime type information - TypeName("heatTransferGunnImplicit"); + TypeName("temporalSmoothing"); + // Constructors //- Construct from components - heatTransferGunnImplicit + temporalSmoothing ( const dictionary& dict, - cfdemCloudEnergy& sm + cfdemCloud& sm ); - // Destructor - virtual ~heatTransferGunnImplicit(); + ~temporalSmoothing(); // Member Functions - - void addEnergyCoefficient(volScalarField&) const; - - void calcEnergyContribution(); - - void postFlow(); + bool doSmoothing() const; + + //void dSmoothing(volScalarField&) const; + + void smoothen(volScalarField&) const; + + void smoothen(volVectorField&) const; + + void smoothenReferenceField(volVectorField&) const; }; diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/GaussVoidFraction/GaussVoidFraction.C b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/GaussVoidFraction/GaussVoidFraction.C index 3db3e053..9a8c5a22 100644 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/GaussVoidFraction/GaussVoidFraction.C +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/GaussVoidFraction/GaussVoidFraction.C @@ -73,7 +73,7 @@ GaussVoidFraction::GaussVoidFraction //reading maxCellsPerParticle from dictionary maxCellsPerParticle_=readLabel(propsDict_.lookup("maxCellsPerParticle")); - if(alphaMin_ > 1 || alphaMin_ < 0.01){ FatalError<< "alphaMin shloud be > 1 and < 0.01." << abort(FatalError); } + if(alphaMin_ > 1 || alphaMin_ < 0.01) { FatalError << "alphaMin must have a value between 0.01 and 1.0." << abort(FatalError); } checkWeightNporosity(propsDict_); } @@ -87,7 +87,7 @@ GaussVoidFraction::~GaussVoidFraction() // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -void GaussVoidFraction::setvoidFraction(double** const& mask,double**& voidfractions,double**& particleWeights,double**& particleVolumes,double**& particleV) const +void GaussVoidFraction::setvoidFraction(double** const& mask,double**& voidfractions,double**& particleWeights,double**& particleVolumes,double**& particleV) { reAllocArrays(); diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/GaussVoidFraction/GaussVoidFraction.H b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/GaussVoidFraction/GaussVoidFraction.H index 535166ba..0a84508d 100644 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/GaussVoidFraction/GaussVoidFraction.H +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/GaussVoidFraction/GaussVoidFraction.H @@ -63,7 +63,7 @@ private: const scalar alphaMin_; //NP min value of voidFraction - mutable bool alphaLimited_; + bool alphaLimited_; public: @@ -86,7 +86,7 @@ public: // Member Functions - void setvoidFraction(double** const& ,double**&, double**&, double**&, double**&) const; + void setvoidFraction(double** const& ,double**&, double**&, double**&, double**&); void buildLabelHashSet ( diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/IBVoidFraction/IBVoidFraction.C b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/IBVoidFraction/IBVoidFraction.C index 4bfadbd0..fcc1947b 100755 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/IBVoidFraction/IBVoidFraction.C +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/IBVoidFraction/IBVoidFraction.C @@ -75,7 +75,7 @@ IBVoidFraction::IBVoidFraction if (scaleUpVol_ < 1.0) FatalError << "scaleUpVol shloud be > 1." << abort(FatalError); if (alphaMin_ > 1.0 || alphaMin_ < 0.01) - FatalError << "alphaMin shloud be > 1 and < 0.01." << abort(FatalError); + FatalError << "alphaMin must have a value between 0.01 and 1.0." << abort(FatalError); } @@ -87,7 +87,7 @@ IBVoidFraction::~IBVoidFraction() // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -void IBVoidFraction::setvoidFraction(double** const& mask,double**& voidfractions,double**& particleWeights,double**& particleVolumes,double**& particleV) const +void IBVoidFraction::setvoidFraction(double** const& mask,double**& voidfractions,double**& particleWeights,double**& particleVolumes,double**& particleV) { const boundBox& globalBb = particleCloud_.mesh().bounds(); @@ -306,7 +306,7 @@ void IBVoidFraction::buildLabelHashSet const label cellID, labelHashSet& hashSett, bool initialInsert //initial insertion of own cell -)const +) { if(initialInsert) hashSett.insert(cellID); diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/IBVoidFraction/IBVoidFraction.H b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/IBVoidFraction/IBVoidFraction.H index 0e430dc9..7f43e3f8 100755 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/IBVoidFraction/IBVoidFraction.H +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/IBVoidFraction/IBVoidFraction.H @@ -64,7 +64,7 @@ private: const scalar alphaMin_; //NP min value of voidFraction - mutable bool alphaLimited_; + bool alphaLimited_; const scalar scaleUpVol_; //NP scaling radius, keeping volume of particle @@ -91,7 +91,7 @@ public: // Member Functions - void setvoidFraction(double** const& ,double**&, double**&, double**&, double**&) const; + void setvoidFraction(double** const& ,double**&, double**&, double**&, double**&); void buildLabelHashSet ( @@ -100,7 +100,7 @@ public: const label cellID, labelHashSet& hashSett, bool initialInsert - ) const; + ); virtual double segmentParticleIntersection(int index, vector positionCenter, vector pointInside, vector pointOutside) const; }; diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/bigParticleVoidFraction/bigParticleVoidFraction.C b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/bigParticleVoidFraction/bigParticleVoidFraction.C index e7dc28bc..4d254b42 100644 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/bigParticleVoidFraction/bigParticleVoidFraction.C +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/bigParticleVoidFraction/bigParticleVoidFraction.C @@ -72,7 +72,7 @@ bigParticleVoidFraction::bigParticleVoidFraction Info << "\n\n W A R N I N G - this model does not yet work properly! \n\n" << endl; //reading maxCellsPerParticle from dictionary maxCellsPerParticle_=readLabel(propsDict_.lookup("maxCellsPerParticle")); - if(alphaMin_ > 1 || alphaMin_ < 0.01){ FatalError<< "alphaMin shloud be > 1 and < 0.01." << abort(FatalError); } + if(alphaMin_ > 1 || alphaMin_ < 0.01) { FatalError << "alphaMin must have a value between 0.01 and 1.0." << abort(FatalError); } checkWeightNporosity(propsDict_); } @@ -86,7 +86,7 @@ bigParticleVoidFraction::~bigParticleVoidFraction() // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -void bigParticleVoidFraction::setvoidFraction(double** const& mask,double**& voidfractions,double**& particleWeights,double**& particleVolumes,double**& particleV) const +void bigParticleVoidFraction::setvoidFraction(double** const& mask,double**& voidfractions,double**& particleWeights,double**& particleVolumes,double**& particleV) { reAllocArrays(); diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/bigParticleVoidFraction/bigParticleVoidFraction.H b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/bigParticleVoidFraction/bigParticleVoidFraction.H index 8e470a44..2875efb5 100644 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/bigParticleVoidFraction/bigParticleVoidFraction.H +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/bigParticleVoidFraction/bigParticleVoidFraction.H @@ -60,7 +60,7 @@ private: const scalar alphaMin_; // min value of voidFraction - mutable bool alphaLimited_; + bool alphaLimited_; public: @@ -83,7 +83,7 @@ public: // Member Functions - void setvoidFraction(double** const& ,double**&, double**&, double**&, double**&) const; + void setvoidFraction(double** const& ,double**&, double**&, double**&, double**&); void buildLabelHashSet ( diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/centreVoidFraction/centreVoidFraction.C b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/centreVoidFraction/centreVoidFraction.C index 6aa96bce..355211cc 100644 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/centreVoidFraction/centreVoidFraction.C +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/centreVoidFraction/centreVoidFraction.C @@ -78,7 +78,7 @@ centreVoidFraction::~centreVoidFraction() // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -void centreVoidFraction::setvoidFraction(double** const& mask,double**& voidfractions,double**& particleWeights,double**& particleVolumes,double**& particleV) const +void centreVoidFraction::setvoidFraction(double** const& mask,double**& voidfractions,double**& particleWeights,double**& particleVolumes,double**& particleV) { reAllocArrays(); diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/centreVoidFraction/centreVoidFraction.H b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/centreVoidFraction/centreVoidFraction.H index 15199923..bf6375ad 100644 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/centreVoidFraction/centreVoidFraction.H +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/centreVoidFraction/centreVoidFraction.H @@ -60,7 +60,7 @@ private: const scalar alphaMin_; //NP min value of voidFraction - mutable bool alphaLimited_; + bool alphaLimited_; public: @@ -83,7 +83,7 @@ public: // Member Functions - void setvoidFraction(double** const& ,double**&, double**&, double**&, double**&) const; + void setvoidFraction(double** const& ,double**&, double**&, double**&, double**&); }; diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/dividedVoidFraction/dividedVoidFraction.C b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/dividedVoidFraction/dividedVoidFraction.C index 6648d3c7..979bf064 100644 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/dividedVoidFraction/dividedVoidFraction.C +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/dividedVoidFraction/dividedVoidFraction.C @@ -64,36 +64,27 @@ dividedVoidFraction::dividedVoidFraction : voidFractionModel(dict,sm), propsDict_(dict.subDict(typeName + "Props")), - verbose_(false), + verbose_(propsDict_.found("verbose")), procBoundaryCorrection_(propsDict_.lookupOrDefault("procBoundaryCorrection", false)), alphaMin_(readScalar(propsDict_.lookup("alphaMin"))), alphaLimited_(0), tooMuch_(0.0), - interpolation_(false), - cfdemUseOnly_(false) + interpolation_(propsDict_.found("interpolation")), + cfdemUseOnly_(propsDict_.lookupOrDefault("cfdemUseOnly", false)) { maxCellsPerParticle_ = numberOfMarkerPoints; if (alphaMin_ > 1.0 || alphaMin_ < 0.01) Warning << "alphaMin should be < 1 and > 0.01 !!!" << endl; - if (propsDict_.found("interpolation")) + if (interpolation_) { - interpolation_ = true; Warning << "interpolation for dividedVoidFraction does not yet work correctly!" << endl; Info << "Using interpolated voidfraction field - do not use this in combination with interpolation in drag model!" << endl; } checkWeightNporosity(propsDict_); - if (propsDict_.found("verbose")) - verbose_ = true; - - if (propsDict_.found("cfdemUseOnly")) - { - cfdemUseOnly_ = readBool(propsDict_.lookup("cfdemUseOnly")); - } - if (procBoundaryCorrection_) { if (!(particleCloud_.locateM().type() == "engineIB")) @@ -165,7 +156,7 @@ dividedVoidFraction::~dividedVoidFraction() // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -void dividedVoidFraction::setvoidFraction(double** const& mask,double**& voidfractions,double**& particleWeights,double**& particleVolumes, double**& particleV) const +void dividedVoidFraction::setvoidFraction(double** const& mask,double**& voidfractions,double**& particleWeights,double**& particleVolumes, double**& particleV) { if (cfdemUseOnly_) reAllocArrays(particleCloud_.numberOfParticles()); diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/dividedVoidFraction/dividedVoidFraction.H b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/dividedVoidFraction/dividedVoidFraction.H index e14062fb..de8c5409 100644 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/dividedVoidFraction/dividedVoidFraction.H +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/dividedVoidFraction/dividedVoidFraction.H @@ -62,19 +62,19 @@ private: dictionary propsDict_; - bool verbose_; + const bool verbose_; - Switch procBoundaryCorrection_; + const Switch procBoundaryCorrection_; const scalar alphaMin_; // min value of voidFraction - mutable bool alphaLimited_; + bool alphaLimited_; - mutable scalar tooMuch_; // particle volume which is lost due to voidFraction limitation + scalar tooMuch_; // particle volume which is lost due to voidFraction limitation - bool interpolation_; + const bool interpolation_; - bool cfdemUseOnly_; + const bool cfdemUseOnly_; vector offsets[numberOfMarkerPoints]; @@ -104,7 +104,7 @@ public: // Member Functions - void setvoidFraction(double** const& ,double**&, double**&, double**&, double**&) const; + void setvoidFraction(double** const& ,double**&, double**&, double**&, double**&); }; diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/trilinearVoidFraction/trilinearVoidFraction.C b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/trilinearVoidFraction/trilinearVoidFraction.C index 8413532a..c43e3c9f 100644 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/trilinearVoidFraction/trilinearVoidFraction.C +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/trilinearVoidFraction/trilinearVoidFraction.C @@ -88,7 +88,7 @@ trilinearVoidFraction::~trilinearVoidFraction() // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -void trilinearVoidFraction::setvoidFraction(double** const& mask,double**& voidfractions,double**& particleWeights,double**& particleVolumes,double**& particleV) const +void trilinearVoidFraction::setvoidFraction(double** const& mask,double**& voidfractions,double**& particleWeights,double**& particleVolumes,double**& particleV) { reAllocArrays(); diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/trilinearVoidFraction/trilinearVoidFraction.H b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/trilinearVoidFraction/trilinearVoidFraction.H index 08a3bdd7..2a821fbe 100644 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/trilinearVoidFraction/trilinearVoidFraction.H +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/trilinearVoidFraction/trilinearVoidFraction.H @@ -88,7 +88,7 @@ public: // Member Functions - void setvoidFraction(double** const& ,double**&, double**&, double**&, double**&) const; + void setvoidFraction(double** const& ,double**&, double**&, double**&, double**&); }; diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/voidFractionModel/voidFractionModel.C b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/voidFractionModel/voidFractionModel.C index 424b8eef..b2e85c9e 100644 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/voidFractionModel/voidFractionModel.C +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/voidFractionModel/voidFractionModel.C @@ -112,7 +112,7 @@ tmp voidFractionModel::voidFractionInterp() const ); } -void voidFractionModel::resetVoidFractions() const +void voidFractionModel::resetVoidFractions() { voidfractionPrev_.ref() = voidfractionNext_.ref(); voidfractionNext_.ref() = 1.; @@ -128,7 +128,7 @@ int voidFractionModel::maxCellsPerParticle() const return maxCellsPerParticle_; } -void voidFractionModel::reAllocArrays() const +void voidFractionModel::reAllocArrays() { if(particleCloud_.numberOfParticlesChanged()) { @@ -137,7 +137,7 @@ void voidFractionModel::reAllocArrays() const } } -void voidFractionModel::reAllocArrays(int nP) const +void voidFractionModel::reAllocArrays(int nP) { if(particleCloud_.numberOfParticlesChanged()) { diff --git a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/voidFractionModel/voidFractionModel.H b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/voidFractionModel/voidFractionModel.H index 9a760b31..0f1a47d3 100644 --- a/src/lagrangian/cfdemParticle/subModels/voidFractionModel/voidFractionModel/voidFractionModel.H +++ b/src/lagrangian/cfdemParticle/subModels/voidFractionModel/voidFractionModel/voidFractionModel.H @@ -65,17 +65,17 @@ protected: bool multiWeights_; - mutable volScalarField voidfractionPrev_; + volScalarField voidfractionPrev_; - mutable volScalarField voidfractionNext_; + volScalarField voidfractionNext_; - mutable int ** cellsPerParticle_; + int ** cellsPerParticle_; int maxCellsPerParticle_; - mutable scalar weight_; + scalar weight_; - mutable scalar porosity_; + scalar porosity_; // Protected member functions @@ -124,30 +124,32 @@ public: // public member functions - virtual void setvoidFraction(double** const&,double**&,double**&,double**&,double**&) const = 0; + virtual void setvoidFraction(double** const&,double**&,double**&,double**&,double**&) = 0; tmp voidFractionInterp() const; - inline volScalarField& voidFractionPrev()const { return voidfractionPrev_; } + volScalarField& voidFractionPrev() { return voidfractionPrev_; } + const volScalarField& voidFractionPrev() const { return voidfractionPrev_; } - inline volScalarField& voidFractionNext()const { return voidfractionNext_; } + volScalarField& voidFractionNext() { return voidfractionNext_; } + const volScalarField& voidFractionNext() const { return voidfractionNext_; } - inline scalar weight()const { return weight_; } + scalar weight() const { return weight_; } - inline scalar weight(label index) const + scalar weight(label index) const { return particleCloud_.particleEffVolFactor(index); } - inline scalar porosity()const { return porosity_; } + scalar porosity() const { return porosity_; } - inline void checkWeightNporosity(dictionary& propsDict) const + void checkWeightNporosity(dictionary& propsDict) { if (propsDict.found("weight")) weight_ = readScalar(propsDict.lookup("weight")); if (propsDict.found("porosity")) porosity_ = readScalar(propsDict.lookup("porosity")); } - void resetVoidFractions() const; + void resetVoidFractions(); //void undoVoidFractions(double**const&) const; @@ -155,9 +157,9 @@ public: int maxCellsPerParticle() const; - void reAllocArrays() const; + void reAllocArrays(); - void reAllocArrays(int nP) const; //force number of particles during reallocation, for CFD offline-use + void reAllocArrays(int nP); //force number of particles during reallocation, for CFD offline-use virtual void setParticleType(label type) const {} diff --git a/tutorials/cfdemSolverMultiphase/damBreak/Allclean.sh b/tutorials/cfdemSolverMultiphase/damBreak/Allclean.sh new file mode 100755 index 00000000..525587d4 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/Allclean.sh @@ -0,0 +1,22 @@ +#!/bin/bash + +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" + +#- clean up case +echo "deleting data at: $casePath :\n" +source $WM_PROJECT_DIR/bin/tools/CleanFunctions +cd $casePath/CFD +cleanCase +rm -r $casePath/CFD/clockData +rm $casePath/DEM/post/*.* +touch $casePath/DEM/post/.gitignore +rm -r $casePath/CFD/0 +rm $casePath/log* + +echo "Remove restart file?" +echo "Enter: yes, Ctrl + C: no" +read + +rm $casePath/DEM/post/restart/*.* +rm $casePath/DEM/post/restart/liggghts.restartCFDEM* diff --git a/tutorials/cfdemSolverMultiphase/damBreak/Allrun.sh b/tutorials/cfdemSolverMultiphase/damBreak/Allrun.sh new file mode 100755 index 00000000..6b9b4e2d --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/Allrun.sh @@ -0,0 +1,35 @@ +#!/bin/bash + +#===================================================================# +# Allrun script for cfdemSolverMultiphase +#===================================================================# + +#- define variables +postProcessing=false #true +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" + +# check if mesh was built +if [ -f "$casePath/CFD/constant/polyMesh/points" ]; then + echo "mesh was built before - using old mesh" +else + echo "mesh needs to be built" + cd $casePath/CFD + blockMesh +fi + +cd $casePath/CFD +cp -r 0.org 0 +setFields + +if [ -f "$casePath/DEM/post/restart/liggghts.restart" ]; then + echo "LIGGGHTS init was run before - using existing restart file" +else + #- run DEM in new terminal + $casePath/parDEMrun.sh +fi + +bash $casePath/parCFDDEMrun.sh + +if [ "$postProcessing" = true ]; then + bash $casePath/postrun.sh +fi diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/Ksl b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/Ksl new file mode 100644 index 00000000..2d0d2d3d --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/Ksl @@ -0,0 +1,47 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object Ksl; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 -3 -1 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type zeroGradient; + //type fixedValue; + //value uniform 0; + } +/* outlet + { + type zeroGradient; + } + frontAndBack + { + type empty; + } +*/ + atmosphere + { + type zeroGradient; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/U b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/U new file mode 100644 index 00000000..6817d47e --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/U @@ -0,0 +1,52 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.x | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volVectorField; + location "0"; + object U; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -1 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + atmosphere + { + type fixedValue; + value uniform (0 0 0); + } +/* frontAndBack + { + type empty; + } + + outlet + { + //type zeroGradient; + + type inletOutlet; + inletValue uniform (0 0 0); + value uniform (0 0 0); + + } + */ + walls + { + type fixedValue; + value uniform (0 0 0); + } +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/Us b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/Us new file mode 100644 index 00000000..996c4974 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/Us @@ -0,0 +1,50 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volVectorField; + location "0"; + object Us; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -1 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + walls + { + type zeroGradient; + //type fixedValue; + //value uniform (1 0 0); + } +/* outlet + { + type zeroGradient; + //type fixedValue; + //value uniform (1 0 0);; + } +*/ + atmosphere + { + type zeroGradient; + } + +/* frontAndBack + { + type empty; + } +*/ +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/alpha.air b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/alpha.air new file mode 100644 index 00000000..b5595fc3 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/alpha.air @@ -0,0 +1,59 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object alpha.air; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type alphaContactAngle; + thetaProperties + ( + ( water air ) 90 0 0 0 + + ); + value uniform 0; + } + atmosphere + { + type alphaContactAngle; + thetaProperties + ( + ( water air ) 90 0 0 0 + + ); + value uniform 0; + } +/* outlet + { + //type zeroGradient; + type inletOutlet; + inletValue uniform 1; + value uniform 1; + } + frontAndBack + { + type empty; + } +*/ +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/alpha.water b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/alpha.water new file mode 100644 index 00000000..a8b310c8 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/alpha.water @@ -0,0 +1,47 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object alpha.water; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type zeroGradient; + } +/* outlet + { + //type zeroGradient; + type inletOutlet; + inletValue uniform 0; + value uniform 0; + } + frontAndBack + { + type empty; + } +*/ + atmosphere + { + type zeroGradient; //fixedValue; + //value uniform 0; + } +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/alphas b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/alphas new file mode 100644 index 00000000..34caed99 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/alphas @@ -0,0 +1,45 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.x | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object alphas; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ +/* outlet + { + type zeroGradient; + } + frontAndBack + { + type empty; + } +*/ + walls + { + type zeroGradient; + } + atmosphere + { + type zeroGradient; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/epsilon b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/epsilon new file mode 100644 index 00000000..ab29b736 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/epsilon @@ -0,0 +1,52 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object epsilon; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 2 -3 0 0 0 0]; + +internalField uniform 0.003; + +boundaryField +{ + walls + { + type epsilonWallFunction; + Cmu 0.09; + kappa 0.41; + E 9.8; + value uniform 0.003; + } + outlet + { + type inletOutlet; + inletValue uniform 0.003; + value uniform 0.003; + } +/* frontAndBack + { + type empty; + } +*/ + atmosphere + { + type fixedValue; + value uniform 0.003; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/k b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/k new file mode 100644 index 00000000..3347d063 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/k @@ -0,0 +1,48 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object k; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 2 -2 0 0 0 0]; + +internalField uniform 0.001; + +boundaryField +{ + walls + { + type kqRWallFunction; + value uniform 0.001; + } + outlet + { + type inletOutlet; + inletValue uniform 0.001; + value uniform 0.001; + } +/* frontAndBack + { + type empty; + } +*/ + atmosphere + { + type fixedValue; + value uniform 0.001; + } +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/nut b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/nut new file mode 100644 index 00000000..8edd2719 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/nut @@ -0,0 +1,51 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object nut; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 2 -1 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type nutWallFunction; + Cmu 0.09; + kappa 0.41; + E 9.8; + value uniform 0; + } + + outlet + { + type calculated; + value uniform 0; + } +/* frontAndBack + { + type empty; + } +*/ + atmosphere + { + type calculated; + value uniform 0; + } +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/p_rgh b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/p_rgh new file mode 100644 index 00000000..f044e615 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/p_rgh @@ -0,0 +1,48 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + object p_rgh; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 -1 -2 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + + walls + { + type fixedFluxPressure; + value uniform 0; + } + +/* outlet + { + type fixedValue; + value uniform 0; + } +*/ + atmosphere + { + type fixedValue; + value uniform 0; + } +/* frontAndBack + { + type empty; + } +*/ +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/sSmoothField b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/sSmoothField new file mode 100644 index 00000000..df22fd91 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/sSmoothField @@ -0,0 +1,45 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + object sSmoothField; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + + walls + { + type zeroGradient; + } + +/* outlet + { + type zeroGradient; + } + frontAndBack + { + type empty; + } +*/ + atmosphere + { + type zeroGradient; + } + +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/vSmoothField b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/vSmoothField new file mode 100644 index 00000000..6bf85d8d --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/vSmoothField @@ -0,0 +1,45 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volVectorField; + object vSmoothField; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 0 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + + walls + { + type zeroGradient; + } + +/* outlet + { + type zeroGradient; + } + frontAndBack + { + type empty; + } +*/ + atmosphere + { + type zeroGradient; + } + +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/voidfraction b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/voidfraction new file mode 100644 index 00000000..2a99d9ae --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/0.org/voidfraction @@ -0,0 +1,48 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object voidfraction; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 1; + +boundaryField +{ + walls + { + type zeroGradient; + } +/* outlet + { + type fixedValue; + value uniform 1; + } +*/ + atmosphere + { + type zeroGradient; //fixedValue; + //value uniform 1; + } +/* frontAndBack + { + type empty; + } +*/ + +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/couplingProperties b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/couplingProperties new file mode 100644 index 00000000..f6a59a36 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/couplingProperties @@ -0,0 +1,281 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.4 | +| \\ / A nd | Web: http://www.openfoam.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ + + +FoamFile +{ + version 2.0; + format ascii; + + root ""; + case ""; + instance ""; + local ""; + + class dictionary; + object couplingProperties; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +//===========================================================================// +// sub-models & settings + +syncMode false; +//verbose; +useDDTvoidfraction; + +modelType "A"; // A or B + +couplingInterval 50; + +voidFractionModel divided;//centre;// + +locateModel engine;//turboEngineM2M;// + +meshMotionModel noMeshMotion; + +regionModel allRegion; + +IOModel basicIO; + +probeModel off; + +dataExchangeModel twoWayMPI;//twoWayFiles;//twoWayM2M;//oneWayVTK;// + +averagingModel dense;//dilute;// + +clockModel standardClock;//off; + +smoothingModel constDiffSmoothing; //off;// localPSizeDiffSmoothing;// constDiffSmoothing; // + +forceModels +( + //GidaspowDrag + //BeetstraDrag + //DiFeliceDrag + gradPForce + viscForce + KochHillDrag + //interface + //DEMbasedDrag + //RongDrag + //Archimedes + //volWeightedAverage + //totalMomentumExchange + //particleCellVolume + //fieldTimeAverage + surfaceTensionForce +); + +momCoupleModels +( + implicitCouple +); + +turbulenceModelType "turbulenceProperties"; //"RASProperties";//"LESProperties";// + +//===========================================================================// +// sub-model properties + +localPSizeDiffSmoothingProps +{ + lowerLimit 0.1; + upperLimit 1e10; + dSmoothingLength 1.5e-3; + Csmoothing 1.0; +} + +constDiffSmoothingProps +{ + lowerLimit 0.1; + upperLimit 1e10; + smoothingLength 5e-3; +} + +implicitCoupleProps +{ + velFieldName "U"; + granVelFieldName "Us"; + voidfractionFieldName "voidfraction"; +} + +ArchimedesProps +{ + gravityFieldName "g"; +} +gradPForceProps +{ + pFieldName "p"; + voidfractionFieldName "voidfraction"; + velocityFieldName "U"; + interpolation true; +} + +viscForceProps +{ + velocityFieldName "U"; + interpolation false; + verbose true; +} +volWeightedAverageProps +{ + scalarFieldNames + ( + voidfraction + ); + vectorFieldNames + ( + ); + upperThreshold 0.999; + lowerThreshold 0; + verbose true; +} +totalMomentumExchangeProps +{ + implicitMomExFieldName "Ksl"; + explicitMomExFieldName "none"; + fluidVelFieldName "U"; + granVelFieldName "Us"; +} +GidaspowDragProps +{ + verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + interpolation true; + phi 1; +} +DEMbasedDragProps +{ + velFieldName "U"; + voidfractionFieldName "voidfraction"; +} + +DiFeliceDragProps +{ + //verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + granVelFieldName "Us"; + interpolation true; +} + +KochHillDragProps +{ + //verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + interpolation true; + //forceSubModels + //( + // ImExCorr + //); + implForceDEM true; + //implForceDEMaccumulated true; + //explicitCorr true; +} + +BeetstraDragProps +{ + velFieldName "U"; + gravityFieldName "g"; + rhoParticle 2000.; + voidfractionFieldName "voidfraction"; + interpolation ; + useFilteredDragModel ; + useParcelSizeDependentFilteredDrag ; + k 0.05; + aLimit 0.0; +// verbose true; +} + +RongDragProps +{ + verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + interpolation true; + implForceDEM true; + implForceDEMaccumulated true; + granVelFieldName "Us"; +} + +virtualMassForceProps +{ + velFieldName "U"; +} + +particleCellVolumeProps +{ + upperThreshold 0.999; + lowerThreshold 0.; + verbose true; +} + +fieldStoreProps +{ + scalarFieldNames + ( + ); + + vectorFieldNames + ( + "U" + ); +} + +oneWayVTKProps +{ + couplingFilename "vtk_out%4.4d.vtk"; + maxNumberOfParticles 30000; +} + +twoWayFilesProps +{ + maxNumberOfParticles 10100; +} + +centreProps +{ + alphaMin 0.1; +} + +engineProps +{ + treeSearch true; +} + +turboEngineM2MProps +{ + turboEngineProps + { + treeSearch true; + } +} + +dividedProps +{ + alphaMin 0.01; + scaleUpVol 1.0; +} + +twoWayMPIProps +{ + liggghtsPath "../DEM/in.liggghts_run"; +} +twoWayM2MProps +{ + maxNumberOfParticles 10100; + liggghtsPath "../DEM/in.liggghts_run"; +} + +surfaceTensionForceProps +{ +} +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/g b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/g new file mode 100644 index 00000000..317bdd50 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/g @@ -0,0 +1,22 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class uniformDimensionedVectorField; + location "constant"; + object g; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -2 0 0 0 0]; +value ( 0 0 -9.81 ); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/liggghtsCommands b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/liggghtsCommands new file mode 100644 index 00000000..d9e1ce81 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/liggghtsCommands @@ -0,0 +1,43 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.4 | +| \\ / A nd | Web: http://www.openfoam.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ + + +FoamFile +{ + version 2.0; + format ascii; + + root ""; + case ""; + instance ""; + local ""; + + class dictionary; + object liggghtsCommands; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +liggghtsCommandModels +( + runLiggghts + writeLiggghts +); +// ************************************************************************* // + +/*runLiggghtsProps +{ + preNo false; +}*/ + +writeLiggghtsProps +{ + writeLast off; + writeName "post/restart/liggghts.restartCFDEM"; + overwrite on; +} diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/motionProperties b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/motionProperties new file mode 100644 index 00000000..d96a5705 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/motionProperties @@ -0,0 +1,21 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 4.x | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object motionProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +movingFvMesh staticFvMesh; + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/transportProperties b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/transportProperties new file mode 100644 index 00000000..bae5857c --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/transportProperties @@ -0,0 +1,53 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object transportProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +phases +( + water + { + transportModel Newtonian; + nu nu [ 0 2 -1 0 0 0 0 ] 1e-06; + rho rho [ 1 -3 0 0 0 0 0 ] 1000; + } +/* + oil + { + transportModel Newtonian; + nu nu [ 0 2 -1 0 0 0 0 ] 1e-06; + rho rho [ 1 -3 0 0 0 0 0 ] 500; + } +*/ + air + { + transportModel Newtonian; + nu nu [ 0 2 -1 0 0 0 0 ] 1e-05; + rho rho [ 1 -3 0 0 0 0 0 ] 1; //100; +// nu nu [ 0 2 -1 0 0 0 0 ] 1.48e-05; +// rho rho [ 1 -3 0 0 0 0 0 ] 1; + } +); + +sigmas +( +// (water oil) 0.07 + (air water) 0.07 +// (air oil) 0.07 + +); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/transportProperties_temp b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/transportProperties_temp new file mode 100644 index 00000000..1e803628 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/transportProperties_temp @@ -0,0 +1,37 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object transportProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +transportModel Newtonian; + +nu nu [ 0 2 -1 0 0 0 0 ] 1.5e-04; + +CrossPowerLawCoeffs +{ + nu0 nu0 [ 0 2 -1 0 0 0 0 ] 1e-06; + nuInf nuInf [ 0 2 -1 0 0 0 0 ] 1e-06; + m m [ 0 0 1 0 0 0 0 ] 1; + n n [ 0 0 0 0 0 0 0 ] 1; +} + +BirdCarreauCoeffs +{ + nu0 nu0 [ 0 2 -1 0 0 0 0 ] 1e-06; + nuInf nuInf [ 0 2 -1 0 0 0 0 ] 1e-06; + k k [ 0 0 1 0 0 0 0 ] 0; + n n [ 0 0 0 0 0 0 0 ] 1; +} +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/turbulenceProperties b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/turbulenceProperties new file mode 100644 index 00000000..c09c9524 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/constant/turbulenceProperties @@ -0,0 +1,30 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object turbulenceProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +simulationType laminar; //RAS; + +RAS +{ + RASModel laminar; + + turbulence off; + + printCoeffs on; +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/blockMeshDict b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/blockMeshDict new file mode 100644 index 00000000..19527945 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/blockMeshDict @@ -0,0 +1,110 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.0 | +| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ +version 2.0; +format ascii; +class dictionary; +object blockMeshDict; +} +// ************************************ + + + + + + + meshGenApp blockMesh; + convertToMeters 0.01; + + //64 mm column diameter + //15 cm length + + + + //Width of middle square section + + + + + //how many cells in the square section + //how many cells from square section to perimeter + // how many cells from top to bottom + + vertices + ( + (0 0 0) + (20 0 0) + (20 10 0) + (0 10 0) + (0 0 30) + (20 0 30) + (20 10 30) + (0 10 30) + ); + + blocks + ( + hex (0 1 2 3 4 5 6 7) (40 20 60) simpleGrading (1 1 1) + ); + + edges + ( + ); + + boundary + ( + atmosphere + { + type patch; + faces + ( + (4 5 6 7) + ); + } +/* frontAndBack + { + type empty; + faces + ( + (0 1 5 4) + (4 5 9 8) + (8 9 13 12) + (3 7 6 2) + (7 11 10 6) + (11 15 14 10) + + ); + } + + outlet + { + type patch; + faces + ( + (5 6 10 9) + ); + } +*/ + walls + { + type wall; + faces + ( + (0 3 2 1) + (0 4 7 3) + (3 7 6 2) + (1 2 6 5) + (0 1 5 4) + ); + } +); + +mergePatchPairs +( +); diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/controlDict b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/controlDict new file mode 100644 index 00000000..879abbbf --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/controlDict @@ -0,0 +1,55 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object controlDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +application pisoFoam; + +startFrom startTime; + +startTime 0; + +stopAt endTime; + +endTime 1.5; + +deltaT 0.0005; + +writeControl adjustableRunTime; + +writeInterval 0.1; + +purgeWrite 0; + +writeFormat ascii; + +writePrecision 6; + +writeCompression uncompressed; + +timeFormat general; + +timePrecision 6; + +runTimeModifiable yes; + +adjustTimeStep no; + +maxCo 0.1; +maxAlphaCo 0.1; + + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/controlDict.foam b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/controlDict.foam new file mode 100644 index 00000000..7493598b --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/controlDict.foam @@ -0,0 +1,117 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object controlDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +application pisoFoam; + +startFrom startTime; + +startTime 0; + +stopAt endTime; + +endTime 0.1;//0.01; + +deltaT 0.001; + +writeControl adjustableRunTime; + +writeInterval 0.001;//0.01; + +purgeWrite 0; + +writeFormat ascii; + +writePrecision 6; + +writeCompression uncompressed; + +timeFormat general; + +timePrecision 6; + +runTimeModifiable yes; + +adjustTimeStep no; + +maxCo 0.1; + +libs ("libOpenFOAM.so" "libgroovyBC.so"); + +functions +( + + probes + { + type probes; + // Where to load it from + functionObjectLibs ( "libsampling.so" ); + // Name of the directory for probe data + name probes; + probeLocations + ( + (0 0 0.0001) + (0 0 0.0026) + (0 0 0.0051) + (0 0 0.0076) + (0 0 0.0101) + (0 0 0.0126) + (0 0 0.0151) + (0 0 0.0176) + (0 0 0.0201) + (0 0 0.0226) + (0 0 0.0251) + (0 0 0.0276) + (0 0 0.0301) + (0 0 0.0326) + (0 0 0.0351) + (0 0 0.0375) + (0 0 0.0401) + (0 0 0.0426) + (0 0 0.0451) + (0 0 0.0476) + (0 0 0.0529) + ); + + // Fields to be probed + fields ( p U voidfraction volAverage_voidfraction); + + // Write at same frequency as fields + outputControl timeStep;//outputTime; + outputInterval 1; + } + + /*pressureDrop + { + type patchAverage; + functionObjectLibs + ( + "libsimpleFunctionObjects.so" + ); + verbose true; + patches + ( + inlet + outlet + ); + fields + ( + p + ); + factor 1; + }*/ +); +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/decomposeParDict b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/decomposeParDict new file mode 100644 index 00000000..4de14078 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/decomposeParDict @@ -0,0 +1,86 @@ +/*-------------------------------*- C++ -*---------------------------------*\ +| ========= | +| \\ / OpenFOAM | +| \\ / | +| \\ / The Open Source CFD Toolbox | +| \\/ http://www.OpenFOAM.org | +\*-------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + note "mesh decomposition control dictionary"; + location "system"; + object decomposeParDict; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +numberOfSubdomains 4; + +//- Keep owner and neighbour on same processor for faces in zones: +// preserveFaceZones (heater solid1 solid3); + +//method scotch; +// method hierarchical; + method simple; +// method metis; +// method manual; + +simpleCoeffs +{ + n (2 2 1); + delta 0.001; +} + +hierarchicalCoeffs +{ + n (2 2 1); + delta 0.001; + order xyz; +} + +metisCoeffs +{ + /* + processorWeights + ( + 1 + 1 + 1 + 1 + ); + */ +} + +scotchCoeffs +{ + //processorWeights + //( + // 1 + // 1 + // 1 + // 1 + //); + //writeGraph true; + //strategy "b"; +} + +manualCoeffs +{ + dataFile "decompositionData"; +} + + +//// Is the case distributed +//distributed yes; +//// Per slave (so nProcs-1 entries) the directory above the case. +//roots +//( +// "/tmp" +// "/tmp" +//); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/funkySetFieldsDict b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/funkySetFieldsDict new file mode 100644 index 00000000..39414dd5 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/funkySetFieldsDict @@ -0,0 +1,33 @@ +FoamFile +{ + version 2.0; + format ascii; + + root "/.automount/werner/Werner/bgschaid/bgschaid-foamStuff/DepositionTests"; + case "neutralTest"; + instance "system"; + local ""; + + class dictionary; + object funkySetFieldsDict; +} + +expressions +( + init + { + field voidfraction; + expression "1"; + valuePatches 2(inlet outlet); // set value 1 at those patches + } + setGamma + { + field voidfraction; + expression "0.43"; + //condition "pow(pow(pos().x-0.2,2) + pow(pos().y-0,2)+ pow(pos().z-0,2),0.5) < 0.04"; + condition "pos().z < 0.01467 && pos().z > 0.0"; + keepPatches true; + //valuePatches 1(inlet); // set value 1 at those patches + } + +); diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/fvSchemes b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/fvSchemes new file mode 100644 index 00000000..4d2ff463 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/fvSchemes @@ -0,0 +1,68 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSchemes; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +ddtSchemes +{ + default Euler; +} + +gradSchemes +{ + default Gauss linear; + grad(U) Gauss linear; + grad(gamma) Gauss linear; +} + +divSchemes +{ + div(rhoPhi,U) Gauss upwind; + div(phi,alpha) Gauss vanLeer; + div(phirb,alpha) Gauss linear; + div((muEff*dev(T(grad(U))))) Gauss linear; + div((viscousTerm*dev2(grad(U).T()))) Gauss linear; + div(((grad(U)*rho)*dev(grad(U).T()))) Gauss linear; + div(((dev(grad(U).T())*rho)*dev(grad(U).T()))) Gauss linear; + div((((((alpha.water*rho)*nu.water)|(alpha.water*rho))*rho)*dev(grad(U).T()))) Gauss linear; + div(((nu*rho)*dev(grad(U).T()))) Gauss linear; + default Gauss linear; +} + +laplacianSchemes +{ + default Gauss linear corrected; +} + +interpolationSchemes +{ + default linear; +} + +snGradSchemes +{ + default corrected; +} + +fluxRequired +{ + default no; + pcorr; + p_rgh; + "alpha.*"; +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/fvSchemes.org b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/fvSchemes.org new file mode 100644 index 00000000..fac85f68 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/fvSchemes.org @@ -0,0 +1,76 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSchemes; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +ddtSchemes +{ + default Euler; +} + +gradSchemes +{ + default Gauss linear; + grad(p) Gauss linear; + grad(U) Gauss linear; +} + +divSchemes +{ + default Gauss linear; + div(phi,U) Gauss limitedLinearV 1; + div(phi,k) Gauss limitedLinear 1; + div(phi,epsilon) Gauss limitedLinear 1; + div(phi,R) Gauss limitedLinear 1; + div(R) Gauss linear; + div(phi,nuTilda) Gauss limitedLinear 1; + div((viscousTerm*dev(grad(U).T()))) Gauss linear; + div((nu*dev(grad(U).T()))) Gauss linear; + div((nuEff*dev(grad(U).T()))) Gauss linear; +} + +laplacianSchemes +{ + default Gauss linear corrected; + laplacian(viscousTerm,U) Gauss linear corrected; + laplacian(nu,U) Gauss linear corrected; + laplacian(nuEff,U) Gauss linear corrected; + laplacian((1|A(U)),p) Gauss linear corrected; + laplacian((voidfraction2|A(U)),p) Gauss linear corrected; + laplacian(DkEff,k) Gauss linear corrected; + laplacian(DepsilonEff,epsilon) Gauss linear corrected; + laplacian(DREff,R) Gauss linear corrected; + laplacian(DnuTildaEff,nuTilda) Gauss linear corrected; +} + +interpolationSchemes +{ + default linear; + interpolate(U) linear; +} + +snGradSchemes +{ + default corrected; +} + +fluxRequired +{ + default no; + p ; +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/fvSolution b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/fvSolution new file mode 100644 index 00000000..6907a786 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/fvSolution @@ -0,0 +1,138 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSolution; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +solvers +{ + "alpha.*" + { + nAlphaSubCycles 1; + cAlpha 1; + } + + pcorr + { + solver PCG; + preconditioner + { + preconditioner GAMG; + tolerance 1e-05; + relTol 0; + smoother GaussSeidel; + nPreSweeps 0; + nPostSweeps 2; + nFinestSweeps 2; + cacheAgglomeration on; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + } + tolerance 1e-05; + relTol 0; + maxIter 100; + } + + p_rgh + { + solver GAMG; + tolerance 1e-07; + relTol 0.05; + smoother GaussSeidel; + nPreSweeps 0; + nPostSweeps 2; + nFinestSweeps 2; + cacheAgglomeration on; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + } + + p_rghFinal + { + solver PCG; + preconditioner + { + preconditioner GAMG; + tolerance 1e-07; + relTol 0; + nVcycles 2; + smoother GaussSeidel; + nPreSweeps 0; + nPostSweeps 2; + nFinestSweeps 2; + cacheAgglomeration on; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + } + tolerance 1e-07; + relTol 0; + maxIter 20; + } + + "(k|epsilon|R|nuTilda)" + { + solver smoothSolver; + smoother GaussSeidel; + tolerance 1e-9; + relTol 0; + nSweeps 1; + } + + "(voidfraction|Us|Ksl|sSmoothField|vSmoothField|UsNext|voidfractionNext)" + { + solver PCG; + preconditioner DIC; + tolerance 1e-05; + relTol 0; + } + + U + { + solver smoothSolver; + smoother GaussSeidel; + tolerance 1e-08; + relTol 0.1; + nSweeps 1; + } + + UFinal + { + $U; + tolerance 1e-08; + relTol 0; + } + +} + +PIMPLE +{ + nCorrectors 2; + nNonOrthogonalCorrectors 0; +} + +relaxationFactors +{ + fields + { + } + equations + { + "U.*" 1; + } +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/fvSolution.org b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/fvSolution.org new file mode 100644 index 00000000..d6fb7a2b --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/fvSolution.org @@ -0,0 +1,62 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSolution; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +solvers +{ + "(p)" + { + solver PCG; + preconditioner DIC; + tolerance 1e-06; + relTol 0.1; + } + + pFinal + { + solver PCG; + preconditioner DIC; + tolerance 1e-06; + relTol 0; + } + + "(U|k|epsilon|R|nuTilda)" + { + solver PBiCG; + preconditioner DILU; + tolerance 1e-05; + relTol 0; + } + + "(voidfraction|Us|Ksl|dSmoothing|UsNext|voidfractionNext)" + { + solver PCG; + preconditioner DIC; + tolerance 1e-05; + relTol 0; + } +} + +PISO +{ + nCorrectors 4; + nNonOrthogonalCorrectors 1; + pRefCell 0; + pRefValue 0; +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/setFieldsDict b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/setFieldsDict new file mode 100644 index 00000000..f38b704c --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/CFD/system/setFieldsDict @@ -0,0 +1,41 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object setFieldsDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +defaultFieldValues +( + volScalarFieldValue alpha.air 1 + volScalarFieldValue alpha.water 0 +// volScalarFieldValue alpha.oil 0 +// volScalarFieldValue alpha.mercury 0 + volVectorFieldValue U ( 0 0 0 ) +); + +regions +( + boxToCell + { + box ( 0.15 0 0 ) ( 0.2 0.1 0.1 ); + fieldValues + ( + volScalarFieldValue alpha.water 1 + volScalarFieldValue alpha.air 0 + ); + } +); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/damBreak/DEM/in.liggghts_init b/tutorials/cfdemSolverMultiphase/damBreak/DEM/in.liggghts_init new file mode 100644 index 00000000..1e06dcea --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/DEM/in.liggghts_init @@ -0,0 +1,71 @@ +# Pour granular particles into chute container, then induce flow +echo both +atom_style granular +atom_modify map array +communicate single vel yes + +boundary f f f +newton off + +units si + +region reg block 0 0.2 0 0.1 0 0.3 units box +create_box 1 reg + +neighbor 0.001 bin +neigh_modify delay 0 + + +# Material properties required for granular pair styles + +fix m1 all property/global youngsModulus peratomtype 5.e6 +fix m2 all property/global poissonsRatio peratomtype 0.45 +fix m3 all property/global coefficientRestitution peratomtypepair 1 0.3 #0.9 +fix m4 all property/global coefficientFriction peratomtypepair 1 0.5 #0.3 + +# pair style +pair_style gran model hertz tangential history # Hertzian without cohesion +pair_coeff * * + +# timestep, gravity +timestep 0.00001 +fix gravi all gravity 9.81 vector 0.0 0.0 -1.0 + +# walls +fix zwalls1 all wall/gran model hertz tangential history primitive type 1 zplane 0 +fix zwalls2 all wall/gran model hertz tangential history primitive type 1 zplane 0.3 +fix xwalls1 all wall/gran model hertz tangential history primitive type 1 xplane 0 +fix xwalls2 all wall/gran model hertz tangential history primitive type 1 xplane 0.2 +fix ywalls1 all wall/gran model hertz tangential history primitive type 1 yplane 0 +fix ywalls2 all wall/gran model hertz tangential history primitive type 1 yplane 0.1 +fix xwalls3 all wall/gran model hertz tangential history primitive type 1 xplane 0.15 +#fix cfdmesh all mesh/surface file ../CFD/mesh.stl type 1 +#fix walls all wall/gran model hertz tangential history mesh n_meshes 1 meshes cfdmesh + +# particle distributions and insertion +#region bc block -0.05 0.05 -0.0025 0.0025 0.05 0.1 units box +region bc block 0.15 0.2 0 0.1 0 0.1 units box +fix pts1 all particletemplate/sphere 1 atom_type 1 density constant 2500 radius constant 0.00135 +fix pdd1 all particledistribution/discrete 1 1 pts1 1.0 + +fix ins all insert/pack seed 100001 distributiontemplate pdd1 vel constant 0. 0. -1.0 insert_every once overlapcheck yes particles_in_region 3883 region bc + +# apply nve integration to all particles that are inserted as single particles +fix integr all nve/sphere + +# screen output +compute rke all erotate/sphere +thermo_style custom step atoms ke c_rke vol +thermo 1000 +thermo_modify lost ignore norm no +compute_modify thermo_temp dynamic yes + +# insert the first particles so that dump is not empty +run 1 +dump dmp all custom 500 post/dump*.liggghts_init id type x y z ix iy iz vx vy vz fx fy fz omegax omegay omegaz radius +#force : f_couple_cfd[0] f_couple_cfd[1] f_couple_cfd[2] +#node : f_couple_cfd[6] +#cell id : f_couple_cfd[7] + +run 30000 upto +write_restart post/restart/liggghts.restart diff --git a/tutorials/cfdemSolverMultiphase/damBreak/DEM/in.liggghts_run b/tutorials/cfdemSolverMultiphase/damBreak/DEM/in.liggghts_run new file mode 100644 index 00000000..de7989ed --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/DEM/in.liggghts_run @@ -0,0 +1,74 @@ +# Pour granular particles into chute container, then induce flow +log ../DEM/log.liggghts +thermo_log ../DEM/post/thermo.txt + +atom_style granular +atom_modify map array +communicate single vel yes + +boundary m m m +newton off + +units si +processors 2 2 1 + +# read the restart file +read_restart ../DEM/post/restart/liggghts.restart + +neighbor 0.0005 bin +neigh_modify delay 0 + +# Material properties required for granular pair styles + +fix m1 all property/global youngsModulus peratomtype 5.e6 +fix m2 all property/global poissonsRatio peratomtype 0.45 +fix m3 all property/global coefficientRestitution peratomtypepair 1 0.3 #0.9 +fix m4 all property/global coefficientFriction peratomtypepair 1 0.5 #0.3 + +# pair style +pair_style gran model hertz tangential history # Hertzian without cohesion +pair_coeff * * + +# timestep, gravity +timestep 0.00001 +fix gravi all gravity 9.81 vector 0.0 0.0 -1.0 + +# walls +fix zwalls1 all wall/gran model hertz tangential history primitive type 1 zplane 0 +fix zwalls2 all wall/gran model hertz tangential history primitive type 1 zplane 0.3 +fix xwalls1 all wall/gran model hertz tangential history primitive type 1 xplane 0 +fix xwalls2 all wall/gran model hertz tangential history primitive type 1 xplane 0.2 +fix ywalls1 all wall/gran model hertz tangential history primitive type 1 yplane 0 +fix ywalls2 all wall/gran model hertz tangential history primitive type 1 yplane 0.1 +#fix cfdmesh all mesh/surface file ../CFD/mesh.stl type 1 +#fix walls all wall/gran model hertz tangential history mesh n_meshes 1 meshes cfdmesh + +# change the particles density +set group all density 2500 + +# cfd coupling +fix cfd all couple/cfd couple_every 100 mpi +fix cfd2 all couple/cfd/force/implicit +#fix cfd2 all couple/cfd/force/accumulator RongDrag 10 1.5e-3 +#fix cfd2 all couple/cfd/force/implicit/accumulated #CrankNicolson 0.5 + +# apply nve integration to all particles that are inserted as single particles +fix integr all nve/sphere + +# center of mass +compute centerOfMass all com + +# compute total dragforce +compute dragtotal all reduce sum f_dragforce[1] f_dragforce[2] f_dragforce[3] + +# screen output +compute rke all erotate/sphere +thermo_style custom step atoms ke c_rke vol c_centerOfMass[3] c_dragtotal[1] c_dragtotal[2] c_dragtotal[3] +thermo 10 +thermo_modify lost ignore norm no +compute_modify thermo_temp dynamic yes + +dump dmp all custom 10000 ../DEM/post/dump*.liggghts_run id type x y z vx vy vz fx fy fz f_dragforce[1] f_dragforce[2] f_dragforce[3] radius +#dump dmpStl all mesh/stl 500 ../DEM/post/dump*.stl + +run 1 diff --git a/tutorials/cfdemSolverMultiphase/damBreak/DEM/post/.gitignore b/tutorials/cfdemSolverMultiphase/damBreak/DEM/post/.gitignore new file mode 100644 index 00000000..e69de29b diff --git a/tutorials/cfdemSolverMultiphase/damBreak/DEM/post/restart/.gitignore b/tutorials/cfdemSolverMultiphase/damBreak/DEM/post/restart/.gitignore new file mode 100644 index 00000000..e69de29b diff --git a/tutorials/cfdemSolverMultiphase/damBreak/parCFDDEMrun.sh b/tutorials/cfdemSolverMultiphase/damBreak/parCFDDEMrun.sh new file mode 100755 index 00000000..cc74e38d --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/parCFDDEMrun.sh @@ -0,0 +1,29 @@ +#!/bin/bash + +#===================================================================# +# allrun script for testcase as part of test routine +# run damBreak CFD part +#===================================================================# + +#- source CFDEM env vars +. ~/.bashrc + +#- include functions +source $CFDEM_PROJECT_DIR/etc/functions.sh + +#--------------------------------------------------------------------------------# +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" +logpath=$casePath +headerText="run_parallel_cfdemSolverMultiphase_test" +logfileName="log_$headerText" +solverName="cfdemSolverMultiphase" +nrProcs="4" +machineFileName="none" # yourMachinefileName | none +debugMode="off" # on | off| strict +testHarnessPath="$CFDEM_TEST_HARNESS_PATH" +#--------------------------------------------------------------------------------# + +#- call function to run a parallel CFD-DEM case +parCFDDEMrun $logpath $logfileName $casePath $headerText $solverName $nrProcs $machineFileName $debugMode + diff --git a/tutorials/cfdemSolverMultiphase/damBreak/parDEMrun.sh b/tutorials/cfdemSolverMultiphase/damBreak/parDEMrun.sh new file mode 100755 index 00000000..9290dfde --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/parDEMrun.sh @@ -0,0 +1,29 @@ +#!/bin/bash + +#===================================================================# +# DEMrun script for damBreak testcase +# init damBreak +#===================================================================# + +#- source CFDEM env vars +. ~/.bashrc + +#- include functions +source $CFDEM_PROJECT_DIR/etc/functions.sh + +echo "starting DEM run in parallel..." +#--------------------------------------------------------------------------------# +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" +logpath="$casePath" +headerText="run_liggghts_init_DEM" +logfileName="log_$headerText" +solverName="in.liggghts_init" +nrProcs=4 +machineFileName="none" +debugMode="off" +#--------------------------------------------------------------------------------# + +#- call function to run DEM case +parDEMrun $logpath $logfileName $casePath $headerText $solverName $nrProcs $machineFileName $debugMode + diff --git a/tutorials/cfdemSolverMultiphase/damBreak/postrun.sh b/tutorials/cfdemSolverMultiphase/damBreak/postrun.sh new file mode 100755 index 00000000..349dfcf6 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/postrun.sh @@ -0,0 +1,14 @@ +#!/bin/bash + +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" + +#- get VTK data from liggghts dump file +cd $casePath/DEM/post +python $CFDEM_LPP_DIR/lpp.py dump*.liggghts_run + +#- get VTK data from CFD sim +cd $casePath/CFD +reconstructPar +foamToVTK + diff --git a/tutorials/cfdemSolverMultiphase/damBreak/prerun.sh b/tutorials/cfdemSolverMultiphase/damBreak/prerun.sh new file mode 100755 index 00000000..567d6388 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/prerun.sh @@ -0,0 +1,9 @@ +#!/bin/bash + +pushd CFD + +cp -r 0.org 0 +setFields + +popd + diff --git a/tutorials/cfdemSolverMultiphase/damBreak/run.config b/tutorials/cfdemSolverMultiphase/damBreak/run.config new file mode 100644 index 00000000..3b8f66a3 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/damBreak/run.config @@ -0,0 +1,19 @@ +{ + "type" : "CFDEMcoupling", + "runs" : [ + { + "name" : "liggghts-init", + "input_script" : "DEM/in.liggghts_init", + "type" : "liggghts/serial" + }, + { + "name" : "cfdemrun", + "depends_on" : "liggghts-init", + "solver" : "cfdemSolverMultiphase", + "type" : "CFDEMcoupling/mpi", + "nprocs" : 4, + "pre_scripts" : ["prerun.sh"], + "post_scripts" : ["postrun.sh"] + } + ] +} diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/Allclean.sh b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/Allclean.sh new file mode 100755 index 00000000..525587d4 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/Allclean.sh @@ -0,0 +1,22 @@ +#!/bin/bash + +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" + +#- clean up case +echo "deleting data at: $casePath :\n" +source $WM_PROJECT_DIR/bin/tools/CleanFunctions +cd $casePath/CFD +cleanCase +rm -r $casePath/CFD/clockData +rm $casePath/DEM/post/*.* +touch $casePath/DEM/post/.gitignore +rm -r $casePath/CFD/0 +rm $casePath/log* + +echo "Remove restart file?" +echo "Enter: yes, Ctrl + C: no" +read + +rm $casePath/DEM/post/restart/*.* +rm $casePath/DEM/post/restart/liggghts.restartCFDEM* diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/Allrun.sh b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/Allrun.sh new file mode 100755 index 00000000..c732f168 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/Allrun.sh @@ -0,0 +1,35 @@ +#!/bin/bash + +#===================================================================# +# Allrun script for cfdemSolverMultiphase +#===================================================================# + +#- define variables +postProcessing=true +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" + +# check if mesh was built +if [ -f "$casePath/CFD/constant/polyMesh/points" ]; then + echo "mesh was built before - using old mesh" +else + echo "mesh needs to be built" + cd $casePath/CFD + blockMesh +fi + +cd $casePath/CFD +cp -r 0.org 0 +setFields + +if [ -f "$casePath/DEM/post/restart/liggghts.restart" ]; then + echo "LIGGGHTS init was run before - using existing restart file" +else + #- run DEM in new terminal + $casePath/parDEMrun.sh +fi + +bash $casePath/parCFDDEMrun.sh + +if [ "$postProcessing" = true ]; then + bash $casePath/postrun.sh +fi diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/Ksl b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/Ksl new file mode 100644 index 00000000..2d0d2d3d --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/Ksl @@ -0,0 +1,47 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object Ksl; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 -3 -1 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type zeroGradient; + //type fixedValue; + //value uniform 0; + } +/* outlet + { + type zeroGradient; + } + frontAndBack + { + type empty; + } +*/ + atmosphere + { + type zeroGradient; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/U b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/U new file mode 100644 index 00000000..48b0791b --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/U @@ -0,0 +1,53 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.x | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volVectorField; + location "0"; + object U; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -1 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + atmosphere + { + type inletOutlet; //fixedValue; + inletValue uniform (0 0 0); + value uniform (0 0 0); + } +/* frontAndBack + { + type empty; + } + + outlet + { + //type zeroGradient; + + type inletOutlet; + inletValue uniform (0 0 0); + value uniform (0 0 0); + + } + */ + walls + { + type fixedValue; + value uniform (0 0 0); + } +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/Us b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/Us new file mode 100644 index 00000000..996c4974 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/Us @@ -0,0 +1,50 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volVectorField; + location "0"; + object Us; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -1 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + walls + { + type zeroGradient; + //type fixedValue; + //value uniform (1 0 0); + } +/* outlet + { + type zeroGradient; + //type fixedValue; + //value uniform (1 0 0);; + } +*/ + atmosphere + { + type zeroGradient; + } + +/* frontAndBack + { + type empty; + } +*/ +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/alpha.air b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/alpha.air new file mode 100644 index 00000000..196a9167 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/alpha.air @@ -0,0 +1,55 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object alpha.air; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type alphaContactAngle; + thetaProperties + ( + ( water air ) 90 0 0 0 + + ); + value uniform 0; + } + atmosphere + { + type inletOutlet; + inletValue uniform 1; + value uniform 1; + } +/* outlet + { + //type zeroGradient; + type inletOutlet; + inletValue uniform 1; + value uniform 1; + } + frontAndBack + { + type empty; + } +*/ +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/alpha.water b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/alpha.water new file mode 100644 index 00000000..62654f88 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/alpha.water @@ -0,0 +1,48 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object alpha.water; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type zeroGradient; + } +/* outlet + { + //type zeroGradient; + type inletOutlet; + inletValue uniform 0; + value uniform 0; + } + frontAndBack + { + type empty; + } +*/ + atmosphere + { + type inletOutlet; + inletValue uniform 0; + value uniform 0; + } +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/alphas b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/alphas new file mode 100644 index 00000000..34caed99 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/alphas @@ -0,0 +1,45 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.x | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object alphas; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ +/* outlet + { + type zeroGradient; + } + frontAndBack + { + type empty; + } +*/ + walls + { + type zeroGradient; + } + atmosphere + { + type zeroGradient; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/epsilon b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/epsilon new file mode 100644 index 00000000..ab29b736 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/epsilon @@ -0,0 +1,52 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object epsilon; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 2 -3 0 0 0 0]; + +internalField uniform 0.003; + +boundaryField +{ + walls + { + type epsilonWallFunction; + Cmu 0.09; + kappa 0.41; + E 9.8; + value uniform 0.003; + } + outlet + { + type inletOutlet; + inletValue uniform 0.003; + value uniform 0.003; + } +/* frontAndBack + { + type empty; + } +*/ + atmosphere + { + type fixedValue; + value uniform 0.003; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/k b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/k new file mode 100644 index 00000000..3347d063 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/k @@ -0,0 +1,48 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object k; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 2 -2 0 0 0 0]; + +internalField uniform 0.001; + +boundaryField +{ + walls + { + type kqRWallFunction; + value uniform 0.001; + } + outlet + { + type inletOutlet; + inletValue uniform 0.001; + value uniform 0.001; + } +/* frontAndBack + { + type empty; + } +*/ + atmosphere + { + type fixedValue; + value uniform 0.001; + } +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/nut b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/nut new file mode 100644 index 00000000..8edd2719 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/nut @@ -0,0 +1,51 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object nut; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 2 -1 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type nutWallFunction; + Cmu 0.09; + kappa 0.41; + E 9.8; + value uniform 0; + } + + outlet + { + type calculated; + value uniform 0; + } +/* frontAndBack + { + type empty; + } +*/ + atmosphere + { + type calculated; + value uniform 0; + } +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/p_rgh b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/p_rgh new file mode 100644 index 00000000..c0547a75 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/p_rgh @@ -0,0 +1,56 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + object p_rgh; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 -1 -2 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + + walls + { + type zeroGradient; //fixedFluxPressure; + //value uniform 0; + } + +/* outlet + { + type fixedValue; + value uniform 0; + } +*/ + atmosphere + { + type fixedValue; + value uniform 0; + /* type totalPressure; + p0 uniform 0; + U U; + phi phi; + rho rho; + psi none; + gamma 1; + value uniform 0;*/ + } +/* frontAndBack + { + type empty; + } +*/ +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/sSmoothField b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/sSmoothField new file mode 100644 index 00000000..df22fd91 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/sSmoothField @@ -0,0 +1,45 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + object sSmoothField; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + + walls + { + type zeroGradient; + } + +/* outlet + { + type zeroGradient; + } + frontAndBack + { + type empty; + } +*/ + atmosphere + { + type zeroGradient; + } + +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/vSmoothField b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/vSmoothField new file mode 100644 index 00000000..6bf85d8d --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/vSmoothField @@ -0,0 +1,45 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volVectorField; + object vSmoothField; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 0 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + + walls + { + type zeroGradient; + } + +/* outlet + { + type zeroGradient; + } + frontAndBack + { + type empty; + } +*/ + atmosphere + { + type zeroGradient; + } + +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/voidfraction b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/voidfraction new file mode 100644 index 00000000..52144c70 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/0.org/voidfraction @@ -0,0 +1,48 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object voidfraction; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 1; + +boundaryField +{ + walls + { + type zeroGradient; + } +/* outlet + { + type fixedValue; + value uniform 1; + } +*/ + atmosphere + { + type fixedValue; + value uniform 1; + } +/* frontAndBack + { + type empty; + } +*/ + +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/couplingProperties b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/couplingProperties new file mode 100644 index 00000000..2ecb6005 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/couplingProperties @@ -0,0 +1,281 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.4 | +| \\ / A nd | Web: http://www.openfoam.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ + + +FoamFile +{ + version 2.0; + format ascii; + + root ""; + case ""; + instance ""; + local ""; + + class dictionary; + object couplingProperties; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +//===========================================================================// +// sub-models & settings + +syncMode false; +//verbose; +useDDTvoidfraction; +modelType "A"; // A or B + +couplingInterval 10; + +voidFractionModel divided;//centre;// + +locateModel engine;//turboEngineM2M;// + +meshMotionModel noMeshMotion; + +regionModel allRegion; + +IOModel basicIO; + +probeModel off; + +dataExchangeModel twoWayMPI;//twoWayFiles;//twoWayM2M;//oneWayVTK;// + +averagingModel dense;//dilute;// + +clockModel standardClock;//off; + +smoothingModel constDiffSmoothing; // off;// localPSizeDiffSmoothing; // + +forceModels +( + //GidaspowDrag + //BeetstraDrag + //DiFeliceDrag + gradPForce + viscForce + KochHillDrag + //interface + //DEMbasedDrag + //RongDrag + //Archimedes + //volWeightedAverage + //totalMomentumExchange + //particleCellVolume + //fieldTimeAverage + surfaceTensionForce +); + +momCoupleModels +( + implicitCouple +); + +turbulenceModelType "turbulenceProperties"; //"RASProperties";//"LESProperties";// + +//===========================================================================// +// sub-model properties + +localPSizeDiffSmoothingProps +{ + lowerLimit 0.1; + upperLimit 1e10; + dSmoothingLength 1.5e-3; + Csmoothing 1.0; +} + +constDiffSmoothingProps +{ + lowerLimit 0.1; + upperLimit 1e10; + smoothingLength 1.5e-3; +} + +implicitCoupleProps +{ + velFieldName "U"; + granVelFieldName "Us"; + voidfractionFieldName "voidfraction"; +} + +ArchimedesProps +{ + gravityFieldName "g"; +} +gradPForceProps +{ + pFieldName "p"; + voidfractionFieldName "voidfraction"; + velocityFieldName "U"; + interpolation true; +} + +viscForceProps +{ + velocityFieldName "U"; + interpolation false; + verbose false; +} +volWeightedAverageProps +{ + scalarFieldNames + ( + voidfraction + ); + vectorFieldNames + ( + ); + upperThreshold 0.999; + lowerThreshold 0; + verbose true; +} +totalMomentumExchangeProps +{ + implicitMomExFieldName "Ksl"; + explicitMomExFieldName "none"; + fluidVelFieldName "U"; + granVelFieldName "Us"; +} +GidaspowDragProps +{ + verbose false; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + interpolation true; + phi 1; + granVelFieldName "Us"; +} +DEMbasedDragProps +{ + velFieldName "U"; + voidfractionFieldName "voidfraction"; +} + +DiFeliceDragProps +{ + //verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + granVelFieldName "Us"; + interpolation true; +} + +KochHillDragProps +{ + //verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + interpolation false; + //forceSubModels + //( + // ImExCorr + //); + implForceDEM true; + //implForceDEMaccumulated true; + //explicitCorr true; +} + +BeetstraDragProps +{ + velFieldName "U"; + gravityFieldName "g"; + rhoParticle 2000.; + voidfractionFieldName "voidfraction"; + interpolation ; + useFilteredDragModel ; + useParcelSizeDependentFilteredDrag ; + k 0.05; + aLimit 0.0; +// verbose true; +} + +RongDragProps +{ + verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + interpolation true; + implForceDEM true; + implForceDEMaccumulated true; + granVelFieldName "Us"; +} + +virtualMassForceProps +{ + velFieldName "U"; +} + +particleCellVolumeProps +{ + upperThreshold 0.999; + lowerThreshold 0.; + verbose true; +} + +fieldStoreProps +{ + scalarFieldNames + ( + ); + + vectorFieldNames + ( + "U" + ); +} + +oneWayVTKProps +{ + couplingFilename "vtk_out%4.4d.vtk"; + maxNumberOfParticles 30000; +} + +twoWayFilesProps +{ + maxNumberOfParticles 10100; +} + +centreProps +{ + alphaMin 0.1; +} + +engineProps +{ + treeSearch true; +} + +turboEngineM2MProps +{ + turboEngineProps + { + treeSearch true; + } +} + +dividedProps +{ + alphaMin 0.3; + //scaleUpVol 1.0; +} + +twoWayMPIProps +{ + liggghtsPath "../DEM/in.liggghts_run"; +} +twoWayM2MProps +{ + maxNumberOfParticles 10100; + liggghtsPath "../DEM/in.liggghts_run"; +} + +surfaceTensionForceProps +{ +} +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/g b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/g new file mode 100644 index 00000000..f4596ed7 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/g @@ -0,0 +1,22 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class uniformDimensionedVectorField; + location "constant"; + object g; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -2 0 0 0 0]; +value ( 0 0 -9.8 ); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/liggghtsCommands b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/liggghtsCommands new file mode 100644 index 00000000..d9e1ce81 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/liggghtsCommands @@ -0,0 +1,43 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.4 | +| \\ / A nd | Web: http://www.openfoam.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ + + +FoamFile +{ + version 2.0; + format ascii; + + root ""; + case ""; + instance ""; + local ""; + + class dictionary; + object liggghtsCommands; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +liggghtsCommandModels +( + runLiggghts + writeLiggghts +); +// ************************************************************************* // + +/*runLiggghtsProps +{ + preNo false; +}*/ + +writeLiggghtsProps +{ + writeLast off; + writeName "post/restart/liggghts.restartCFDEM"; + overwrite on; +} diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/transportProperties b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/transportProperties new file mode 100644 index 00000000..bae5857c --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/transportProperties @@ -0,0 +1,53 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object transportProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +phases +( + water + { + transportModel Newtonian; + nu nu [ 0 2 -1 0 0 0 0 ] 1e-06; + rho rho [ 1 -3 0 0 0 0 0 ] 1000; + } +/* + oil + { + transportModel Newtonian; + nu nu [ 0 2 -1 0 0 0 0 ] 1e-06; + rho rho [ 1 -3 0 0 0 0 0 ] 500; + } +*/ + air + { + transportModel Newtonian; + nu nu [ 0 2 -1 0 0 0 0 ] 1e-05; + rho rho [ 1 -3 0 0 0 0 0 ] 1; //100; +// nu nu [ 0 2 -1 0 0 0 0 ] 1.48e-05; +// rho rho [ 1 -3 0 0 0 0 0 ] 1; + } +); + +sigmas +( +// (water oil) 0.07 + (air water) 0.07 +// (air oil) 0.07 + +); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/transportProperties_temp b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/transportProperties_temp new file mode 100644 index 00000000..1e803628 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/transportProperties_temp @@ -0,0 +1,37 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object transportProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +transportModel Newtonian; + +nu nu [ 0 2 -1 0 0 0 0 ] 1.5e-04; + +CrossPowerLawCoeffs +{ + nu0 nu0 [ 0 2 -1 0 0 0 0 ] 1e-06; + nuInf nuInf [ 0 2 -1 0 0 0 0 ] 1e-06; + m m [ 0 0 1 0 0 0 0 ] 1; + n n [ 0 0 0 0 0 0 0 ] 1; +} + +BirdCarreauCoeffs +{ + nu0 nu0 [ 0 2 -1 0 0 0 0 ] 1e-06; + nuInf nuInf [ 0 2 -1 0 0 0 0 ] 1e-06; + k k [ 0 0 1 0 0 0 0 ] 0; + n n [ 0 0 0 0 0 0 0 ] 1; +} +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/turbulenceProperties b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/turbulenceProperties new file mode 100644 index 00000000..6cd2b219 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/constant/turbulenceProperties @@ -0,0 +1,21 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object turbulenceProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +simulationType laminar; //RASModel; + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/blockMeshDict b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/blockMeshDict new file mode 100644 index 00000000..8747be6f --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/blockMeshDict @@ -0,0 +1,110 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.0 | +| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ +version 2.0; +format ascii; +class dictionary; +object blockMeshDict; +} +// ************************************ + + + + + + + meshGenApp blockMesh; + convertToMeters 0.01; + + //64 mm column diameter + //15 cm length + + + + //Width of middle square section + + + + + //how many cells in the square section + //how many cells from square section to perimeter + // how many cells from top to bottom + + vertices + ( + (0 0 0) + (5 0 0) + (5 5 0) + (0 5 0) + (0 0 20) + (5 0 20) + (5 5 20) + (0 5 20) + ); + + blocks + ( + hex (0 1 2 3 4 5 6 7) (16 16 64) simpleGrading (1 1 1) + ); + + edges + ( + ); + + boundary + ( + atmosphere + { + type patch; + faces + ( + (4 5 6 7) + ); + } +/* frontAndBack + { + type empty; + faces + ( + (0 1 5 4) + (4 5 9 8) + (8 9 13 12) + (3 7 6 2) + (7 11 10 6) + (11 15 14 10) + + ); + } + + outlet + { + type patch; + faces + ( + (5 6 10 9) + ); + } +*/ + walls + { + type wall; + faces + ( + (0 3 2 1) + (0 4 7 3) + (3 7 6 2) + (1 2 6 5) + (0 1 5 4) + ); + } +); + +mergePatchPairs +( +); diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/controlDict b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/controlDict new file mode 100644 index 00000000..c85a0a12 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/controlDict @@ -0,0 +1,74 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object controlDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +application pisoFoam; + +startFrom startTime; + +startTime 0; + +stopAt endTime; + +endTime 1.0; + +deltaT 0.0001; + +writeControl adjustableRunTime; + +writeInterval 0.01; + +purgeWrite 0; + +writeFormat ascii; + +writePrecision 6; + +writeCompression uncompressed; + +timeFormat general; + +timePrecision 6; + +runTimeModifiable yes; + +adjustTimeStep no; + +maxCo 0.1; +maxAlphaCo 0.1; +/* +libs ( + "libOpenFOAM.so" + "libsimpleSwakFunctionObjects.so" + "libswakFunctionObjects.so" + ); + +functions +{ + volFlow + { + type swakExpression; + valueType patch; + patchName atmosphere; + + verbose true; + expression "U&Sf()"; + accumulations ( sum ); + outputInterval 500; + } +} +*/ +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/decomposeParDict b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/decomposeParDict new file mode 100644 index 00000000..4de14078 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/decomposeParDict @@ -0,0 +1,86 @@ +/*-------------------------------*- C++ -*---------------------------------*\ +| ========= | +| \\ / OpenFOAM | +| \\ / | +| \\ / The Open Source CFD Toolbox | +| \\/ http://www.OpenFOAM.org | +\*-------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + note "mesh decomposition control dictionary"; + location "system"; + object decomposeParDict; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +numberOfSubdomains 4; + +//- Keep owner and neighbour on same processor for faces in zones: +// preserveFaceZones (heater solid1 solid3); + +//method scotch; +// method hierarchical; + method simple; +// method metis; +// method manual; + +simpleCoeffs +{ + n (2 2 1); + delta 0.001; +} + +hierarchicalCoeffs +{ + n (2 2 1); + delta 0.001; + order xyz; +} + +metisCoeffs +{ + /* + processorWeights + ( + 1 + 1 + 1 + 1 + ); + */ +} + +scotchCoeffs +{ + //processorWeights + //( + // 1 + // 1 + // 1 + // 1 + //); + //writeGraph true; + //strategy "b"; +} + +manualCoeffs +{ + dataFile "decompositionData"; +} + + +//// Is the case distributed +//distributed yes; +//// Per slave (so nProcs-1 entries) the directory above the case. +//roots +//( +// "/tmp" +// "/tmp" +//); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/fvSchemes b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/fvSchemes new file mode 100644 index 00000000..764a3064 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/fvSchemes @@ -0,0 +1,69 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSchemes; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +ddtSchemes +{ + default Euler; +} + +gradSchemes +{ + default Gauss linear; + grad(U) Gauss linear; + grad(gamma) Gauss linear; +} + +divSchemes +{ + div(rhoPhi,U) Gauss upwind; + div((interpolate(rho)*phi),U) Gauss upwind; + div(phi,alpha) Gauss vanLeer; + div(phirb,alpha) Gauss linear; + div((muEff*dev(T(grad(U))))) Gauss linear; + div((viscousTerm*dev2(grad(U).T()))) Gauss linear; + div(((grad(U)*rho)*dev(grad(U).T()))) Gauss linear; + div(((dev(grad(U).T())*rho)*dev(grad(U).T()))) Gauss linear; + div((((((alpha.water*rho)*nu.water)|(alpha.water*rho))*rho)*dev(grad(U).T()))) Gauss linear; + div(((nu*rho)*dev(grad(U).T()))) Gauss linear; + default Gauss linear; +} + +laplacianSchemes +{ + default Gauss linear corrected; +} + +interpolationSchemes +{ + default linear; +} + +snGradSchemes +{ + default corrected; +} + +fluxRequired +{ + default no; + pcorr; + p_rgh; + "alpha.*"; +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/fvSolution b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/fvSolution new file mode 100644 index 00000000..6907a786 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/fvSolution @@ -0,0 +1,138 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSolution; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +solvers +{ + "alpha.*" + { + nAlphaSubCycles 1; + cAlpha 1; + } + + pcorr + { + solver PCG; + preconditioner + { + preconditioner GAMG; + tolerance 1e-05; + relTol 0; + smoother GaussSeidel; + nPreSweeps 0; + nPostSweeps 2; + nFinestSweeps 2; + cacheAgglomeration on; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + } + tolerance 1e-05; + relTol 0; + maxIter 100; + } + + p_rgh + { + solver GAMG; + tolerance 1e-07; + relTol 0.05; + smoother GaussSeidel; + nPreSweeps 0; + nPostSweeps 2; + nFinestSweeps 2; + cacheAgglomeration on; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + } + + p_rghFinal + { + solver PCG; + preconditioner + { + preconditioner GAMG; + tolerance 1e-07; + relTol 0; + nVcycles 2; + smoother GaussSeidel; + nPreSweeps 0; + nPostSweeps 2; + nFinestSweeps 2; + cacheAgglomeration on; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + } + tolerance 1e-07; + relTol 0; + maxIter 20; + } + + "(k|epsilon|R|nuTilda)" + { + solver smoothSolver; + smoother GaussSeidel; + tolerance 1e-9; + relTol 0; + nSweeps 1; + } + + "(voidfraction|Us|Ksl|sSmoothField|vSmoothField|UsNext|voidfractionNext)" + { + solver PCG; + preconditioner DIC; + tolerance 1e-05; + relTol 0; + } + + U + { + solver smoothSolver; + smoother GaussSeidel; + tolerance 1e-08; + relTol 0.1; + nSweeps 1; + } + + UFinal + { + $U; + tolerance 1e-08; + relTol 0; + } + +} + +PIMPLE +{ + nCorrectors 2; + nNonOrthogonalCorrectors 0; +} + +relaxationFactors +{ + fields + { + } + equations + { + "U.*" 1; + } +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/sampleDict b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/sampleDict new file mode 100644 index 00000000..207dab9e --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/sampleDict @@ -0,0 +1,36 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object sampleDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +interpolationScheme cellPoint; + +setFormat raw; + +sets +( + data + { + type uniform; + axis z; + start (0.025 0.025 0.2); + end (0.025 0.025 0); + nPoints 1000; + } +); + +fields (alpha.air); + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/setFieldsDict b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/setFieldsDict new file mode 100644 index 00000000..cea2286d --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/CFD/system/setFieldsDict @@ -0,0 +1,50 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object setFieldsDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +defaultFieldValues +( + volScalarFieldValue alpha.air 1 + volScalarFieldValue alpha.water 0 +// volScalarFieldValue alpha.oil 0 +// volScalarFieldValue alpha.mercury 0 + volVectorFieldValue U ( 0 0 0 ) +); + +regions +( + boxToCell + { + box ( 0 0 0 ) ( 0.05 0.05 0.05 ); + fieldValues + ( + volScalarFieldValue alpha.water 1 + volScalarFieldValue alpha.air 0 + ); + } +/* boxToCell + { + box ( 0.005 0.005 0.05 ) ( 0.045 0.045 0.1 ); + fieldValues + ( + volScalarFieldValue voidfraction 0.35 + ); + } + */ +); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/DEM/in.liggghts_init b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/DEM/in.liggghts_init new file mode 100644 index 00000000..07248ceb --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/DEM/in.liggghts_init @@ -0,0 +1,72 @@ +# Pour granular particles into chute container, then induce flow +echo both +atom_style granular +atom_modify map array +communicate single vel yes + +boundary f f f +newton off + +units si + +region reg block 0 0.05 0 0.05 0 0.2 units box +create_box 1 reg + +neighbor 0.001 bin +neigh_modify delay 0 + + +# Material properties required for granular pair styles + +fix m1 all property/global youngsModulus peratomtype 5.e6 +fix m2 all property/global poissonsRatio peratomtype 0.45 +fix m3 all property/global coefficientRestitution peratomtypepair 1 0.3 #0.9 +fix m4 all property/global coefficientFriction peratomtypepair 1 0.5 #0.3 + +# pair style +pair_style gran model hertz tangential history # Hertzian without cohesion +pair_coeff * * + +# timestep, gravity +timestep 0.00001 +fix gravi all gravity 9.8 vector 0.0 0.0 -1.0 + +# walls +fix zwalls1 all wall/gran model hertz tangential history primitive type 1 zplane 0.05 +fix zwalls2 all wall/gran model hertz tangential history primitive type 1 zplane 0.2 +fix xwalls1 all wall/gran model hertz tangential history primitive type 1 xplane 0.005 +fix xwalls2 all wall/gran model hertz tangential history primitive type 1 xplane 0.045 +fix ywalls1 all wall/gran model hertz tangential history primitive type 1 yplane 0.005 +fix ywalls2 all wall/gran model hertz tangential history primitive type 1 yplane 0.045 +#fix cfdmesh all mesh/surface file ../CFD/mesh.stl type 1 +#fix walls all wall/gran model hertz tangential history mesh n_meshes 1 meshes cfdmesh + +# particle distributions and insertion +#region bc block -0.05 0.05 -0.0025 0.0025 0.05 0.1 units box +region bc block 0.005 0.045 0.005 0.045 0.05 0.15 units box +fix pts1 all particletemplate/sphere 1 atom_type 1 density constant 2500 radius constant 0.001 +fix pdd1 all particledistribution/discrete 1 1 pts1 1.0 + +fix ins all insert/pack seed 100001 distributiontemplate pdd1 vel constant 0. 0. 0. insert_every once overlapcheck yes particles_in_region 10000 region bc + +# apply nve integration to all particles that are inserted as single particles +fix integr all nve/sphere + +# screen output +compute rke all erotate/sphere +#compute mp all property/atom mass +#compute mpA all reduce ave c_mp +thermo_style custom step atoms ke c_rke vol #c_mpA +thermo 1000 +thermo_modify lost ignore norm no +compute_modify thermo_temp dynamic yes + +# insert the first particles so that dump is not empty +run 1 +dump dmp all custom 500 post/dump*.liggghts_init id type x y z ix iy iz vx vy vz fx fy fz omegax omegay omegaz radius +#force : f_couple_cfd[0] f_couple_cfd[1] f_couple_cfd[2] +#node : f_couple_cfd[6] +#cell id : f_couple_cfd[7] + +run 35000 upto +write_restart post/restart/liggghts.restart diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/DEM/in.liggghts_run b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/DEM/in.liggghts_run new file mode 100644 index 00000000..e780d6ea --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/DEM/in.liggghts_run @@ -0,0 +1,76 @@ +# Pour granular particles into chute container, then induce flow +log ../DEM/log.liggghts +thermo_log ../DEM/post/thermo.txt + +atom_style granular +atom_modify map array +communicate single vel yes + +boundary m m m +newton off + +units si +processors 2 2 1 + +# read the restart file +read_restart ../DEM/post/restart/liggghts.restart + +neighbor 0.005 bin +neigh_modify delay 0 + +# Material properties required for granular pair styles + +fix m1 all property/global youngsModulus peratomtype 5.e6 +fix m2 all property/global poissonsRatio peratomtype 0.45 +fix m3 all property/global coefficientRestitution peratomtypepair 1 0.3 +fix m4 all property/global coefficientFriction peratomtypepair 1 0.5 + +# pair style +pair_style gran model hertz tangential history # Hertzian without cohesion +pair_coeff * * + +# timestep, gravity +timestep 0.00001 +fix gravi all gravity 9.8 vector 0.0 0.0 -1.0 + +# walls +fix zwalls1 all wall/gran model hertz tangential history primitive type 1 zplane 0 +fix zwalls2 all wall/gran model hertz tangential history primitive type 1 zplane 0.2 +fix xwalls1 all wall/gran model hertz tangential history primitive type 1 xplane 0 +fix xwalls2 all wall/gran model hertz tangential history primitive type 1 xplane 0.05 +fix ywalls1 all wall/gran model hertz tangential history primitive type 1 yplane 0 +fix ywalls2 all wall/gran model hertz tangential history primitive type 1 yplane 0.05 +#fix cfdmesh all mesh/surface file ../CFD/mesh.stl type 1 +#fix walls all wall/gran model hertz tangential history mesh n_meshes 1 meshes cfdmesh + +# change the particles density +set group all density 2500 + +# cfd coupling +fix cfd all couple/cfd couple_every 100 mpi +fix cfd2 all couple/cfd/force/implicit +#fix cfd2 all couple/cfd/force/accumulator RongDrag 10 1.5e-3 +#fix cfd2 all couple/cfd/force/implicit/accumulated #CrankNicolson 0.5 + +# apply nve integration to all particles that are inserted as single particles +fix integr all nve/sphere + +# center of mass +compute centerOfMass all com + +# compute total dragforce +compute dragtotal all reduce sum f_dragforce[1] f_dragforce[2] f_dragforce[3] + +# screen output +compute rke all erotate/sphere +compute mp all property/atom diameter +compute particleMassTotal all reduce ave c_mp +thermo_style custom step atoms ke c_rke vol c_centerOfMass[3] c_dragtotal[1] c_dragtotal[2] c_dragtotal[3] c_particleMassTotal +thermo 10 +thermo_modify lost ignore norm no +compute_modify thermo_temp dynamic yes + +dump dmp all custom 1000 ../DEM/post/dump*.liggghts_run id type x y z vx vy vz fx fy fz f_dragforce[1] f_dragforce[2] f_dragforce[3] radius +#dump dmpStl all mesh/stl 500 ../DEM/post/dump*.stl + +run 1 diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/DEM/post/.gitignore b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/DEM/post/.gitignore new file mode 100644 index 00000000..e69de29b diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/DEM/post/restart/.gitignore b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/DEM/post/restart/.gitignore new file mode 100644 index 00000000..e69de29b diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/parCFDDEMrun.sh b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/parCFDDEMrun.sh new file mode 100755 index 00000000..2882782b --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/parCFDDEMrun.sh @@ -0,0 +1,29 @@ +#!/bin/bash + +#===================================================================# +# allrun script for testcase as part of test routine +# run particlesWaterEntry CFD part +#===================================================================# + +#- source CFDEM env vars +. ~/.bashrc + +#- include functions +source $CFDEM_PROJECT_DIR/etc/functions.sh + +#--------------------------------------------------------------------------------# +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" +logpath=$casePath +headerText="run_parallel_cfdemSolverMultiphase_test" +logfileName="log_$headerText" +solverName="cfdemSolverMultiphase" +nrProcs="4" +machineFileName="none" # yourMachinefileName | none +debugMode="off" # on | off| strict +testHarnessPath="$CFDEM_TEST_HARNESS_PATH" +#--------------------------------------------------------------------------------# + +#- call function to run a parallel CFD-DEM case +parCFDDEMrun $logpath $logfileName $casePath $headerText $solverName $nrProcs $machineFileName $debugMode + diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/parDEMrun.sh b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/parDEMrun.sh new file mode 100755 index 00000000..6bba2001 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/parDEMrun.sh @@ -0,0 +1,29 @@ +#!/bin/bash + +#===================================================================# +# DEMrun script for particlesWaterEntry testcase +# init particlesWaterEntry +#===================================================================# + +#- source CFDEM env vars +. ~/.bashrc + +#- include functions +source $CFDEM_PROJECT_DIR/etc/functions.sh + +echo "starting DEM run in parallel..." +#--------------------------------------------------------------------------------# +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" +logpath="$casePath" +headerText="run_liggghts_init_DEM" +logfileName="log_$headerText" +solverName="in.liggghts_init" +nrProcs=4 +machineFileName="none" +debugMode="off" +#--------------------------------------------------------------------------------# + +#- call function to run DEM case +parDEMrun $logpath $logfileName $casePath $headerText $solverName $nrProcs $machineFileName $debugMode + diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/postrun.sh b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/postrun.sh new file mode 100755 index 00000000..3c569302 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/postrun.sh @@ -0,0 +1,14 @@ +#!/bin/bash + +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" + +#- get VTK data from liggghts dump file +cd $casePath/DEM/post +python $CFDEM_LPP_DIR/lpp.py dump*.liggghts_run + +#- get VTK data from CFD sim +cd $casePath/CFD +reconstructPar +foamToVTK + diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/prerun.sh b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/prerun.sh new file mode 100755 index 00000000..567d6388 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/prerun.sh @@ -0,0 +1,9 @@ +#!/bin/bash + +pushd CFD + +cp -r 0.org 0 +setFields + +popd + diff --git a/tutorials/cfdemSolverMultiphase/particlesWaterEntry/run.config b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/run.config new file mode 100644 index 00000000..3b8f66a3 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/particlesWaterEntry/run.config @@ -0,0 +1,19 @@ +{ + "type" : "CFDEMcoupling", + "runs" : [ + { + "name" : "liggghts-init", + "input_script" : "DEM/in.liggghts_init", + "type" : "liggghts/serial" + }, + { + "name" : "cfdemrun", + "depends_on" : "liggghts-init", + "solver" : "cfdemSolverMultiphase", + "type" : "CFDEMcoupling/mpi", + "nprocs" : 4, + "pre_scripts" : ["prerun.sh"], + "post_scripts" : ["postrun.sh"] + } + ] +} diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/Allclean.sh b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/Allclean.sh new file mode 100755 index 00000000..16ba029b --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/Allclean.sh @@ -0,0 +1,26 @@ +#!/bin/bash + +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" + +#- clean up case +echo "deleting data at: $casePath :\n" +source $WM_PROJECT_DIR/bin/tools/CleanFunctions +cd $casePath/CFD +mv 1.org .. +cleanCase +mv ../1.org . +rm -r $casePath/CFD/clockData +rm $casePath/DEM/post/*.* +touch $casePath/DEM/post/.gitignore +rm $casePath/log* +rm $casePath/DEM/log* +#rm -r $casePath/CFD/0 + +#echo "Remove restart files?" +#echo "Enter: yes, Ctrl + C: no" +#read + +#rm $casePath/DEM/post/restart/*.* + + diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/Allrun.sh b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/Allrun.sh new file mode 100755 index 00000000..6a977cba --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/Allrun.sh @@ -0,0 +1,28 @@ +#!/bin/bash + +#===================================================================# +# This tutorial runs a drainage simulation of a small-scale blast +# furnace hearth from an initial state generated from ../init +#===================================================================# + +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" +nrProcs=4; + +# check if mesh was built +if [ -f "$casePath/CFD/constant/polyMesh/points" ]; then + echo "mesh was built before - using old mesh" +else + echo "mesh needs to be built" + cd $casePath/CFD + ./mesh.sh +fi + +#run the drainage simulation +cd $casePath +cp -r ./CFD/1.org ./CFD/1 +./parCFDDEMrun.sh + +# generate files for post processing +cd $casePath +./postrun.sh diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/RASProperties b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/RASProperties new file mode 100644 index 00000000..daec1829 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/RASProperties @@ -0,0 +1,25 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object RASProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +RASModel laminar; + +turbulence off; + +printCoeffs on; + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/couplingProperties b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/couplingProperties new file mode 100644 index 00000000..63d00d52 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/couplingProperties @@ -0,0 +1,314 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.4 | +| \\ / A nd | Web: http://www.openfoam.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ + + +FoamFile +{ + version 2.0; + format ascii; + + root ""; + case ""; + instance ""; + local ""; + + class dictionary; + object couplingProperties; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +//===========================================================================// +// sub-models & settings + +syncMode false; +//verbose; +useDDTvoidfraction; + + +modelType "A"; // A or B + +couplingInterval 100; + +voidFractionModel divided; //bigParticle; //trilinear; //centre; //divided; + +locateModel engine;//turboEngineM2M;// + +meshMotionModel noMeshMotion; + +regionModel allRegion; + +IOModel basicIO; + +probeModel off; //particleProbe; //off; + +dataExchangeModel twoWayMPI;//twoWayFiles;//twoWayM2M;//oneWayVTK;// + +averagingModel dense;//dilute;// + +clockModel standardClock;//off; + +smoothingModel constDiffSmoothing; //off;// localPSizeDiffSmoothing;// constDiffSmoothing; // + +forceModels +( + //GidaspowDrag + //BeetstraDrag + //DiFeliceDrag + //gradPForce + gradPForceSmooth + viscForce + KochHillDrag + //interface + //DEMbasedDrag + //RongDrag + //Archimedes + //volWeightedAverage + //totalMomentumExchange + //particleCellVolume + //fieldTimeAverage + surfaceTensionForce +); + +momCoupleModels +( + implicitCouple +); + +turbulenceModelType "turbulenceProperties"; //"RASProperties";//"LESProperties";// + +//===========================================================================// +// sub-model properties + +localPSizeDiffSmoothingProps +{ + lowerLimit 0.1; + upperLimit 1e10; + dSmoothingLength 1.5e-3; + Csmoothing 1.0; +} + +constDiffSmoothingProps +{ + lowerLimit 0.1; + upperLimit 1e10; + smoothingLength 6e-3; +} + +implicitCoupleProps +{ + velFieldName "U"; + granVelFieldName "Us"; + voidfractionFieldName "voidfraction"; +} + +ArchimedesProps +{ + gravityFieldName "g"; + treatForceDEM true; +} +gradPForceProps +{ + pFieldName "p"; + voidfractionFieldName "voidfraction"; + velocityFieldName "U"; + //interpolation true; +} + +viscForceProps +{ + velocityFieldName "U"; + //interpolation false; + verbose true; +} +volWeightedAverageProps +{ + scalarFieldNames + ( + voidfraction + ); + vectorFieldNames + ( + ); + upperThreshold 0.999; + lowerThreshold 0; + verbose true; +} +totalMomentumExchangeProps +{ + implicitMomExFieldName "Ksl"; + explicitMomExFieldName "none"; + fluidVelFieldName "U"; + granVelFieldName "Us"; +} +GidaspowDragProps +{ + verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + interpolation true; + phi 1; +} +DEMbasedDragProps +{ + velFieldName "U"; + voidfractionFieldName "voidfraction"; +} + +DiFeliceDragProps +{ + //verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + granVelFieldName "Us"; + interpolation true; +} + +KochHillDragProps +{ + //verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + //interpolation true; + //forceSubModels + //( + // ImExCorr + //); + implForceDEM true; + //implForceDEMaccumulated true; + //explicitCorr true; +} + +BeetstraDragProps +{ + velFieldName "U"; + gravityFieldName "g"; + rhoParticle 2000.; + voidfractionFieldName "voidfraction"; + interpolation ; + useFilteredDragModel ; + useParcelSizeDependentFilteredDrag ; + k 0.05; + aLimit 0.0; +// verbose true; +} + +RongDragProps +{ + verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + interpolation true; + implForceDEM true; + implForceDEMaccumulated true; + granVelFieldName "Us"; +} + +virtualMassForceProps +{ + velFieldName "U"; +} + +particleCellVolumeProps +{ + upperThreshold 0.999; + lowerThreshold 0.; + verbose true; +} + +fieldStoreProps +{ + scalarFieldNames + ( + ); + + vectorFieldNames + ( + "U" + ); +} + +oneWayVTKProps +{ + couplingFilename "vtk_out%4.4d.vtk"; + maxNumberOfParticles 30000; +} + +twoWayFilesProps +{ + maxNumberOfParticles 10100; +} + +centreProps +{ + alphaMin 0.1; +} + +engineProps +{ + treeSearch true; +} + +turboEngineM2MProps +{ + turboEngineProps + { + treeSearch true; + } +} + +dividedProps +{ + alphaMin 0.01; + // porosity 0.5; + //interpolation true; +} + +twoWayMPIProps +{ + liggghtsPath "../DEM/in.liggghts_run"; +} +twoWayM2MProps +{ + maxNumberOfParticles 10100; + liggghtsPath "../DEM/in.liggghts_run"; +} +surfaceTensionForceProps +{ +} + +trilinearProps +{ + alphaMin 0.01; +} + +bigParticleProps +{ + alphaMin 0.01; + maxCellsPerParticle 1000; + porosity 100.0; +} + +gradPForceSmoothProps +{ + pFieldName "p_rgh"; + voidfractionFieldName "voidfraction"; + velocityFieldName "U"; + smoothingModel "temporalSmoothing"; + temporalSmoothingProps + { + lowerLimit 0.1; + upperLimit 1e10; + refField "p_rgh"; + gamma 0.01; + } + +} + +} +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/g b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/g new file mode 100644 index 00000000..317bdd50 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/g @@ -0,0 +1,22 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class uniformDimensionedVectorField; + location "constant"; + object g; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -2 0 0 0 0]; +value ( 0 0 -9.81 ); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/liggghtsCommands b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/liggghtsCommands new file mode 100644 index 00000000..ea16dec7 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/liggghtsCommands @@ -0,0 +1,43 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.4 | +| \\ / A nd | Web: http://www.openfoam.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ + + +FoamFile +{ + version 2.0; + format ascii; + + root ""; + case ""; + instance ""; + local ""; + + class dictionary; + object liggghtsCommands; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +liggghtsCommandModels +( + runLiggghts + writeLiggghts +); +// ************************************************************************* // + +/*runLiggghtsProps +{ + preNo false; +}*/ + +writeLiggghtsProps +{ + writeLast on; + writeName "post/restart/liggghts.restartCFDEM"; + overwrite on; +} diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/polyMesh/blockMeshDict b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/polyMesh/blockMeshDict new file mode 100644 index 00000000..02f3b4ac --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/polyMesh/blockMeshDict @@ -0,0 +1,146 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + object blockMeshDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +// General m4 macros + + + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +// User-defined parameters +convertToMeters 1; + + + + + + + //degrees from x-axis + + + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +// Derived parameters + + + + + + + + + + + + + + + + + + + + + + + +vertices +( + (-0.05 0.05 0) //Square 11 o'clock,bottom //0 + (0.05 0.05 0) //Square 1 o'clock,bottom //1 + (0.05 -0.05 0) //Square 5 o'clock,bottom //2 + (-0.05 -0.05 0) //Square 7 o'clock,bottom //3 + (-0.0707106781186548 0.0707106781186548 0) //Cyl 11 o'clock,bottom //4 + (0.0707106781186548 0.0707106781186548 0) //Cyl 1 o'clock,bottom //5 + (0.0707106781186548 -0.0707106781186548 0) //Cyl 5 o'clock,bottom //6 + (-0.0707106781186548 -0.0707106781186548 0) //Cyl 7 o'clock,bottom //7 + + (-0.05 0.05 0.08) //Square 11 o'clock,top //8 + (0.05 0.05 0.08) //Square 1 o'clock,top //9 + (0.05 -0.05 0.08) //Square 5 o'clock,top //10 + (-0.05 -0.05 0.08) //Square 7 o'clock,top //11 + (-0.0707106781186548 0.0707106781186548 0.08) //Cyl 11 o'clock,top //12 + (0.0707106781186548 0.0707106781186548 0.08) //Cyl 1 o'clock,top //13 + (0.0707106781186548 -0.0707106781186548 0.08) //Cyl 5 o'clock,top //14 + (-0.0707106781186548 -0.0707106781186548 0.08) //Cyl 7 o'clock,top //15 + +); + +blocks +( + hex (3 2 1 0 11 10 9 8) (8 8 6) simpleGrading (1 1 1) //Mid-block + hex (7 3 0 4 15 11 8 12) (3 8 6) simpleGrading (1 1 1) //west-block + hex (0 1 5 4 8 9 13 12) (8 3 6) simpleGrading (1 1 1) //north-block + hex (2 6 5 1 10 14 13 9) (3 8 6) simpleGrading (1 1 1) //east-block + hex (7 6 2 3 15 14 10 11) (8 3 6) simpleGrading (1 1 1) //south-block +); + +edges +( + arc 7 4 (-0.1 0 0) //west,bottom + arc 4 5 (0 0.1 0) //north,bottom + arc 5 6 (0.1 0 0) //east,bottom + arc 6 7 (0 -0.1 0) //south,bottom + arc 15 12 (-0.1 0 0.08) //west,top + arc 12 13 (0 0.1 0.08) //north,top + arc 13 14 (0.1 0 0.08) //east,top + arc 14 15 (0 -0.1 0.08) //south,top +); + +boundary +( + atmosphere + { + type patch; + faces + ( + (8 11 10 9) + (8 12 15 11) + (8 9 13 12) + (9 10 14 13) + (10 11 15 14) + ); + } + walls + { + type wall; + faces + ( + //Bottom + (0 1 2 3) + (0 3 7 4) + (4 5 1 0) + (2 1 5 6) + (2 6 7 3) + + //West + (15 12 4 7) + + //North + (12 13 5 4) + + //East + (13 14 6 5) + + //South + (14 15 7 6) + ); + } +); + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/polyMesh/blockMeshDict.m4 b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/polyMesh/blockMeshDict.m4 new file mode 100644 index 00000000..77e36a59 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/polyMesh/blockMeshDict.m4 @@ -0,0 +1,148 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + object blockMeshDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +// General m4 macros + +changecom(//)changequote([,]) dnl> +define(calc, [esyscmd(perl -e 'use Math::Trig; print ($1)')]) dnl> +define(VCOUNT, 0) +define(vlabel, [[// ]Vertex $1 = VCOUNT define($1, VCOUNT)define([VCOUNT], incr(VCOUNT))]) + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +// User-defined parameters +convertToMeters 1; + +define(cylRadius, 0.1) +define(cylHeight, 0.08) +define(sqSide, 0.1) +define(outletSize, 0.02) +define(outletStartZ, 0.04) +define(outletAngularPos, 2.5) //degrees from x-axis +define(sqCells1D, 8) +define(cylCellsRadial, 3) +define(cellsZ, 6) + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +// Derived parameters + +define(sqHalf, calc(sqSide/2)) +define(sq11x, calc(-sqHalf)) +define(sq11y, calc(sqHalf)) +define(sq1x, calc(sqHalf)) +define(sq1y, calc(sqHalf)) +define(sq5x, calc(sqHalf)) +define(sq5y, calc(-sqHalf)) +define(sq7x, calc(-sqHalf)) +define(sq7y, calc(-sqHalf)) +define(c11x, calc(-cylRadius*cos(pi/4))) +define(c11y, calc(cylRadius*sin(pi/4))) +define(c1x, calc(cylRadius*cos(pi/4))) +define(c1y, calc(cylRadius*sin(pi/4))) +define(c5x, calc(cylRadius*cos(pi/4))) +define(c5y, calc(-cylRadius*sin(pi/4))) +define(c7x, calc(-cylRadius*cos(pi/4))) +define(c7y, calc(-cylRadius*sin(pi/4))) +define(ipNy, calc(cylRadius)) +define(ipSy, calc(-cylRadius)) +define(ipWx, calc(-cylRadius)) +define(ipEx, calc(cylRadius)) + +vertices +( + (sq11x sq11y 0) //Square 11 o'clock,bottom //0 + (sq1x sq1y 0) //Square 1 o'clock,bottom //1 + (sq5x sq5y 0) //Square 5 o'clock,bottom //2 + (sq7x sq7y 0) //Square 7 o'clock,bottom //3 + (c11x c11y 0) //Cyl 11 o'clock,bottom //4 + (c1x c1y 0) //Cyl 1 o'clock,bottom //5 + (c5x c5y 0) //Cyl 5 o'clock,bottom //6 + (c7x c7y 0) //Cyl 7 o'clock,bottom //7 + + (sq11x sq11y cylHeight) //Square 11 o'clock,top //8 + (sq1x sq1y cylHeight) //Square 1 o'clock,top //9 + (sq5x sq5y cylHeight) //Square 5 o'clock,top //10 + (sq7x sq7y cylHeight) //Square 7 o'clock,top //11 + (c11x c11y cylHeight) //Cyl 11 o'clock,top //12 + (c1x c1y cylHeight) //Cyl 1 o'clock,top //13 + (c5x c5y cylHeight) //Cyl 5 o'clock,top //14 + (c7x c7y cylHeight) //Cyl 7 o'clock,top //15 + +); + +blocks +( + hex (3 2 1 0 11 10 9 8) (sqCells1D sqCells1D cellsZ) simpleGrading (1 1 1) //Mid-block + hex (7 3 0 4 15 11 8 12) (cylCellsRadial sqCells1D cellsZ) simpleGrading (1 1 1) //west-block + hex (0 1 5 4 8 9 13 12) (sqCells1D cylCellsRadial cellsZ) simpleGrading (1 1 1) //north-block + hex (2 6 5 1 10 14 13 9) (cylCellsRadial sqCells1D cellsZ) simpleGrading (1 1 1) //east-block + hex (7 6 2 3 15 14 10 11) (sqCells1D cylCellsRadial cellsZ) simpleGrading (1 1 1) //south-block +); + +edges +( + arc 7 4 (ipWx 0 0) //west,bottom + arc 4 5 (0 ipNy 0) //north,bottom + arc 5 6 (ipEx 0 0) //east,bottom + arc 6 7 (0 ipSy 0) //south,bottom + arc 15 12 (ipWx 0 cylHeight) //west,top + arc 12 13 (0 ipNy cylHeight) //north,top + arc 13 14 (ipEx 0 cylHeight) //east,top + arc 14 15 (0 ipSy cylHeight) //south,top +); + +boundary +( + atmosphere + { + type patch; + faces + ( + (8 11 10 9) + (8 12 15 11) + (8 9 13 12) + (9 10 14 13) + (10 11 15 14) + ); + } + walls + { + type wall; + faces + ( + //Bottom + (0 1 2 3) + (0 3 7 4) + (4 5 1 0) + (2 1 5 6) + (2 6 7 3) + + //West + (15 12 4 7) + + //North + (12 13 5 4) + + //East + (13 14 6 5) + + //South + (14 15 7 6) + ); + } +); + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/transportProperties b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/transportProperties new file mode 100644 index 00000000..1591b01b --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/transportProperties @@ -0,0 +1,52 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object transportProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +//Properties from https://www.jstage.jst.go.jp/article/tetsutohagane/100/8/100_925/_pdf +phases +( + iron + { + transportModel Newtonian; + nu nu [ 0 2 -1 0 0 0 0 ] 1.5e-07; + rho rho [ 1 -3 0 0 0 0 0 ] 6700; + } + + slag + { + transportModel Newtonian; + nu nu [ 0 2 -1 0 0 0 0 ] 1.5e-04; + rho rho [ 1 -3 0 0 0 0 0 ] 2600; + } + + air + { + transportModel Newtonian; + nu nu [ 0 2 -1 0 0 0 0 ] 1.3e-05; + rho rho [ 1 -3 0 0 0 0 0 ] 1.5; + } +); + +sigmas +( + (iron slag) 0.07 //?? + (iron air) 0.07 //?? + (slag air) 0.07 //?? + +); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/turbulenceProperties b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/turbulenceProperties new file mode 100644 index 00000000..9cfc50a3 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/constant/turbulenceProperties @@ -0,0 +1,21 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object turbulenceProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +simulationType laminar; + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/mesh.sh b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/mesh.sh new file mode 100755 index 00000000..50c8c98e --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/mesh.sh @@ -0,0 +1,7 @@ +#!/bin/bash +m4 constant/polyMesh/blockMeshDict.m4 > constant/polyMesh/blockMeshDict +m4 system/topoSetDict.m4 > system/topoSetDict +blockMesh +topoSet +createPatch -overwrite + diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/controlDict b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/controlDict new file mode 100644 index 00000000..0db39d4e --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/controlDict @@ -0,0 +1,70 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object controlDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +application pisoFoam; + +startFrom startTime; + +startTime 1; + +stopAt endTime; + +endTime 60; + +deltaT 0.005; + +writeControl adjustableRunTime; + +writeInterval 0.5; + +purgeWrite 0; + +writeFormat ascii; + +writePrecision 6; + +writeCompression uncompressed; + +timeFormat general; + +timePrecision 6; + +runTimeModifiable yes; + +adjustTimeStep no; + +maxCo 0.1; +maxAlphaCo 0.1; + + +libs ( + + ); + +functions +{ + +} + + + + + + + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/createPatchDict b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/createPatchDict new file mode 100644 index 00000000..90a82e7f --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/createPatchDict @@ -0,0 +1,32 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + object createPatchDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +pointSync false; + +patches +( + { + name outlet; + patchInfo + { + type patch; + } + constructFrom set; + set outlet; + } +); + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/decomposeParDict b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/decomposeParDict new file mode 100644 index 00000000..4de14078 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/decomposeParDict @@ -0,0 +1,86 @@ +/*-------------------------------*- C++ -*---------------------------------*\ +| ========= | +| \\ / OpenFOAM | +| \\ / | +| \\ / The Open Source CFD Toolbox | +| \\/ http://www.OpenFOAM.org | +\*-------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + note "mesh decomposition control dictionary"; + location "system"; + object decomposeParDict; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +numberOfSubdomains 4; + +//- Keep owner and neighbour on same processor for faces in zones: +// preserveFaceZones (heater solid1 solid3); + +//method scotch; +// method hierarchical; + method simple; +// method metis; +// method manual; + +simpleCoeffs +{ + n (2 2 1); + delta 0.001; +} + +hierarchicalCoeffs +{ + n (2 2 1); + delta 0.001; + order xyz; +} + +metisCoeffs +{ + /* + processorWeights + ( + 1 + 1 + 1 + 1 + ); + */ +} + +scotchCoeffs +{ + //processorWeights + //( + // 1 + // 1 + // 1 + // 1 + //); + //writeGraph true; + //strategy "b"; +} + +manualCoeffs +{ + dataFile "decompositionData"; +} + + +//// Is the case distributed +//distributed yes; +//// Per slave (so nProcs-1 entries) the directory above the case. +//roots +//( +// "/tmp" +// "/tmp" +//); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/funkySetFieldsDict b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/funkySetFieldsDict new file mode 100644 index 00000000..14e9b0da --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/funkySetFieldsDict @@ -0,0 +1,52 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object funkySetFieldsDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +initVariables +( + "initIronLevel=0.04;" + "initSlagLevel=0.07;" +); +expressions +( + initAir + { + variables $initVariables; + field alpha.air; + expression "1"; + condition "pos().z > initSlagLevel"; + keepPatches 1; //keep boundary conditions + } + + initIron + { + variables $initVariables; + field alpha.iron; + expression "1"; + condition "pos().z <= initIronLevel"; + keepPatches 1; //keep boundary conditions + } + + initSlag + { + variables $initVariables; + field alpha.slag; + expression "1"; + condition "pos().z > initIronLevel && pos().z <= initSlagLevel"; + keepPatches 1; //keep boundary conditions + } +); + +// ************************************************** *********************** // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/fvSchemes b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/fvSchemes new file mode 100644 index 00000000..4d2ff463 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/fvSchemes @@ -0,0 +1,68 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSchemes; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +ddtSchemes +{ + default Euler; +} + +gradSchemes +{ + default Gauss linear; + grad(U) Gauss linear; + grad(gamma) Gauss linear; +} + +divSchemes +{ + div(rhoPhi,U) Gauss upwind; + div(phi,alpha) Gauss vanLeer; + div(phirb,alpha) Gauss linear; + div((muEff*dev(T(grad(U))))) Gauss linear; + div((viscousTerm*dev2(grad(U).T()))) Gauss linear; + div(((grad(U)*rho)*dev(grad(U).T()))) Gauss linear; + div(((dev(grad(U).T())*rho)*dev(grad(U).T()))) Gauss linear; + div((((((alpha.water*rho)*nu.water)|(alpha.water*rho))*rho)*dev(grad(U).T()))) Gauss linear; + div(((nu*rho)*dev(grad(U).T()))) Gauss linear; + default Gauss linear; +} + +laplacianSchemes +{ + default Gauss linear corrected; +} + +interpolationSchemes +{ + default linear; +} + +snGradSchemes +{ + default corrected; +} + +fluxRequired +{ + default no; + pcorr; + p_rgh; + "alpha.*"; +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/fvSolution b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/fvSolution new file mode 100644 index 00000000..471c3d60 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/fvSolution @@ -0,0 +1,138 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSolution; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +solvers +{ + "alpha.*" + { + nAlphaSubCycles 1; + cAlpha 1; + } + + pcorr + { + solver PCG; + preconditioner + { + preconditioner GAMG; + tolerance 1e-05; + relTol 0; + smoother GaussSeidel; + nPreSweeps 0; + nPostSweeps 2; + nFinestSweeps 2; + cacheAgglomeration on; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + } + tolerance 1e-05; + relTol 0; + maxIter 100; + } + + p_rgh + { + solver GAMG; + tolerance 1e-07; + relTol 0.05; + smoother GaussSeidel; + nPreSweeps 0; + nPostSweeps 2; + nFinestSweeps 2; + cacheAgglomeration on; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + } + + "(p_rghFinal|pSmoothFinal)" + { + solver PCG; + preconditioner + { + preconditioner GAMG; + tolerance 1e-07; + relTol 0; + nVcycles 2; + smoother GaussSeidel; + nPreSweeps 0; + nPostSweeps 2; + nFinestSweeps 2; + cacheAgglomeration on; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + } + tolerance 1e-07; + relTol 0; + maxIter 20; + } + + "(k|epsilon|R|nuTilda)" + { + solver smoothSolver; + smoother GaussSeidel; + tolerance 1e-9; + relTol 0; + nSweeps 1; + } + + "(voidfraction|Us|Ksl|vSmoothField|sSmoothField|UsNext|voidfractionNext|pSmooth)" + { + solver PCG; + preconditioner DIC; + tolerance 1e-05; + relTol 0; + } + + U + { + solver smoothSolver; + smoother GaussSeidel; + tolerance 1e-08; + relTol 0.1; + nSweeps 1; + } + + UFinal + { + $U; + tolerance 1e-08; + relTol 0; + } + +} + +PIMPLE +{ + nCorrectors 2; + nNonOrthogonalCorrectors 0; +} + +relaxationFactors +{ + fields + { + } + equations + { + "U.*" 1; + } +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/setFieldsDict b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/setFieldsDict new file mode 100644 index 00000000..e284debd --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/setFieldsDict @@ -0,0 +1,53 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object setFieldsDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +defaultFieldValues +( + volScalarFieldValue alpha.air 1 + volScalarFieldValue alpha.iron 0 + volScalarFieldValue alpha.slag 0 +); + +regions +( + cylinderToCell + { + p1 (0 0 0); //center point, min + p2 (0 0 0.04); //center point, max + radius 0.1; + fieldValues + ( + volScalarFieldValue alpha.iron 1 + volScalarFieldValue alpha.air 0 + ); + } + + cylinderToCell + { + p1 (0 0 0.04); //center point, min + p2 (0 0 0.07); //center point, max + radius 0.1; + fieldValues + ( + volScalarFieldValue alpha.slag 1 + volScalarFieldValue alpha.air 0 + ); + } +); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/topoSetDict b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/topoSetDict new file mode 100644 index 00000000..3bc9d9ff --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/topoSetDict @@ -0,0 +1,75 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + object topoSetDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +// General m4 macros + + + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +// User-defined parameters + + + + + + //degrees from x-axis + + + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +// Derived parameters + + + +actions +( + { + name c_out; + type cellSet; + action new; + source boxToCell; + sourceInfo + { + box (0.0899048221581858 -0.0056380612634664 0.04)(0.109904822158186 0.0143619387365336 0.06); + } + } + + { + name outlet; + type faceSet; + action new; + source patchToFace; + sourceInfo + { + name "wall"; + } + } + + { + name outlet; + type faceSet; + action subset; + source cellToFace; + sourceInfo + { + set c_out; + option all; + } + } +); +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/topoSetDict.m4 b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/topoSetDict.m4 new file mode 100644 index 00000000..696444a5 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/CFD/system/topoSetDict.m4 @@ -0,0 +1,77 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + object topoSetDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +// General m4 macros + +changecom(//)changequote([,]) dnl> +define(calc, [esyscmd(perl -e 'use Math::Trig; print ($1)')]) dnl> +define(VCOUNT, 0) +define(vlabel, [[// ]Vertex $1 = VCOUNT define($1, VCOUNT)define([VCOUNT], incr(VCOUNT))]) + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +// User-defined parameters +define(cylRadius, 0.1) +define(cylHeight, 0.08) +define(sqSide, 0.1) +define(outletSize, 0.02) +define(outletStartZ, 0.04) +define(outletAngularPos, 2.5) //degrees from x-axis +define(sqCells1D, 8) +define(cylCellsRadial, 3) +define(cellsZ, 6) + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +// Derived parameters +define(midPointX, calc(cylRadius*cos(outletAngularPos*pi/180))) +define(midPointY, calc(cylRadius*sin(outletAngularPos*pi/180))) + +actions +( + { + name c_out; + type cellSet; + action new; + source boxToCell; + sourceInfo + { + box (calc(midPointX-0.5*outletSize) calc(midPointY-0.5*outletSize) outletStartZ)(calc(midPointX+0.5*outletSize) calc(midPointY+0.5*outletSize) calc(outletStartZ+1.0*outletSize)); + } + } + + { + name outlet; + type faceSet; + action new; + source patchToFace; + sourceInfo + { + name "wall"; + } + } + + { + name outlet; + type faceSet; + action subset; + source cellToFace; + sourceInfo + { + set c_out; + option all; + } + } +); +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/in.liggghts_run b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/in.liggghts_run new file mode 100644 index 00000000..710ffdf8 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/in.liggghts_run @@ -0,0 +1,142 @@ +############################################### +#geometry +variable cylRadius equal 0.1 +variable cylHeight equal 0.08 + +# Radiuses of servo wall for force calculation +variable r1 equal 0.02 +variable r2 equal 0.04 +variable r3 equal 0.06 +variable r4 equal 0.08 +variable r5 equal 0.1 + +#particle variables +variable rho equal 1500 # particle density + +# time parameters +variable dt equal 0.00005 # Time step +variable outInterval equal 0.5 # Dump interval to be consistent with controlDict + +# DEM-parameters +variable yM equal 5.e6 # Young's modulus +variable pR equal 0.45 # Poisson ratio +variable rest equal 0.3 # coefficient of restitution +variable fric equal 0.5 # coefficient of friction +variable cV equal 0.1 # characteristic velocity +variable skin equal 0.001 + +# variables for the servo wall +#Pressure acting on the servo wall (Pa) +variable p1 equal 800 +variable p2 equal 800 +variable p3 equal 800 +variable p4 equal 800 +variable p5 equal 800 + +variable A1 equal PI*${r1}^2 +variable A2 equal PI*(${r2}^2-${r1}^2) +variable A3 equal PI*(${r3}^2-${r2}^2) +variable A4 equal PI*(${r4}^2-${r3}^2) +variable A5 equal PI*(${r5}^2-${r4}^2) + +variable ctrlForceR1 equal -${p1}*${A1} # target value of the force +variable ctrlForceR2 equal -${p2}*${A2} # target value of the force +variable ctrlForceR3 equal -${p3}*${A3} # target value of the force +variable ctrlForceR4 equal -${p4}*${A4} # target value of the force +variable ctrlForceR5 equal -${p5}*${A5} # target value of the force + +variable maxVel equal 0.25*${skin}/${dt} + +# controller parameter (servo wall) +variable ctrlKp equal 1e-2 +variable ctrlKi equal 0.0 +variable ctrlKd equal 0.0 + +# particle settling loop parameters +variable vthre equal 0.01 + +# calculated parameters +variable dumpInterval equal ${outInterval}/${dt} + + +############################################### + +log ../DEM/log.liggghts +thermo_log ../DEM/post/thermo.txt + +atom_style granular +atom_modify map array +communicate single vel yes + +boundary f f f +newton off + +units si +processors 2 2 1 + +# read the restart file +read_restart ../DEM/post/restart/liggghts.restart + +neighbor ${skin} bin +neigh_modify delay 0 + +# Material properties required for granular pair styles + +fix m1 all property/global youngsModulus peratomtype ${yM} +fix m2 all property/global poissonsRatio peratomtype ${pR} +fix m3 all property/global coefficientRestitution peratomtypepair 1 ${rest} +fix m4 all property/global coefficientFriction peratomtypepair 1 ${fric} + +# pair style +pair_style gran model hertz tangential history # Hertzian without cohesion +pair_coeff * * + +# timestep, gravity +timestep ${dt} +fix gravi all gravity 9.81 vector 0.0 0.0 -1.0 + +# walls +fix cylWall all wall/gran model hertz tangential history primitive type 1 zcylinder 0.1 0 0 +fix botWall all wall/gran model hertz tangential history primitive type 1 zplane 0 + +fix servoR1 all mesh/surface/stress/servo file ../DEM/stls/r1.stl type 1 scale 1. com 0 0 0 ctrlPV force axis 0. 0. 1. target_val ${ctrlForceR1} vel_max ${maxVel} kp ${ctrlKp} ki ${ctrlKi} kd ${ctrlKd} #verbose no move 0.0 0.0 7.8 + +fix servoR2 all mesh/surface/stress/servo file ../DEM/stls/r2.stl type 1 scale 1. com 0 0 0 ctrlPV force axis 0. 0. 1. target_val ${ctrlForceR2} vel_max ${maxVel} kp ${ctrlKp} ki ${ctrlKi} kd ${ctrlKd} #verbose no move 0.0 0.0 7.8 + +fix servoR3 all mesh/surface/stress/servo file ../DEM/stls/r3.stl type 1 scale 1. com 0 0 0 ctrlPV force axis 0. 0. 1. target_val ${ctrlForceR3} vel_max ${maxVel} kp ${ctrlKp} ki ${ctrlKi} kd ${ctrlKd} #verbose no move 0.0 0.0 7.8 + +fix servoR4 all mesh/surface/stress/servo file ../DEM/stls/r4.stl type 1 scale 1. com 0 0 0 ctrlPV force axis 0. 0. 1. target_val ${ctrlForceR4} vel_max ${maxVel} kp ${ctrlKp} ki ${ctrlKi} kd ${ctrlKd} #verbose no move 0.0 0.0 7.8 + +fix servoR5 all mesh/surface/stress/servo file ../DEM/stls/r5.stl type 1 scale 1. com 0 0 0 ctrlPV force axis 0. 0. 1. target_val ${ctrlForceR5} vel_max ${maxVel} kp ${ctrlKp} ki ${ctrlKi} kd ${ctrlKd} #verbose no move 0.0 0.0 7.8 + +fix walls all wall/gran model hertz tangential history mesh n_meshes 5 meshes servoR1 servoR2 servoR3 servoR4 servoR5 + +# change the particles density +set group all density ${rho} + +# cfd coupling +fix cfd all couple/cfd couple_every 100000000 mpi +fix cfd2 all couple/cfd/force/implicit + +# apply nve integration to all particles that are inserted as single particles +fix integr all nve/sphere + +# center of mass +compute centerOfMass all com + +# compute total dragforce +compute dragtotal all reduce sum f_dragforce[1] f_dragforce[2] f_dragforce[3] + +# screen output +compute rke all erotate/sphere +thermo_style custom step atoms ke c_rke vol c_centerOfMass[3] c_dragtotal[1] c_dragtotal[2] c_dragtotal[3] +thermo 100 +thermo_modify lost ignore norm no +compute_modify thermo_temp dynamic yes + +#compute position all property/atom x y z +fix ts_check all check/timestep/gran 100 0.1 0.1 +dump dmp all custom ${dumpInterval} ../DEM/post/dump*.liggghts_run id type x y z vx vy vz fx fy fz f_dragforce[1] f_dragforce[2] f_dragforce[3] radius +dump servoWall all mesh/stl ${dumpInterval} ../DEM/post/dump*.servoWall.stl servoR1 servoR2 servoR3 servoR4 servoR5 + +run 1 diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/cone.stl b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/cone.stl new file mode 100644 index 00000000..eaba756f --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/cone.stl @@ -0,0 +1,4468 @@ +solid + facet normal 4.344248e-01 -3.492005e-01 -8.302615e-01 + outer loop + vertex 6.472136e-02 -4.702282e-02 6.666667e-03 + vertex 5.335134e-02 -4.531704e-02 0.000000e+00 + vertex 5.572651e-02 -4.236220e-02 0.000000e+00 + endloop + endfacet + facet normal 3.862302e-01 -3.951244e-01 -8.334884e-01 + outer loop + vertex 6.560718e-02 -6.160924e-02 1.333333e-02 + vertex 7.151095e-02 -6.990124e-02 2.000000e-02 + vertex 6.825531e-02 -7.308360e-02 2.000000e-02 + endloop + endfacet + facet normal 4.061136e-01 -3.792837e-01 -8.313938e-01 + outer loop + vertex 6.560718e-02 -6.160924e-02 1.333333e-02 + vertex 7.461837e-02 -6.657401e-02 2.000000e-02 + vertex 7.151095e-02 -6.990124e-02 2.000000e-02 + endloop + endfacet + facet normal 5.325177e-01 1.635081e-01 -8.304758e-01 + outer loop + vertex 7.748665e-02 1.989519e-02 6.666667e-03 + vertex 6.744850e-02 1.872698e-02 0.000000e+00 + vertex 6.633572e-02 2.235111e-02 0.000000e+00 + endloop + endfacet + facet normal 4.199111e-01 -3.578122e-01 -8.340534e-01 + outer loop + vertex 6.560718e-02 -6.160924e-02 1.333333e-02 + vertex 7.757113e-02 -6.310879e-02 2.000000e-02 + vertex 7.461837e-02 -6.657401e-02 2.000000e-02 + endloop + endfacet + facet normal 3.751038e-01 -3.994450e-01 -8.365051e-01 + outer loop + vertex 6.560718e-02 -6.160924e-02 1.333333e-02 + vertex 6.825531e-02 -7.308360e-02 2.000000e-02 + vertex 5.736816e-02 -6.934619e-02 1.333333e-02 + endloop + endfacet + facet normal 4.985173e-01 -2.472418e-01 -8.308743e-01 + outer loop + vertex 7.010453e-02 -3.854029e-02 6.666667e-03 + vertex 6.184584e-02 -3.278859e-02 0.000000e+00 + vertex 6.353028e-02 -2.939224e-02 0.000000e+00 + endloop + endfacet + facet normal 5.206442e-01 1.912752e-01 -8.320718e-01 + outer loop + vertex 7.438212e-02 2.944996e-02 6.666667e-03 + vertex 6.633572e-02 2.235111e-02 0.000000e+00 + vertex 6.502837e-02 2.590967e-02 0.000000e+00 + endloop + endfacet + facet normal 5.098565e-01 2.193243e-01 -8.318312e-01 + outer loop + vertex 7.438212e-02 2.944996e-02 6.666667e-03 + vertex 6.502837e-02 2.590967e-02 0.000000e+00 + vertex 6.353028e-02 2.939224e-02 0.000000e+00 + endloop + endfacet + facet normal 4.222964e-01 -3.493540e-01 -8.364314e-01 + outer loop + vertex 7.281153e-02 -5.290067e-02 1.333333e-02 + vertex 7.757113e-02 -6.310879e-02 2.000000e-02 + vertex 6.560718e-02 -6.160924e-02 1.333333e-02 + endloop + endfacet + facet normal 5.332135e-01 1.732516e-01 -8.280503e-01 + outer loop + vertex 7.438212e-02 2.944996e-02 6.666667e-03 + vertex 7.748665e-02 1.989519e-02 6.666667e-03 + vertex 6.633572e-02 2.235111e-02 0.000000e+00 + endloop + endfacet + facet normal 5.073876e-01 -2.387585e-01 -8.279808e-01 + outer loop + vertex 7.438212e-02 -2.944996e-02 6.666667e-03 + vertex 7.010453e-02 -3.854029e-02 6.666667e-03 + vertex 6.353028e-02 -2.939224e-02 0.000000e+00 + endloop + endfacet + facet normal 5.383146e-01 1.026890e-01 -8.364642e-01 + outer loop + vertex 8.717248e-02 2.238209e-02 1.333333e-02 + vertex 9.834617e-02 1.811162e-02 2.000000e-02 + vertex 8.929032e-02 1.127999e-02 1.333333e-02 + endloop + endfacet + facet normal 5.404341e-01 1.123035e-01 -8.338578e-01 + outer loop + vertex 8.717248e-02 2.238209e-02 1.333333e-02 + vertex 9.741991e-02 2.256904e-02 2.000000e-02 + vertex 9.834617e-02 1.811162e-02 2.000000e-02 + endloop + endfacet + facet normal 5.383626e-01 1.377056e-01 -8.313861e-01 + outer loop + vertex 8.717248e-02 2.238209e-02 1.333333e-02 + vertex 9.629173e-02 2.697968e-02 2.000000e-02 + vertex 9.741991e-02 2.256904e-02 2.000000e-02 + endloop + endfacet + facet normal 5.282548e-01 1.610655e-01 -8.336695e-01 + outer loop + vertex 8.717248e-02 2.238209e-02 1.333333e-02 + vertex 9.496397e-02 3.133440e-02 2.000000e-02 + vertex 9.629173e-02 2.697968e-02 2.000000e-02 + endloop + endfacet + facet normal 5.098565e-01 -2.193243e-01 -8.318312e-01 + outer loop + vertex 7.438212e-02 -2.944996e-02 6.666667e-03 + vertex 6.353028e-02 -2.939224e-02 0.000000e+00 + vertex 6.502837e-02 -2.590967e-02 0.000000e+00 + endloop + endfacet + facet normal 5.206442e-01 -1.912752e-01 -8.320718e-01 + outer loop + vertex 7.438212e-02 -2.944996e-02 6.666667e-03 + vertex 6.502837e-02 -2.590967e-02 0.000000e+00 + vertex 6.633572e-02 -2.235111e-02 0.000000e+00 + endloop + endfacet + facet normal 4.985173e-01 2.472418e-01 -8.308743e-01 + outer loop + vertex 7.010453e-02 3.854029e-02 6.666667e-03 + vertex 6.353028e-02 2.939224e-02 0.000000e+00 + vertex 6.184584e-02 3.278859e-02 0.000000e+00 + endloop + endfacet + facet normal 5.073876e-01 2.387585e-01 -8.279808e-01 + outer loop + vertex 7.010453e-02 3.854029e-02 6.666667e-03 + vertex 7.438212e-02 2.944996e-02 6.666667e-03 + vertex 6.353028e-02 2.939224e-02 0.000000e+00 + endloop + endfacet + facet normal 5.325177e-01 -1.635081e-01 -8.304758e-01 + outer loop + vertex 7.748665e-02 -1.989519e-02 6.666667e-03 + vertex 6.633572e-02 -2.235111e-02 0.000000e+00 + vertex 6.744850e-02 -1.872698e-02 0.000000e+00 + endloop + endfacet + facet normal 5.211638e-01 1.693364e-01 -8.364888e-01 + outer loop + vertex 8.367988e-02 3.313121e-02 1.333333e-02 + vertex 9.496397e-02 3.133440e-02 2.000000e-02 + vertex 8.717248e-02 2.238209e-02 1.333333e-02 + endloop + endfacet + facet normal 5.332135e-01 -1.732516e-01 -8.280503e-01 + outer loop + vertex 7.748665e-02 -1.989519e-02 6.666667e-03 + vertex 7.438212e-02 -2.944996e-02 6.666667e-03 + vertex 6.633572e-02 -2.235111e-02 0.000000e+00 + endloop + endfacet + facet normal 4.344248e-01 3.492005e-01 -8.302615e-01 + outer loop + vertex 6.472136e-02 4.702282e-02 6.666667e-03 + vertex 5.572651e-02 4.236220e-02 0.000000e+00 + vertex 5.335134e-02 4.531704e-02 0.000000e+00 + endloop + endfacet + facet normal 5.211638e-01 -1.693364e-01 -8.364888e-01 + outer loop + vertex 8.717248e-02 -2.238209e-02 1.333333e-02 + vertex 9.496397e-02 -3.133440e-02 2.000000e-02 + vertex 8.367988e-02 -3.313121e-02 1.333333e-02 + endloop + endfacet + facet normal 5.282548e-01 -1.610655e-01 -8.336695e-01 + outer loop + vertex 8.717248e-02 -2.238209e-02 1.333333e-02 + vertex 9.629173e-02 -2.697968e-02 2.000000e-02 + vertex 9.496397e-02 -3.133440e-02 2.000000e-02 + endloop + endfacet + facet normal 5.383626e-01 -1.377056e-01 -8.313861e-01 + outer loop + vertex 8.717248e-02 -2.238209e-02 1.333333e-02 + vertex 9.741991e-02 -2.256904e-02 2.000000e-02 + vertex 9.629173e-02 -2.697968e-02 2.000000e-02 + endloop + endfacet + facet normal 4.319368e-01 3.573292e-01 -8.280981e-01 + outer loop + vertex 5.831749e-02 5.476377e-02 6.666667e-03 + vertex 6.472136e-02 4.702282e-02 6.666667e-03 + vertex 5.335134e-02 4.531704e-02 0.000000e+00 + endloop + endfacet + facet normal 5.404341e-01 -1.123035e-01 -8.338578e-01 + outer loop + vertex 8.717248e-02 -2.238209e-02 1.333333e-02 + vertex 9.834617e-02 -1.811162e-02 2.000000e-02 + vertex 9.741991e-02 -2.256904e-02 2.000000e-02 + endloop + endfacet + facet normal 4.127500e-01 3.702946e-01 -8.321775e-01 + outer loop + vertex 5.831749e-02 5.476377e-02 6.666667e-03 + vertex 5.335134e-02 4.531704e-02 0.000000e+00 + vertex 5.081968e-02 4.813896e-02 0.000000e+00 + endloop + endfacet + facet normal 3.926074e-01 3.926074e-01 -8.316964e-01 + outer loop + vertex 5.831749e-02 5.476377e-02 6.666667e-03 + vertex 5.081968e-02 4.813896e-02 0.000000e+00 + vertex 4.813896e-02 5.081968e-02 0.000000e+00 + endloop + endfacet + facet normal 5.383146e-01 -1.026890e-01 -8.364642e-01 + outer loop + vertex 8.929032e-02 -1.127999e-02 1.333333e-02 + vertex 9.834617e-02 -1.811162e-02 2.000000e-02 + vertex 8.717248e-02 -2.238209e-02 1.333333e-02 + endloop + endfacet + facet normal 5.562092e-01 1.506733e-02 -8.309057e-01 + outer loop + vertex 7.485200e-02 4.709289e-03 3.333333e-03 + vertex 7.000000e-02 -1.714506e-17 0.000000e+00 + vertex 6.989734e-02 3.789724e-03 0.000000e+00 + endloop + endfacet + facet normal 3.838862e-01 4.087973e-01 -8.279591e-01 + outer loop + vertex 5.099392e-02 6.164106e-02 6.666667e-03 + vertex 5.831749e-02 5.476377e-02 6.666667e-03 + vertex 4.813896e-02 5.081968e-02 0.000000e+00 + endloop + endfacet + facet normal 5.518802e-01 4.493814e-02 -8.327117e-01 + outer loop + vertex 7.485200e-02 4.709289e-03 3.333333e-03 + vertex 6.989734e-02 3.789724e-03 0.000000e+00 + vertex 6.958966e-02 7.568331e-03 0.000000e+00 + endloop + endfacet + facet normal 5.524271e-01 5.221974e-02 -8.319239e-01 + outer loop + vertex 7.984214e-02 5.023242e-03 6.666667e-03 + vertex 7.936918e-02 1.002666e-02 6.666667e-03 + vertex 8.929032e-02 1.127999e-02 1.333333e-02 + endloop + endfacet + facet normal 5.524271e-01 5.221974e-02 -8.319239e-01 + outer loop + vertex 7.984214e-02 5.023242e-03 6.666667e-03 + vertex 7.485200e-02 4.709289e-03 3.333333e-03 + vertex 7.936918e-02 1.002666e-02 6.666667e-03 + endloop + endfacet + facet normal 3.714136e-01 4.139973e-01 -8.310585e-01 + outer loop + vertex 5.099392e-02 6.164106e-02 6.666667e-03 + vertex 4.813896e-02 5.081968e-02 0.000000e+00 + vertex 4.531704e-02 5.335134e-02 0.000000e+00 + endloop + endfacet + facet normal 5.546159e-01 1.742951e-02 -8.319239e-01 + outer loop + vertex 7.984214e-02 5.023242e-03 6.666667e-03 + vertex 7.000000e-02 -1.714506e-17 0.000000e+00 + vertex 7.485200e-02 4.709289e-03 3.333333e-03 + endloop + endfacet + facet normal 5.624791e-01 7.663624e-02 -8.232522e-01 + outer loop + vertex 7.340025e-02 1.540789e-02 3.333333e-03 + vertex 6.958966e-02 7.568331e-03 0.000000e+00 + vertex 6.907786e-02 1.132474e-02 0.000000e+00 + endloop + endfacet + facet normal 5.436772e-01 1.043225e-01 -8.327856e-01 + outer loop + vertex 7.340025e-02 1.540789e-02 3.333333e-03 + vertex 6.907786e-02 1.132474e-02 0.000000e+00 + vertex 6.836344e-02 1.504793e-02 0.000000e+00 + endloop + endfacet + facet normal 5.401871e-01 1.343385e-01 -8.307533e-01 + outer loop + vertex 7.340025e-02 1.540789e-02 3.333333e-03 + vertex 6.836344e-02 1.504793e-02 0.000000e+00 + vertex 6.744850e-02 1.872698e-02 0.000000e+00 + endloop + endfacet + facet normal 5.559978e-01 1.060623e-01 -8.243890e-01 + outer loop + vertex 7.340025e-02 1.540789e-02 3.333333e-03 + vertex 7.748665e-02 1.989519e-02 6.666667e-03 + vertex 7.936918e-02 1.002666e-02 6.666667e-03 + endloop + endfacet + facet normal 5.382144e-01 1.286072e-01 -8.329378e-01 + outer loop + vertex 7.340025e-02 1.540789e-02 3.333333e-03 + vertex 6.744850e-02 1.872698e-02 0.000000e+00 + vertex 7.748665e-02 1.989519e-02 6.666667e-03 + endloop + endfacet + facet normal 5.354116e-01 7.265300e-02 -8.414606e-01 + outer loop + vertex 7.340025e-02 1.540789e-02 3.333333e-03 + vertex 7.936918e-02 1.002666e-02 6.666667e-03 + vertex 7.485200e-02 4.709289e-03 3.333333e-03 + endloop + endfacet + facet normal 4.199111e-01 3.578122e-01 -8.340534e-01 + outer loop + vertex 6.560718e-02 6.160924e-02 1.333333e-02 + vertex 7.461837e-02 6.657401e-02 2.000000e-02 + vertex 7.757113e-02 6.310879e-02 2.000000e-02 + endloop + endfacet + facet normal 5.628305e-01 7.637363e-02 -8.230364e-01 + outer loop + vertex 7.340025e-02 1.540789e-02 3.333333e-03 + vertex 7.485200e-02 4.709289e-03 3.333333e-03 + vertex 6.958966e-02 7.568331e-03 0.000000e+00 + endloop + endfacet + facet normal 4.061136e-01 3.792837e-01 -8.313938e-01 + outer loop + vertex 6.560718e-02 6.160924e-02 1.333333e-02 + vertex 7.151095e-02 6.990124e-02 2.000000e-02 + vertex 7.461837e-02 6.657401e-02 2.000000e-02 + endloop + endfacet + facet normal 5.480581e-01 8.680388e-02 -8.319239e-01 + outer loop + vertex 8.349442e-02 1.592741e-02 1.000000e-02 + vertex 8.929032e-02 1.127999e-02 1.333333e-02 + vertex 7.936918e-02 1.002666e-02 6.666667e-03 + endloop + endfacet + facet normal 3.862302e-01 3.951244e-01 -8.334884e-01 + outer loop + vertex 6.560718e-02 6.160924e-02 1.333333e-02 + vertex 6.825531e-02 7.308360e-02 2.000000e-02 + vertex 7.151095e-02 6.990124e-02 2.000000e-02 + endloop + endfacet + facet normal 5.331657e-01 1.017068e-01 -8.398750e-01 + outer loop + vertex 8.349442e-02 1.592741e-02 1.000000e-02 + vertex 7.936918e-02 1.002666e-02 6.666667e-03 + vertex 7.748665e-02 1.989519e-02 6.666667e-03 + endloop + endfacet + facet normal 5.585323e-01 1.065457e-01 -8.226115e-01 + outer loop + vertex 8.349442e-02 1.592741e-02 1.000000e-02 + vertex 8.717248e-02 2.238209e-02 1.333333e-02 + vertex 8.929032e-02 1.127999e-02 1.333333e-02 + endloop + endfacet + facet normal 5.507126e-01 1.253923e-02 -8.346007e-01 + outer loop + vertex 9.481254e-02 5.965099e-03 1.666667e-02 + vertex 9.989637e-02 4.551460e-03 2.000000e-02 + vertex 1.000000e-01 -2.449294e-17 2.000000e-02 + endloop + endfacet + facet normal 4.222964e-01 3.493540e-01 -8.364314e-01 + outer loop + vertex 6.560718e-02 6.160924e-02 1.333333e-02 + vertex 7.757113e-02 6.310879e-02 2.000000e-02 + vertex 7.281153e-02 5.290067e-02 1.333333e-02 + endloop + endfacet + facet normal 5.552889e-01 3.798280e-02 -8.307897e-01 + outer loop + vertex 9.481254e-02 5.965099e-03 1.666667e-02 + vertex 9.958568e-02 9.093486e-03 2.000000e-02 + vertex 9.989637e-02 4.551460e-03 2.000000e-02 + endloop + endfacet + facet normal 5.562997e-01 7.056887e-02 -8.279799e-01 + outer loop + vertex 9.465219e-02 8.121790e-03 1.666667e-02 + vertex 8.929032e-02 1.127999e-02 1.333333e-02 + vertex 9.834617e-02 1.811162e-02 2.000000e-02 + endloop + endfacet + facet normal 5.502009e-01 6.289895e-02 -8.326600e-01 + outer loop + vertex 9.465219e-02 8.121790e-03 1.666667e-02 + vertex 9.906859e-02 1.361666e-02 2.000000e-02 + vertex 9.958568e-02 9.093486e-03 2.000000e-02 + endloop + endfacet + facet normal 5.304842e-01 8.525885e-02 -8.433964e-01 + outer loop + vertex 9.465219e-02 8.121790e-03 1.666667e-02 + vertex 9.834617e-02 1.811162e-02 2.000000e-02 + vertex 9.906859e-02 1.361666e-02 2.000000e-02 + endloop + endfacet + facet normal 5.537893e-01 4.117478e-02 -8.316382e-01 + outer loop + vertex 9.465219e-02 8.121790e-03 1.666667e-02 + vertex 9.958568e-02 9.093486e-03 2.000000e-02 + vertex 9.481254e-02 5.965099e-03 1.666667e-02 + endloop + endfacet + facet normal 5.250188e-01 1.348019e-01 -8.403474e-01 + outer loop + vertex 8.083980e-02 2.626644e-02 1.000000e-02 + vertex 8.717248e-02 2.238209e-02 1.333333e-02 + vertex 8.349442e-02 1.592741e-02 1.000000e-02 + endloop + endfacet + facet normal 5.162143e-01 1.677282e-01 -8.398750e-01 + outer loop + vertex 8.083980e-02 2.626644e-02 1.000000e-02 + vertex 7.748665e-02 1.989519e-02 6.666667e-03 + vertex 7.438212e-02 2.944996e-02 6.666667e-03 + endloop + endfacet + facet normal 2.744826e-01 4.854872e-01 -8.300370e-01 + outer loop + vertex 4.286614e-02 6.754623e-02 6.666667e-03 + vertex 3.608877e-02 5.998000e-02 0.000000e+00 + vertex 3.278859e-02 6.184584e-02 0.000000e+00 + endloop + endfacet + facet normal 5.407744e-01 1.757082e-01 -8.226115e-01 + outer loop + vertex 8.083980e-02 2.626644e-02 1.000000e-02 + vertex 8.367988e-02 3.313121e-02 1.333333e-02 + vertex 8.717248e-02 2.238209e-02 1.333333e-02 + endloop + endfacet + facet normal 5.499784e-01 1.412105e-01 -8.231545e-01 + outer loop + vertex 8.083980e-02 2.626644e-02 1.000000e-02 + vertex 8.349442e-02 1.592741e-02 1.000000e-02 + vertex 7.748665e-02 1.989519e-02 6.666667e-03 + endloop + endfacet + facet normal 5.279433e-01 2.090275e-01 -8.231545e-01 + outer loop + vertex 7.691030e-02 3.619124e-02 1.000000e-02 + vertex 8.083980e-02 2.626644e-02 1.000000e-02 + vertex 7.438212e-02 2.944996e-02 6.666667e-03 + endloop + endfacet + facet normal 5.039837e-01 1.995413e-01 -8.403474e-01 + outer loop + vertex 7.691030e-02 3.619124e-02 1.000000e-02 + vertex 8.367988e-02 3.313121e-02 1.333333e-02 + vertex 8.083980e-02 2.626644e-02 1.000000e-02 + endloop + endfacet + facet normal 4.911219e-01 2.311044e-01 -8.398750e-01 + outer loop + vertex 7.691030e-02 3.619124e-02 1.000000e-02 + vertex 7.438212e-02 2.944996e-02 6.666667e-03 + vertex 7.010453e-02 3.854029e-02 6.666667e-03 + endloop + endfacet + facet normal 3.683470e-01 4.128556e-01 -8.329890e-01 + outer loop + vertex 5.736816e-02 6.934619e-02 1.333333e-02 + vertex 6.485821e-02 7.611447e-02 2.000000e-02 + vertex 6.825531e-02 7.308360e-02 2.000000e-02 + endloop + endfacet + facet normal 5.144881e-01 2.420997e-01 -8.226115e-01 + outer loop + vertex 7.691030e-02 3.619124e-02 1.000000e-02 + vertex 7.886760e-02 4.335783e-02 1.333333e-02 + vertex 8.367988e-02 3.313121e-02 1.333333e-02 + endloop + endfacet + facet normal 3.506200e-01 4.309699e-01 -8.314629e-01 + outer loop + vertex 5.736816e-02 6.934619e-02 1.333333e-02 + vertex 6.132668e-02 7.898759e-02 2.000000e-02 + vertex 6.485821e-02 7.611447e-02 2.000000e-02 + endloop + endfacet + facet normal 4.525522e-01 3.181876e-01 -8.330385e-01 + outer loop + vertex 6.252898e-02 4.141409e-02 3.333333e-03 + vertex 5.572651e-02 4.236220e-02 0.000000e+00 + vertex 6.472136e-02 4.702282e-02 6.666667e-03 + endloop + endfacet + facet normal 3.277551e-01 4.425843e-01 -8.346830e-01 + outer loop + vertex 5.736816e-02 6.934619e-02 1.333333e-02 + vertex 5.766803e-02 8.169699e-02 2.000000e-02 + vertex 6.132668e-02 7.898759e-02 2.000000e-02 + endloop + endfacet + facet normal 4.744450e-01 2.843717e-01 -8.330874e-01 + outer loop + vertex 6.252898e-02 4.141409e-02 3.333333e-03 + vertex 7.010453e-02 3.854029e-02 6.666667e-03 + vertex 6.184584e-02 3.278859e-02 0.000000e+00 + endloop + endfacet + facet normal 4.937651e-01 2.791628e-01 -8.235679e-01 + outer loop + vertex 6.252898e-02 4.141409e-02 3.333333e-03 + vertex 6.184584e-02 3.278859e-02 0.000000e+00 + vertex 5.998000e-02 3.608877e-02 0.000000e+00 + endloop + endfacet + facet normal 4.663617e-01 2.980926e-01 -8.328550e-01 + outer loop + vertex 6.252898e-02 4.141409e-02 3.333333e-03 + vertex 5.998000e-02 3.608877e-02 0.000000e+00 + vertex 5.793823e-02 3.928309e-02 0.000000e+00 + endloop + endfacet + facet normal 3.751038e-01 3.994450e-01 -8.365051e-01 + outer loop + vertex 5.736816e-02 6.934619e-02 1.333333e-02 + vertex 6.825531e-02 7.308360e-02 2.000000e-02 + vertex 6.560718e-02 6.160924e-02 1.333333e-02 + endloop + endfacet + facet normal 4.522879e-01 3.248780e-01 -8.305961e-01 + outer loop + vertex 6.252898e-02 4.141409e-02 3.333333e-03 + vertex 5.793823e-02 3.928309e-02 0.000000e+00 + vertex 5.572651e-02 4.236220e-02 0.000000e+00 + endloop + endfacet + facet normal 4.778065e-01 3.032252e-01 -8.244728e-01 + outer loop + vertex 6.252898e-02 4.141409e-02 3.333333e-03 + vertex 6.472136e-02 4.702282e-02 6.666667e-03 + vertex 7.010453e-02 3.854029e-02 6.666667e-03 + endloop + endfacet + facet normal 5.058280e-01 1.797713e-01 -8.436944e-01 + outer loop + vertex 8.689205e-02 3.840275e-02 1.666667e-02 + vertex 9.343938e-02 3.562417e-02 2.000000e-02 + vertex 9.496397e-02 3.133440e-02 2.000000e-02 + endloop + endfacet + facet normal 5.126521e-01 2.089372e-01 -8.327863e-01 + outer loop + vertex 8.689205e-02 3.840275e-02 1.666667e-02 + vertex 9.172113e-02 3.984011e-02 2.000000e-02 + vertex 9.343938e-02 3.562417e-02 2.000000e-02 + endloop + endfacet + facet normal 5.045332e-01 2.329413e-01 -8.313751e-01 + outer loop + vertex 8.689205e-02 3.840275e-02 1.666667e-02 + vertex 8.981277e-02 4.397347e-02 2.000000e-02 + vertex 9.172113e-02 3.984011e-02 2.000000e-02 + endloop + endfacet + facet normal 4.820386e-01 2.497723e-01 -8.397932e-01 + outer loop + vertex 8.689205e-02 3.840275e-02 1.666667e-02 + vertex 8.771826e-02 4.801569e-02 2.000000e-02 + vertex 8.981277e-02 4.397347e-02 2.000000e-02 + endloop + endfacet + facet normal 4.973653e-01 2.457544e-01 -8.320051e-01 + outer loop + vertex 8.689205e-02 3.840275e-02 1.666667e-02 + vertex 7.886760e-02 4.335783e-02 1.333333e-02 + vertex 8.771826e-02 4.801569e-02 2.000000e-02 + endloop + endfacet + facet normal 5.218550e-01 2.055191e-01 -8.279066e-01 + outer loop + vertex 8.689205e-02 3.840275e-02 1.666667e-02 + vertex 9.496397e-02 3.133440e-02 2.000000e-02 + vertex 8.367988e-02 3.313121e-02 1.333333e-02 + endloop + endfacet + facet normal 4.915851e-01 2.313224e-01 -8.395439e-01 + outer loop + vertex 8.689205e-02 3.840275e-02 1.666667e-02 + vertex 8.367988e-02 3.313121e-02 1.333333e-02 + vertex 7.886760e-02 4.335783e-02 1.333333e-02 + endloop + endfacet + facet normal 4.975822e-01 2.735481e-01 -8.231545e-01 + outer loop + vertex 7.176787e-02 4.554528e-02 1.000000e-02 + vertex 7.691030e-02 3.619124e-02 1.000000e-02 + vertex 7.010453e-02 3.854029e-02 6.666667e-03 + endloop + endfacet + facet normal 2.463110e-01 4.966405e-01 -8.322735e-01 + outer loop + vertex 3.406234e-02 7.238616e-02 6.666667e-03 + vertex 3.278859e-02 6.184584e-02 0.000000e+00 + vertex 2.939224e-02 6.353028e-02 0.000000e+00 + endloop + endfacet + facet normal 4.750005e-01 2.611337e-01 -8.403474e-01 + outer loop + vertex 7.176787e-02 4.554528e-02 1.000000e-02 + vertex 7.886760e-02 4.335783e-02 1.333333e-02 + vertex 7.691030e-02 3.619124e-02 1.000000e-02 + endloop + endfacet + facet normal 2.194898e-01 5.102412e-01 -8.315517e-01 + outer loop + vertex 3.406234e-02 7.238616e-02 6.666667e-03 + vertex 2.939224e-02 6.353028e-02 0.000000e+00 + vertex 2.590967e-02 6.502837e-02 0.000000e+00 + endloop + endfacet + facet normal 4.800881e-01 3.046732e-01 -8.226115e-01 + outer loop + vertex 7.176787e-02 4.554528e-02 1.000000e-02 + vertex 7.281153e-02 5.290067e-02 1.333333e-02 + vertex 7.886760e-02 4.335783e-02 1.333333e-02 + endloop + endfacet + facet normal 4.582842e-01 2.908360e-01 -8.398750e-01 + outer loop + vertex 7.176787e-02 4.554528e-02 1.000000e-02 + vertex 7.010453e-02 3.854029e-02 6.666667e-03 + vertex 6.472136e-02 4.702282e-02 6.666667e-03 + endloop + endfacet + facet normal 4.381168e-01 3.624417e-01 -8.226115e-01 + outer loop + vertex 6.549363e-02 5.418104e-02 1.000000e-02 + vertex 6.560718e-02 6.160924e-02 1.333333e-02 + vertex 7.281153e-02 5.290067e-02 1.333333e-02 + endloop + endfacet + facet normal 2.700229e-01 4.911698e-01 -8.281545e-01 + outer loop + vertex 3.406234e-02 7.238616e-02 6.666667e-03 + vertex 4.286614e-02 6.754623e-02 6.666667e-03 + vertex 3.278859e-02 6.184584e-02 0.000000e+00 + endloop + endfacet + facet normal 4.385262e-01 3.186080e-01 -8.403474e-01 + outer loop + vertex 6.549363e-02 5.418104e-02 1.000000e-02 + vertex 7.281153e-02 5.290067e-02 1.333333e-02 + vertex 7.176787e-02 4.554528e-02 1.000000e-02 + endloop + endfacet + facet normal 4.593740e-01 3.337547e-01 -8.231545e-01 + outer loop + vertex 6.549363e-02 5.418104e-02 1.000000e-02 + vertex 7.176787e-02 4.554528e-02 1.000000e-02 + vertex 6.472136e-02 4.702282e-02 6.666667e-03 + endloop + endfacet + facet normal 3.222807e-01 4.435813e-01 -8.362839e-01 + outer loop + vertex 4.822441e-02 7.598951e-02 1.333333e-02 + vertex 5.766803e-02 8.169699e-02 2.000000e-02 + vertex 5.736816e-02 6.934619e-02 1.333333e-02 + endloop + endfacet + facet normal 4.182191e-01 3.459809e-01 -8.398750e-01 + outer loop + vertex 6.549363e-02 5.418104e-02 1.000000e-02 + vertex 6.472136e-02 4.702282e-02 6.666667e-03 + vertex 5.831749e-02 5.476377e-02 6.666667e-03 + endloop + endfacet + facet normal 3.093690e-01 4.601633e-01 -8.321902e-01 + outer loop + vertex 4.822441e-02 7.598951e-02 1.333333e-02 + vertex 5.388986e-02 8.423706e-02 2.000000e-02 + vertex 5.766803e-02 8.169699e-02 2.000000e-02 + endloop + endfacet + facet normal 4.694729e-01 2.710503e-01 -8.403136e-01 + outer loop + vertex 7.907961e-02 5.264423e-02 1.666667e-02 + vertex 8.544194e-02 5.195840e-02 2.000000e-02 + vertex 8.771826e-02 4.801569e-02 2.000000e-02 + endloop + endfacet + facet normal 4.679210e-01 2.993480e-01 -8.315291e-01 + outer loop + vertex 7.907961e-02 5.264423e-02 1.666667e-02 + vertex 8.298853e-02 5.579340e-02 2.000000e-02 + vertex 8.544194e-02 5.195840e-02 2.000000e-02 + endloop + endfacet + facet normal 4.525757e-01 3.194628e-01 -8.325375e-01 + outer loop + vertex 7.907961e-02 5.264423e-02 1.666667e-02 + vertex 8.036311e-02 5.951277e-02 2.000000e-02 + vertex 8.298853e-02 5.579340e-02 2.000000e-02 + endloop + endfacet + facet normal 4.247597e-01 3.297873e-01 -8.431012e-01 + outer loop + vertex 7.907961e-02 5.264423e-02 1.666667e-02 + vertex 7.757113e-02 6.310879e-02 2.000000e-02 + vertex 8.036311e-02 5.951277e-02 2.000000e-02 + endloop + endfacet + facet normal 4.538247e-01 3.291853e-01 -8.280581e-01 + outer loop + vertex 7.907961e-02 5.264423e-02 1.666667e-02 + vertex 7.281153e-02 5.290067e-02 1.333333e-02 + vertex 7.757113e-02 6.310879e-02 2.000000e-02 + endloop + endfacet + facet normal 4.584693e-01 2.909535e-01 -8.397332e-01 + outer loop + vertex 7.907961e-02 5.264423e-02 1.666667e-02 + vertex 7.886760e-02 4.335783e-02 1.333333e-02 + vertex 7.281153e-02 5.290067e-02 1.333333e-02 + endloop + endfacet + facet normal 4.750230e-01 2.876655e-01 -8.316259e-01 + outer loop + vertex 7.907961e-02 5.264423e-02 1.666667e-02 + vertex 8.771826e-02 4.801569e-02 2.000000e-02 + vertex 7.886760e-02 4.335783e-02 1.333333e-02 + endloop + endfacet + facet normal 3.715584e-01 3.956695e-01 -8.398750e-01 + outer loop + vertex 5.818650e-02 6.196233e-02 1.000000e-02 + vertex 5.831749e-02 5.476377e-02 6.666667e-03 + vertex 5.099392e-02 6.164106e-02 6.666667e-03 + endloop + endfacet + facet normal 3.892361e-01 4.144944e-01 -8.226115e-01 + outer loop + vertex 5.818650e-02 6.196233e-02 1.000000e-02 + vertex 5.736816e-02 6.934619e-02 1.333333e-02 + vertex 6.560718e-02 6.160924e-02 1.333333e-02 + endloop + endfacet + facet normal 4.139211e-01 3.886978e-01 -8.231545e-01 + outer loop + vertex 5.818650e-02 6.196233e-02 1.000000e-02 + vertex 6.549363e-02 5.418104e-02 1.000000e-02 + vertex 5.831749e-02 5.476377e-02 6.666667e-03 + endloop + endfacet + facet normal 3.951362e-01 3.710576e-01 -8.403474e-01 + outer loop + vertex 5.818650e-02 6.196233e-02 1.000000e-02 + vertex 6.560718e-02 6.160924e-02 1.333333e-02 + vertex 6.549363e-02 5.418104e-02 1.000000e-02 + endloop + endfacet + facet normal 3.029675e-01 4.627032e-01 -8.331365e-01 + outer loop + vertex 4.282575e-02 6.157073e-02 3.333333e-03 + vertex 3.608877e-02 5.998000e-02 0.000000e+00 + vertex 4.286614e-02 6.754623e-02 6.666667e-03 + endloop + endfacet + facet normal 3.550852e-01 4.417458e-01 -8.238781e-01 + outer loop + vertex 4.282575e-02 6.157073e-02 3.333333e-03 + vertex 4.531704e-02 5.335134e-02 0.000000e+00 + vertex 4.236220e-02 5.572651e-02 0.000000e+00 + endloop + endfacet + facet normal 1.917085e-01 5.218237e-01 -8.312328e-01 + outer loop + vertex 2.472136e-02 7.608452e-02 6.666667e-03 + vertex 2.590967e-02 6.502837e-02 0.000000e+00 + vertex 2.235111e-02 6.633572e-02 0.000000e+00 + endloop + endfacet + facet normal 3.228468e-01 4.494600e-01 -8.329199e-01 + outer loop + vertex 4.282575e-02 6.157073e-02 3.333333e-03 + vertex 4.236220e-02 5.572651e-02 0.000000e+00 + vertex 3.928309e-02 5.793823e-02 0.000000e+00 + endloop + endfacet + facet normal 3.000452e-01 4.694166e-01 -8.304342e-01 + outer loop + vertex 4.282575e-02 6.157073e-02 3.333333e-03 + vertex 3.928309e-02 5.793823e-02 0.000000e+00 + vertex 3.608877e-02 5.998000e-02 0.000000e+00 + endloop + endfacet + facet normal 3.361132e-01 4.396561e-01 -8.329048e-01 + outer loop + vertex 4.282575e-02 6.157073e-02 3.333333e-03 + vertex 5.099392e-02 6.164106e-02 6.666667e-03 + vertex 4.531704e-02 5.335134e-02 0.000000e+00 + endloop + endfacet + facet normal 3.325528e-01 4.577197e-01 -8.245613e-01 + outer loop + vertex 4.282575e-02 6.157073e-02 3.333333e-03 + vertex 4.286614e-02 6.754623e-02 6.666667e-03 + vertex 5.099392e-02 6.164106e-02 6.666667e-03 + endloop + endfacet + facet normal 2.064471e-01 5.214259e-01 -8.279460e-01 + outer loop + vertex 2.472136e-02 7.608452e-02 6.666667e-03 + vertex 3.406234e-02 7.238616e-02 6.666667e-03 + vertex 2.590967e-02 6.502837e-02 0.000000e+00 + endloop + endfacet + facet normal 3.455146e-01 4.176553e-01 -8.403474e-01 + outer loop + vertex 4.996175e-02 6.876644e-02 1.000000e-02 + vertex 5.736816e-02 6.934619e-02 1.333333e-02 + vertex 5.818650e-02 6.196233e-02 1.000000e-02 + endloop + endfacet + facet normal 3.190380e-01 4.391181e-01 -8.398750e-01 + outer loop + vertex 4.996175e-02 6.876644e-02 1.000000e-02 + vertex 5.099392e-02 6.164106e-02 6.666667e-03 + vertex 4.286614e-02 6.754623e-02 6.666667e-03 + endloop + endfacet + facet normal 3.619405e-01 4.375109e-01 -8.231545e-01 + outer loop + vertex 4.996175e-02 6.876644e-02 1.000000e-02 + vertex 5.818650e-02 6.196233e-02 1.000000e-02 + vertex 5.099392e-02 6.164106e-02 6.666667e-03 + endloop + endfacet + facet normal 3.342170e-01 4.600102e-01 -8.226115e-01 + outer loop + vertex 4.996175e-02 6.876644e-02 1.000000e-02 + vertex 4.822441e-02 7.598951e-02 1.333333e-02 + vertex 5.736816e-02 6.934619e-02 1.333333e-02 + endloop + endfacet + facet normal 2.904440e-01 4.576665e-01 -8.403474e-01 + outer loop + vertex 4.094906e-02 7.448607e-02 1.000000e-02 + vertex 4.822441e-02 7.598951e-02 1.333333e-02 + vertex 4.996175e-02 6.876644e-02 1.000000e-02 + endloop + endfacet + facet normal 2.614862e-01 4.756416e-01 -8.398750e-01 + outer loop + vertex 4.094906e-02 7.448607e-02 1.000000e-02 + vertex 4.286614e-02 6.754623e-02 6.666667e-03 + vertex 3.406234e-02 7.238616e-02 6.666667e-03 + endloop + endfacet + facet normal 3.042518e-01 4.794241e-01 -8.231545e-01 + outer loop + vertex 4.094906e-02 7.448607e-02 1.000000e-02 + vertex 4.996175e-02 6.876644e-02 1.000000e-02 + vertex 4.286614e-02 6.754623e-02 6.666667e-03 + endloop + endfacet + facet normal 2.739270e-01 4.982713e-01 -8.226115e-01 + outer loop + vertex 4.094906e-02 7.448607e-02 1.000000e-02 + vertex 3.832014e-02 8.143443e-02 1.333333e-02 + vertex 4.822441e-02 7.598951e-02 1.333333e-02 + endloop + endfacet + facet normal 2.093170e-01 5.286745e-01 -8.226115e-01 + outer loop + vertex 3.129059e-02 7.903100e-02 1.000000e-02 + vertex 2.781153e-02 8.559509e-02 1.333333e-02 + vertex 3.832014e-02 8.143443e-02 1.333333e-02 + endloop + endfacet + facet normal 2.417649e-01 5.137766e-01 -8.231545e-01 + outer loop + vertex 3.129059e-02 7.903100e-02 1.000000e-02 + vertex 4.094906e-02 7.448607e-02 1.000000e-02 + vertex 3.406234e-02 7.238616e-02 6.666667e-03 + endloop + endfacet + facet normal 2.307929e-01 4.904599e-01 -8.403474e-01 + outer loop + vertex 3.129059e-02 7.903100e-02 1.000000e-02 + vertex 3.832014e-02 8.143443e-02 1.333333e-02 + vertex 4.094906e-02 7.448607e-02 1.000000e-02 + endloop + endfacet + facet normal 1.998106e-01 5.046639e-01 -8.398750e-01 + outer loop + vertex 3.129059e-02 7.903100e-02 1.000000e-02 + vertex 3.406234e-02 7.238616e-02 6.666667e-03 + vertex 2.472136e-02 7.608452e-02 6.666667e-03 + endloop + endfacet + facet normal 1.662288e-01 5.413785e-01 -8.241828e-01 + outer loop + vertex 1.707358e-02 7.303077e-02 3.333333e-03 + vertex 2.235111e-02 6.633572e-02 0.000000e+00 + vertex 1.872698e-02 6.744850e-02 0.000000e+00 + endloop + endfacet + facet normal 1.335329e-01 5.369476e-01 -8.329803e-01 + outer loop + vertex 1.707358e-02 7.303077e-02 3.333333e-03 + vertex 1.872698e-02 6.744850e-02 0.000000e+00 + vertex 1.504793e-02 6.836344e-02 0.000000e+00 + endloop + endfacet + facet normal 1.050329e-01 5.473793e-01 -8.302675e-01 + outer loop + vertex 1.707358e-02 7.303077e-02 3.333333e-03 + vertex 1.504793e-02 6.836344e-02 0.000000e+00 + vertex 1.132474e-02 6.907786e-02 0.000000e+00 + endloop + endfacet + facet normal 1.501409e-01 5.329478e-01 -8.327210e-01 + outer loop + vertex 1.707358e-02 7.303077e-02 3.333333e-03 + vertex 2.472136e-02 7.608452e-02 6.666667e-03 + vertex 2.235111e-02 6.633572e-02 0.000000e+00 + endloop + endfacet + facet normal 1.406682e-01 5.478663e-01 -8.246545e-01 + outer loop + vertex 1.707358e-02 7.303077e-02 3.333333e-03 + vertex 1.499051e-02 7.858298e-02 6.666667e-03 + vertex 2.472136e-02 7.608452e-02 6.666667e-03 + endloop + endfacet + facet normal 2.782805e-01 4.809094e-01 -8.314362e-01 + outer loop + vertex 4.401312e-02 8.418934e-02 1.666667e-02 + vertex 5.388986e-02 8.423706e-02 2.000000e-02 + vertex 4.822441e-02 7.598951e-02 1.333333e-02 + endloop + endfacet + facet normal 2.397003e-01 5.066815e-01 -8.281411e-01 + outer loop + vertex 4.401312e-02 8.418934e-02 1.666667e-02 + vertex 3.832014e-02 8.143443e-02 1.333333e-02 + vertex 3.774192e-02 9.260425e-02 2.000000e-02 + endloop + endfacet + facet normal 2.814533e-01 4.628302e-01 -8.405785e-01 + outer loop + vertex 4.401312e-02 8.418934e-02 1.666667e-02 + vertex 5.000000e-02 8.660254e-02 2.000000e-02 + vertex 5.388986e-02 8.423706e-02 2.000000e-02 + endloop + endfacet + facet normal 2.666585e-01 4.871494e-01 -8.316121e-01 + outer loop + vertex 4.401312e-02 8.418934e-02 1.666667e-02 + vertex 4.600650e-02 8.878852e-02 2.000000e-02 + vertex 5.000000e-02 8.660254e-02 2.000000e-02 + endloop + endfacet + facet normal 2.436776e-01 4.976946e-01 -8.324190e-01 + outer loop + vertex 4.401312e-02 8.418934e-02 1.666667e-02 + vertex 4.191765e-02 9.079048e-02 2.000000e-02 + vertex 4.600650e-02 8.878852e-02 2.000000e-02 + endloop + endfacet + facet normal 2.144246e-01 4.936550e-01 -8.428089e-01 + outer loop + vertex 4.401312e-02 8.418934e-02 1.666667e-02 + vertex 3.774192e-02 9.260425e-02 2.000000e-02 + vertex 4.191765e-02 9.079048e-02 2.000000e-02 + endloop + endfacet + facet normal 2.017816e-01 5.096422e-01 -8.363905e-01 + outer loop + vertex 2.781153e-02 8.559509e-02 1.333333e-02 + vertex 3.774192e-02 9.260425e-02 2.000000e-02 + vertex 3.832014e-02 8.143443e-02 1.333333e-02 + endloop + endfacet + facet normal 2.615256e-01 4.757133e-01 -8.398221e-01 + outer loop + vertex 4.401312e-02 8.418934e-02 1.666667e-02 + vertex 4.822441e-02 7.598951e-02 1.333333e-02 + vertex 3.832014e-02 8.143443e-02 1.333333e-02 + endloop + endfacet + facet normal 1.964235e-01 5.152033e-01 -8.342561e-01 + outer loop + vertex 2.781153e-02 8.559509e-02 1.333333e-02 + vertex 3.348796e-02 9.422609e-02 2.000000e-02 + vertex 3.774192e-02 9.260425e-02 2.000000e-02 + endloop + endfacet + facet normal 1.047750e-01 5.476379e-01 -8.301294e-01 + outer loop + vertex 1.109017e-02 7.417552e-02 3.333333e-03 + vertex 1.707358e-02 7.303077e-02 3.333333e-03 + vertex 1.132474e-02 6.907786e-02 0.000000e+00 + endloop + endfacet + facet normal 1.741129e-01 5.276775e-01 -8.314091e-01 + outer loop + vertex 2.781153e-02 8.559509e-02 1.333333e-02 + vertex 2.916459e-02 9.565263e-02 2.000000e-02 + vertex 3.348796e-02 9.422609e-02 2.000000e-02 + endloop + endfacet + facet normal 1.033486e-01 5.401825e-01 -8.351778e-01 + outer loop + vertex 1.109017e-02 7.417552e-02 3.333333e-03 + vertex 1.499051e-02 7.858298e-02 6.666667e-03 + vertex 1.707358e-02 7.303077e-02 3.333333e-03 + endloop + endfacet + facet normal 1.491434e-01 5.322997e-01 -8.333146e-01 + outer loop + vertex 2.781153e-02 8.559509e-02 1.333333e-02 + vertex 2.478078e-02 9.688092e-02 2.000000e-02 + vertex 2.916459e-02 9.565263e-02 2.000000e-02 + endloop + endfacet + facet normal 7.087519e-02 5.610349e-01 -8.247524e-01 + outer loop + vertex 1.109017e-02 7.417552e-02 3.333333e-03 + vertex 5.023242e-03 7.984214e-02 6.666667e-03 + vertex 1.499051e-02 7.858298e-02 6.666667e-03 + endloop + endfacet + facet normal 7.468450e-02 5.481540e-01 -8.330362e-01 + outer loop + vertex 1.109017e-02 7.417552e-02 3.333333e-03 + vertex 1.132474e-02 6.907786e-02 0.000000e+00 + vertex 7.568331e-03 6.958966e-02 0.000000e+00 + endloop + endfacet + facet normal 4.592677e-02 5.640215e-01 -8.244820e-01 + outer loop + vertex 1.109017e-02 7.417552e-02 3.333333e-03 + vertex 7.568331e-03 6.958966e-02 0.000000e+00 + vertex 3.789724e-03 6.989734e-02 0.000000e+00 + endloop + endfacet + facet normal 5.723149e-02 5.510062e-01 -8.325363e-01 + outer loop + vertex 1.109017e-02 7.417552e-02 3.333333e-03 + vertex 3.789724e-03 6.989734e-02 0.000000e+00 + vertex 5.023242e-03 7.984214e-02 6.666667e-03 + endloop + endfacet + facet normal 1.675021e-01 5.155185e-01 -8.403474e-01 + outer loop + vertex 2.113864e-02 8.232957e-02 1.000000e-02 + vertex 2.781153e-02 8.559509e-02 1.333333e-02 + vertex 3.129059e-02 7.903100e-02 1.000000e-02 + endloop + endfacet + facet normal 1.754652e-01 5.400265e-01 -8.231545e-01 + outer loop + vertex 2.113864e-02 8.232957e-02 1.000000e-02 + vertex 3.129059e-02 7.903100e-02 1.000000e-02 + vertex 2.472136e-02 7.608452e-02 6.666667e-03 + endloop + endfacet + facet normal 1.349839e-01 5.257274e-01 -8.398750e-01 + outer loop + vertex 2.113864e-02 8.232957e-02 1.000000e-02 + vertex 2.472136e-02 7.608452e-02 6.666667e-03 + vertex 1.499051e-02 7.858298e-02 6.666667e-03 + endloop + endfacet + facet normal 1.414060e-01 5.507401e-01 -8.226115e-01 + outer loop + vertex 2.113864e-02 8.232957e-02 1.000000e-02 + vertex 1.686432e-02 8.840585e-02 1.333333e-02 + vertex 2.781153e-02 8.559509e-02 1.333333e-02 + endloop + endfacet + facet normal 7.126496e-02 5.641202e-01 -8.226115e-01 + outer loop + vertex 1.065332e-02 8.432975e-02 1.000000e-02 + vertex 5.651147e-03 8.982241e-02 1.333333e-02 + vertex 1.686432e-02 8.840585e-02 1.333333e-02 + endloop + endfacet + facet normal 1.063984e-01 5.577598e-01 -8.231545e-01 + outer loop + vertex 1.065332e-02 8.432975e-02 1.000000e-02 + vertex 2.113864e-02 8.232957e-02 1.000000e-02 + vertex 1.499051e-02 7.858298e-02 6.666667e-03 + endloop + endfacet + facet normal 1.015697e-01 5.324471e-01 -8.403474e-01 + outer loop + vertex 1.065332e-02 8.432975e-02 1.000000e-02 + vertex 1.686432e-02 8.840585e-02 1.333333e-02 + vertex 2.113864e-02 8.232957e-02 1.000000e-02 + endloop + endfacet + facet normal 6.802835e-02 5.384999e-01 -8.398750e-01 + outer loop + vertex 1.065332e-02 8.432975e-02 1.000000e-02 + vertex 1.499051e-02 7.858298e-02 6.666667e-03 + vertex 5.023242e-03 7.984214e-02 6.666667e-03 + endloop + endfacet + facet normal 0.000000e+00 5.686038e-01 -8.226115e-01 + outer loop + vertex 2.407854e-17 8.500000e-02 1.000000e-02 + vertex -5.651147e-03 8.982241e-02 1.333333e-02 + vertex 5.651147e-03 8.982241e-02 1.333333e-02 + endloop + endfacet + facet normal 1.504744e-02 5.554749e-01 -8.313971e-01 + outer loop + vertex 5.023242e-03 7.984214e-02 6.666667e-03 + vertex 3.789724e-03 6.989734e-02 0.000000e+00 + vertex -2.679998e-17 7.000000e-02 0.000000e+00 + endloop + endfacet + facet normal 0.000000e+00 5.427798e-01 -8.398750e-01 + outer loop + vertex 2.407854e-17 8.500000e-02 1.000000e-02 + vertex 5.023242e-03 7.984214e-02 6.666667e-03 + vertex -5.023242e-03 7.984214e-02 6.666667e-03 + endloop + endfacet + facet normal 3.565355e-02 5.666970e-01 -8.231545e-01 + outer loop + vertex 2.407854e-17 8.500000e-02 1.000000e-02 + vertex 1.065332e-02 8.432975e-02 1.000000e-02 + vertex 5.023242e-03 7.984214e-02 6.666667e-03 + endloop + endfacet + facet normal 3.403549e-02 5.409786e-01 -8.403474e-01 + outer loop + vertex 2.407854e-17 8.500000e-02 1.000000e-02 + vertex 5.651147e-03 8.982241e-02 1.333333e-02 + vertex 1.065332e-02 8.432975e-02 1.000000e-02 + endloop + endfacet + facet normal -7.087519e-02 5.610349e-01 -8.247524e-01 + outer loop + vertex -1.109017e-02 7.417552e-02 3.333333e-03 + vertex -1.499051e-02 7.858298e-02 6.666667e-03 + vertex -5.023242e-03 7.984214e-02 6.666667e-03 + endloop + endfacet + facet normal 1.362688e-01 5.307318e-01 -8.365133e-01 + outer loop + vertex 1.686432e-02 8.840585e-02 1.333333e-02 + vertex 2.478078e-02 9.688092e-02 2.000000e-02 + vertex 2.781153e-02 8.559509e-02 1.333333e-02 + endloop + endfacet + facet normal -4.592677e-02 5.640215e-01 -8.244820e-01 + outer loop + vertex -1.109017e-02 7.417552e-02 3.333333e-03 + vertex -3.789724e-03 6.989734e-02 0.000000e+00 + vertex -7.568331e-03 6.958966e-02 0.000000e+00 + endloop + endfacet + facet normal 1.248180e-01 5.387807e-01 -8.331481e-01 + outer loop + vertex 1.686432e-02 8.840585e-02 1.333333e-02 + vertex 2.034560e-02 9.790841e-02 2.000000e-02 + vertex 2.478078e-02 9.688092e-02 2.000000e-02 + endloop + endfacet + facet normal -5.723149e-02 5.510062e-01 -8.325363e-01 + outer loop + vertex -1.109017e-02 7.417552e-02 3.333333e-03 + vertex -5.023242e-03 7.984214e-02 6.666667e-03 + vertex -3.789724e-03 6.989734e-02 0.000000e+00 + endloop + endfacet + facet normal 1.006329e-01 5.464371e-01 -8.314322e-01 + outer loop + vertex 1.686432e-02 8.840585e-02 1.333333e-02 + vertex 1.586825e-02 9.873297e-02 2.000000e-02 + vertex 2.034560e-02 9.790841e-02 2.000000e-02 + endloop + endfacet + facet normal -7.468450e-02 5.481540e-01 -8.330362e-01 + outer loop + vertex -1.109017e-02 7.417552e-02 3.333333e-03 + vertex -7.568331e-03 6.958966e-02 0.000000e+00 + vertex -1.132474e-02 6.907786e-02 0.000000e+00 + endloop + endfacet + facet normal 7.503591e-02 5.459268e-01 -8.344660e-01 + outer loop + vertex 1.686432e-02 8.840585e-02 1.333333e-02 + vertex 1.135802e-02 9.935288e-02 2.000000e-02 + vertex 1.586825e-02 9.873297e-02 2.000000e-02 + endloop + endfacet + facet normal -1.406682e-01 5.478663e-01 -8.246545e-01 + outer loop + vertex -1.707358e-02 7.303077e-02 3.333333e-03 + vertex -2.472136e-02 7.608452e-02 6.666667e-03 + vertex -1.499051e-02 7.858298e-02 6.666667e-03 + endloop + endfacet + facet normal -1.501409e-01 5.329478e-01 -8.327210e-01 + outer loop + vertex -1.707358e-02 7.303077e-02 3.333333e-03 + vertex -2.235111e-02 6.633572e-02 0.000000e+00 + vertex -2.472136e-02 7.608452e-02 6.666667e-03 + endloop + endfacet + facet normal -1.033486e-01 5.401825e-01 -8.351778e-01 + outer loop + vertex -1.707358e-02 7.303077e-02 3.333333e-03 + vertex -1.499051e-02 7.858298e-02 6.666667e-03 + vertex -1.109017e-02 7.417552e-02 3.333333e-03 + endloop + endfacet + facet normal -1.047750e-01 5.476379e-01 -8.301294e-01 + outer loop + vertex -1.707358e-02 7.303077e-02 3.333333e-03 + vertex -1.109017e-02 7.417552e-02 3.333333e-03 + vertex -1.132474e-02 6.907786e-02 0.000000e+00 + endloop + endfacet + facet normal -1.050329e-01 5.473793e-01 -8.302675e-01 + outer loop + vertex -1.707358e-02 7.303077e-02 3.333333e-03 + vertex -1.132474e-02 6.907786e-02 0.000000e+00 + vertex -1.504793e-02 6.836344e-02 0.000000e+00 + endloop + endfacet + facet normal -1.335329e-01 5.369476e-01 -8.329803e-01 + outer loop + vertex -1.707358e-02 7.303077e-02 3.333333e-03 + vertex -1.504793e-02 6.836344e-02 0.000000e+00 + vertex -1.872698e-02 6.744850e-02 0.000000e+00 + endloop + endfacet + facet normal -1.662288e-01 5.413785e-01 -8.241828e-01 + outer loop + vertex -1.707358e-02 7.303077e-02 3.333333e-03 + vertex -1.872698e-02 6.744850e-02 0.000000e+00 + vertex -2.235111e-02 6.633572e-02 0.000000e+00 + endloop + endfacet + facet normal -6.802835e-02 5.384999e-01 -8.398750e-01 + outer loop + vertex -1.065332e-02 8.432975e-02 1.000000e-02 + vertex -5.023242e-03 7.984214e-02 6.666667e-03 + vertex -1.499051e-02 7.858298e-02 6.666667e-03 + endloop + endfacet + facet normal -3.403549e-02 5.409786e-01 -8.403474e-01 + outer loop + vertex -1.065332e-02 8.432975e-02 1.000000e-02 + vertex -5.651147e-03 8.982241e-02 1.333333e-02 + vertex 2.407854e-17 8.500000e-02 1.000000e-02 + endloop + endfacet + facet normal -7.126496e-02 5.641202e-01 -8.226115e-01 + outer loop + vertex -1.065332e-02 8.432975e-02 1.000000e-02 + vertex -1.686432e-02 8.840585e-02 1.333333e-02 + vertex -5.651147e-03 8.982241e-02 1.333333e-02 + endloop + endfacet + facet normal -3.565355e-02 5.666970e-01 -8.231545e-01 + outer loop + vertex -1.065332e-02 8.432975e-02 1.000000e-02 + vertex 2.407854e-17 8.500000e-02 1.000000e-02 + vertex -5.023242e-03 7.984214e-02 6.666667e-03 + endloop + endfacet + facet normal -3.332666e-02 5.593984e-01 -8.282287e-01 + outer loop + vertex -1.903040e-03 9.498094e-02 1.666667e-02 + vertex -5.651147e-03 8.982241e-02 1.333333e-02 + vertex -1.135802e-02 9.935288e-02 2.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 5.427301e-01 -8.399071e-01 + outer loop + vertex -1.903040e-03 9.498094e-02 1.666667e-02 + vertex 5.651147e-03 8.982241e-02 1.333333e-02 + vertex -5.651147e-03 8.982241e-02 1.333333e-02 + endloop + endfacet + facet normal -1.504744e-02 5.554749e-01 -8.313971e-01 + outer loop + vertex -5.023242e-03 7.984214e-02 6.666667e-03 + vertex -2.679998e-17 7.000000e-02 0.000000e+00 + vertex -3.789724e-03 6.989734e-02 0.000000e+00 + endloop + endfacet + facet normal 2.463585e-02 5.407126e-01 -8.408466e-01 + outer loop + vertex -1.903040e-03 9.498094e-02 1.666667e-02 + vertex 2.276320e-03 9.997409e-02 2.000000e-02 + vertex 6.824241e-03 9.976688e-02 2.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 5.552266e-01 -8.316991e-01 + outer loop + vertex -1.903040e-03 9.498094e-02 1.666667e-02 + vertex -2.276320e-03 9.997409e-02 2.000000e-02 + vertex 2.276320e-03 9.997409e-02 2.000000e-02 + endloop + endfacet + facet normal -2.522961e-02 5.537445e-01 -8.323043e-01 + outer loop + vertex -1.903040e-03 9.498094e-02 1.666667e-02 + vertex -6.824241e-03 9.976688e-02 2.000000e-02 + vertex -2.276320e-03 9.997409e-02 2.000000e-02 + endloop + endfacet + facet normal -4.898350e-02 5.364340e-01 -8.425195e-01 + outer loop + vertex -1.903040e-03 9.498094e-02 1.666667e-02 + vertex -1.135802e-02 9.935288e-02 2.000000e-02 + vertex -6.824241e-03 9.976688e-02 2.000000e-02 + endloop + endfacet + facet normal 1.271821e-02 5.557584e-01 -8.312465e-01 + outer loop + vertex -1.903040e-03 9.498094e-02 1.666667e-02 + vertex 6.824241e-03 9.976688e-02 2.000000e-02 + vertex 5.651147e-03 8.982241e-02 1.333333e-02 + endloop + endfacet + facet normal 0.000000e+00 5.608142e-01 -8.279417e-01 + outer loop + vertex -5.023242e-03 7.984214e-02 6.666667e-03 + vertex 5.023242e-03 7.984214e-02 6.666667e-03 + vertex -2.679998e-17 7.000000e-02 0.000000e+00 + endloop + endfacet + facet normal -1.349839e-01 5.257274e-01 -8.398750e-01 + outer loop + vertex -2.113864e-02 8.232957e-02 1.000000e-02 + vertex -1.499051e-02 7.858298e-02 6.666667e-03 + vertex -2.472136e-02 7.608452e-02 6.666667e-03 + endloop + endfacet + facet normal -1.414060e-01 5.507401e-01 -8.226115e-01 + outer loop + vertex -2.113864e-02 8.232957e-02 1.000000e-02 + vertex -2.781153e-02 8.559509e-02 1.333333e-02 + vertex -1.686432e-02 8.840585e-02 1.333333e-02 + endloop + endfacet + facet normal 5.040688e-02 5.520219e-01 -8.323046e-01 + outer loop + vertex 5.651147e-03 8.982241e-02 1.333333e-02 + vertex 6.824241e-03 9.976688e-02 2.000000e-02 + vertex 1.135802e-02 9.935288e-02 2.000000e-02 + endloop + endfacet + facet normal -1.063984e-01 5.577598e-01 -8.231545e-01 + outer loop + vertex -2.113864e-02 8.232957e-02 1.000000e-02 + vertex -1.065332e-02 8.432975e-02 1.000000e-02 + vertex -1.499051e-02 7.858298e-02 6.666667e-03 + endloop + endfacet + facet normal -1.015697e-01 5.324471e-01 -8.403474e-01 + outer loop + vertex -2.113864e-02 8.232957e-02 1.000000e-02 + vertex -1.686432e-02 8.840585e-02 1.333333e-02 + vertex -1.065332e-02 8.432975e-02 1.000000e-02 + endloop + endfacet + facet normal -1.998106e-01 5.046639e-01 -8.398750e-01 + outer loop + vertex -3.129059e-02 7.903100e-02 1.000000e-02 + vertex -2.472136e-02 7.608452e-02 6.666667e-03 + vertex -3.406234e-02 7.238616e-02 6.666667e-03 + endloop + endfacet + facet normal -2.093170e-01 5.286745e-01 -8.226115e-01 + outer loop + vertex -3.129059e-02 7.903100e-02 1.000000e-02 + vertex -3.832014e-02 8.143443e-02 1.333333e-02 + vertex -2.781153e-02 8.559509e-02 1.333333e-02 + endloop + endfacet + facet normal -1.754652e-01 5.400265e-01 -8.231545e-01 + outer loop + vertex -3.129059e-02 7.903100e-02 1.000000e-02 + vertex -2.113864e-02 8.232957e-02 1.000000e-02 + vertex -2.472136e-02 7.608452e-02 6.666667e-03 + endloop + endfacet + facet normal 6.870882e-02 5.438863e-01 -8.363413e-01 + outer loop + vertex 5.651147e-03 8.982241e-02 1.333333e-02 + vertex 1.135802e-02 9.935288e-02 2.000000e-02 + vertex 1.686432e-02 8.840585e-02 1.333333e-02 + endloop + endfacet + facet normal -1.675021e-01 5.155185e-01 -8.403474e-01 + outer loop + vertex -3.129059e-02 7.903100e-02 1.000000e-02 + vertex -2.781153e-02 8.559509e-02 1.333333e-02 + vertex -2.113864e-02 8.232957e-02 1.000000e-02 + endloop + endfacet + facet normal -3.361132e-01 4.396561e-01 -8.329048e-01 + outer loop + vertex -4.282575e-02 6.157073e-02 3.333333e-03 + vertex -4.531704e-02 5.335134e-02 0.000000e+00 + vertex -5.099392e-02 6.164106e-02 6.666667e-03 + endloop + endfacet + facet normal -3.029675e-01 4.627032e-01 -8.331365e-01 + outer loop + vertex -4.282575e-02 6.157073e-02 3.333333e-03 + vertex -4.286614e-02 6.754623e-02 6.666667e-03 + vertex -3.608877e-02 5.998000e-02 0.000000e+00 + endloop + endfacet + facet normal -3.325528e-01 4.577197e-01 -8.245613e-01 + outer loop + vertex -4.282575e-02 6.157073e-02 3.333333e-03 + vertex -5.099392e-02 6.164106e-02 6.666667e-03 + vertex -4.286614e-02 6.754623e-02 6.666667e-03 + endloop + endfacet + facet normal -3.000452e-01 4.694166e-01 -8.304342e-01 + outer loop + vertex -4.282575e-02 6.157073e-02 3.333333e-03 + vertex -3.608877e-02 5.998000e-02 0.000000e+00 + vertex -3.928309e-02 5.793823e-02 0.000000e+00 + endloop + endfacet + facet normal -3.228468e-01 4.494600e-01 -8.329199e-01 + outer loop + vertex -4.282575e-02 6.157073e-02 3.333333e-03 + vertex -3.928309e-02 5.793823e-02 0.000000e+00 + vertex -4.236220e-02 5.572651e-02 0.000000e+00 + endloop + endfacet + facet normal -3.550852e-01 4.417458e-01 -8.238781e-01 + outer loop + vertex -4.282575e-02 6.157073e-02 3.333333e-03 + vertex -4.236220e-02 5.572651e-02 0.000000e+00 + vertex -4.531704e-02 5.335134e-02 0.000000e+00 + endloop + endfacet + facet normal -2.739270e-01 4.982713e-01 -8.226115e-01 + outer loop + vertex -4.094906e-02 7.448607e-02 1.000000e-02 + vertex -4.822441e-02 7.598951e-02 1.333333e-02 + vertex -3.832014e-02 8.143443e-02 1.333333e-02 + endloop + endfacet + facet normal -2.614862e-01 4.756416e-01 -8.398750e-01 + outer loop + vertex -4.094906e-02 7.448607e-02 1.000000e-02 + vertex -3.406234e-02 7.238616e-02 6.666667e-03 + vertex -4.286614e-02 6.754623e-02 6.666667e-03 + endloop + endfacet + facet normal -2.417649e-01 5.137766e-01 -8.231545e-01 + outer loop + vertex -4.094906e-02 7.448607e-02 1.000000e-02 + vertex -3.129059e-02 7.903100e-02 1.000000e-02 + vertex -3.406234e-02 7.238616e-02 6.666667e-03 + endloop + endfacet + facet normal -2.307929e-01 4.904599e-01 -8.403474e-01 + outer loop + vertex -4.094906e-02 7.448607e-02 1.000000e-02 + vertex -3.832014e-02 8.143443e-02 1.333333e-02 + vertex -3.129059e-02 7.903100e-02 1.000000e-02 + endloop + endfacet + facet normal -2.615256e-01 4.757133e-01 -8.398221e-01 + outer loop + vertex -4.401312e-02 8.418934e-02 1.666667e-02 + vertex -3.832014e-02 8.143443e-02 1.333333e-02 + vertex -4.822441e-02 7.598951e-02 1.333333e-02 + endloop + endfacet + facet normal -2.144246e-01 4.936550e-01 -8.428089e-01 + outer loop + vertex -4.401312e-02 8.418934e-02 1.666667e-02 + vertex -4.191765e-02 9.079048e-02 2.000000e-02 + vertex -3.774192e-02 9.260425e-02 2.000000e-02 + endloop + endfacet + facet normal -2.436776e-01 4.976946e-01 -8.324190e-01 + outer loop + vertex -4.401312e-02 8.418934e-02 1.666667e-02 + vertex -4.600650e-02 8.878852e-02 2.000000e-02 + vertex -4.191765e-02 9.079048e-02 2.000000e-02 + endloop + endfacet + facet normal -2.666585e-01 4.871494e-01 -8.316121e-01 + outer loop + vertex -4.401312e-02 8.418934e-02 1.666667e-02 + vertex -5.000000e-02 8.660254e-02 2.000000e-02 + vertex -4.600650e-02 8.878852e-02 2.000000e-02 + endloop + endfacet + facet normal -2.814533e-01 4.628302e-01 -8.405785e-01 + outer loop + vertex -4.401312e-02 8.418934e-02 1.666667e-02 + vertex -5.388986e-02 8.423706e-02 2.000000e-02 + vertex -5.000000e-02 8.660254e-02 2.000000e-02 + endloop + endfacet + facet normal -2.397003e-01 5.066815e-01 -8.281411e-01 + outer loop + vertex -4.401312e-02 8.418934e-02 1.666667e-02 + vertex -3.774192e-02 9.260425e-02 2.000000e-02 + vertex -3.832014e-02 8.143443e-02 1.333333e-02 + endloop + endfacet + facet normal -2.782805e-01 4.809094e-01 -8.314362e-01 + outer loop + vertex -4.401312e-02 8.418934e-02 1.666667e-02 + vertex -4.822441e-02 7.598951e-02 1.333333e-02 + vertex -5.388986e-02 8.423706e-02 2.000000e-02 + endloop + endfacet + facet normal -3.342170e-01 4.600102e-01 -8.226115e-01 + outer loop + vertex -4.996175e-02 6.876644e-02 1.000000e-02 + vertex -5.736816e-02 6.934619e-02 1.333333e-02 + vertex -4.822441e-02 7.598951e-02 1.333333e-02 + endloop + endfacet + facet normal -3.190380e-01 4.391181e-01 -8.398750e-01 + outer loop + vertex -4.996175e-02 6.876644e-02 1.000000e-02 + vertex -4.286614e-02 6.754623e-02 6.666667e-03 + vertex -5.099392e-02 6.164106e-02 6.666667e-03 + endloop + endfacet + facet normal -2.904440e-01 4.576665e-01 -8.403474e-01 + outer loop + vertex -4.996175e-02 6.876644e-02 1.000000e-02 + vertex -4.822441e-02 7.598951e-02 1.333333e-02 + vertex -4.094906e-02 7.448607e-02 1.000000e-02 + endloop + endfacet + facet normal -3.042518e-01 4.794241e-01 -8.231545e-01 + outer loop + vertex -4.996175e-02 6.876644e-02 1.000000e-02 + vertex -4.094906e-02 7.448607e-02 1.000000e-02 + vertex -4.286614e-02 6.754623e-02 6.666667e-03 + endloop + endfacet + facet normal -3.455146e-01 4.176553e-01 -8.403474e-01 + outer loop + vertex -5.818650e-02 6.196233e-02 1.000000e-02 + vertex -5.736816e-02 6.934619e-02 1.333333e-02 + vertex -4.996175e-02 6.876644e-02 1.000000e-02 + endloop + endfacet + facet normal -3.892361e-01 4.144944e-01 -8.226115e-01 + outer loop + vertex -5.818650e-02 6.196233e-02 1.000000e-02 + vertex -6.560718e-02 6.160924e-02 1.333333e-02 + vertex -5.736816e-02 6.934619e-02 1.333333e-02 + endloop + endfacet + facet normal -3.715584e-01 3.956695e-01 -8.398750e-01 + outer loop + vertex -5.818650e-02 6.196233e-02 1.000000e-02 + vertex -5.099392e-02 6.164106e-02 6.666667e-03 + vertex -5.831749e-02 5.476377e-02 6.666667e-03 + endloop + endfacet + facet normal -3.619405e-01 4.375109e-01 -8.231545e-01 + outer loop + vertex -5.818650e-02 6.196233e-02 1.000000e-02 + vertex -4.996175e-02 6.876644e-02 1.000000e-02 + vertex -5.099392e-02 6.164106e-02 6.666667e-03 + endloop + endfacet + facet normal -4.778065e-01 3.032252e-01 -8.244728e-01 + outer loop + vertex -6.252898e-02 4.141409e-02 3.333333e-03 + vertex -7.010453e-02 3.854029e-02 6.666667e-03 + vertex -6.472136e-02 4.702282e-02 6.666667e-03 + endloop + endfacet + facet normal -4.525522e-01 3.181876e-01 -8.330385e-01 + outer loop + vertex -6.252898e-02 4.141409e-02 3.333333e-03 + vertex -6.472136e-02 4.702282e-02 6.666667e-03 + vertex -5.572651e-02 4.236220e-02 0.000000e+00 + endloop + endfacet + facet normal -4.744450e-01 2.843717e-01 -8.330874e-01 + outer loop + vertex -6.252898e-02 4.141409e-02 3.333333e-03 + vertex -6.184584e-02 3.278859e-02 0.000000e+00 + vertex -7.010453e-02 3.854029e-02 6.666667e-03 + endloop + endfacet + facet normal -4.522879e-01 3.248780e-01 -8.305961e-01 + outer loop + vertex -6.252898e-02 4.141409e-02 3.333333e-03 + vertex -5.572651e-02 4.236220e-02 0.000000e+00 + vertex -5.793823e-02 3.928309e-02 0.000000e+00 + endloop + endfacet + facet normal -4.663617e-01 2.980926e-01 -8.328550e-01 + outer loop + vertex -6.252898e-02 4.141409e-02 3.333333e-03 + vertex -5.793823e-02 3.928309e-02 0.000000e+00 + vertex -5.998000e-02 3.608877e-02 0.000000e+00 + endloop + endfacet + facet normal -4.937651e-01 2.791628e-01 -8.235679e-01 + outer loop + vertex -6.252898e-02 4.141409e-02 3.333333e-03 + vertex -5.998000e-02 3.608877e-02 0.000000e+00 + vertex -6.184584e-02 3.278859e-02 0.000000e+00 + endloop + endfacet + facet normal -1.917085e-01 5.218237e-01 -8.312328e-01 + outer loop + vertex -2.472136e-02 7.608452e-02 6.666667e-03 + vertex -2.235111e-02 6.633572e-02 0.000000e+00 + vertex -2.590967e-02 6.502837e-02 0.000000e+00 + endloop + endfacet + facet normal -4.381168e-01 3.624417e-01 -8.226115e-01 + outer loop + vertex -6.549363e-02 5.418104e-02 1.000000e-02 + vertex -7.281153e-02 5.290067e-02 1.333333e-02 + vertex -6.560718e-02 6.160924e-02 1.333333e-02 + endloop + endfacet + facet normal -4.182191e-01 3.459809e-01 -8.398750e-01 + outer loop + vertex -6.549363e-02 5.418104e-02 1.000000e-02 + vertex -5.831749e-02 5.476377e-02 6.666667e-03 + vertex -6.472136e-02 4.702282e-02 6.666667e-03 + endloop + endfacet + facet normal -3.951362e-01 3.710576e-01 -8.403474e-01 + outer loop + vertex -6.549363e-02 5.418104e-02 1.000000e-02 + vertex -6.560718e-02 6.160924e-02 1.333333e-02 + vertex -5.818650e-02 6.196233e-02 1.000000e-02 + endloop + endfacet + facet normal -4.139211e-01 3.886978e-01 -8.231545e-01 + outer loop + vertex -6.549363e-02 5.418104e-02 1.000000e-02 + vertex -5.818650e-02 6.196233e-02 1.000000e-02 + vertex -5.831749e-02 5.476377e-02 6.666667e-03 + endloop + endfacet + facet normal -6.870882e-02 5.438863e-01 -8.363413e-01 + outer loop + vertex -1.686432e-02 8.840585e-02 1.333333e-02 + vertex -1.135802e-02 9.935288e-02 2.000000e-02 + vertex -5.651147e-03 8.982241e-02 1.333333e-02 + endloop + endfacet + facet normal -4.800881e-01 3.046732e-01 -8.226115e-01 + outer loop + vertex -7.176787e-02 4.554528e-02 1.000000e-02 + vertex -7.886760e-02 4.335783e-02 1.333333e-02 + vertex -7.281153e-02 5.290067e-02 1.333333e-02 + endloop + endfacet + facet normal -7.503591e-02 5.459268e-01 -8.344660e-01 + outer loop + vertex -1.686432e-02 8.840585e-02 1.333333e-02 + vertex -1.586825e-02 9.873297e-02 2.000000e-02 + vertex -1.135802e-02 9.935288e-02 2.000000e-02 + endloop + endfacet + facet normal -4.593740e-01 3.337547e-01 -8.231545e-01 + outer loop + vertex -7.176787e-02 4.554528e-02 1.000000e-02 + vertex -6.549363e-02 5.418104e-02 1.000000e-02 + vertex -6.472136e-02 4.702282e-02 6.666667e-03 + endloop + endfacet + facet normal -1.006329e-01 5.464371e-01 -8.314322e-01 + outer loop + vertex -1.686432e-02 8.840585e-02 1.333333e-02 + vertex -2.034560e-02 9.790841e-02 2.000000e-02 + vertex -1.586825e-02 9.873297e-02 2.000000e-02 + endloop + endfacet + facet normal -4.582842e-01 2.908360e-01 -8.398750e-01 + outer loop + vertex -7.176787e-02 4.554528e-02 1.000000e-02 + vertex -6.472136e-02 4.702282e-02 6.666667e-03 + vertex -7.010453e-02 3.854029e-02 6.666667e-03 + endloop + endfacet + facet normal -1.248180e-01 5.387807e-01 -8.331481e-01 + outer loop + vertex -1.686432e-02 8.840585e-02 1.333333e-02 + vertex -2.478078e-02 9.688092e-02 2.000000e-02 + vertex -2.034560e-02 9.790841e-02 2.000000e-02 + endloop + endfacet + facet normal -4.385262e-01 3.186080e-01 -8.403474e-01 + outer loop + vertex -7.176787e-02 4.554528e-02 1.000000e-02 + vertex -7.281153e-02 5.290067e-02 1.333333e-02 + vertex -6.549363e-02 5.418104e-02 1.000000e-02 + endloop + endfacet + facet normal -4.584693e-01 2.909535e-01 -8.397332e-01 + outer loop + vertex -7.907961e-02 5.264423e-02 1.666667e-02 + vertex -7.281153e-02 5.290067e-02 1.333333e-02 + vertex -7.886760e-02 4.335783e-02 1.333333e-02 + endloop + endfacet + facet normal -4.750230e-01 2.876655e-01 -8.316259e-01 + outer loop + vertex -7.907961e-02 5.264423e-02 1.666667e-02 + vertex -7.886760e-02 4.335783e-02 1.333333e-02 + vertex -8.771826e-02 4.801569e-02 2.000000e-02 + endloop + endfacet + facet normal -4.247597e-01 3.297873e-01 -8.431012e-01 + outer loop + vertex -7.907961e-02 5.264423e-02 1.666667e-02 + vertex -8.036311e-02 5.951277e-02 2.000000e-02 + vertex -7.757113e-02 6.310879e-02 2.000000e-02 + endloop + endfacet + facet normal -4.525757e-01 3.194628e-01 -8.325375e-01 + outer loop + vertex -7.907961e-02 5.264423e-02 1.666667e-02 + vertex -8.298853e-02 5.579340e-02 2.000000e-02 + vertex -8.036311e-02 5.951277e-02 2.000000e-02 + endloop + endfacet + facet normal -2.064471e-01 5.214259e-01 -8.279460e-01 + outer loop + vertex -3.406234e-02 7.238616e-02 6.666667e-03 + vertex -2.472136e-02 7.608452e-02 6.666667e-03 + vertex -2.590967e-02 6.502837e-02 0.000000e+00 + endloop + endfacet + facet normal -4.538247e-01 3.291853e-01 -8.280581e-01 + outer loop + vertex -7.907961e-02 5.264423e-02 1.666667e-02 + vertex -7.757113e-02 6.310879e-02 2.000000e-02 + vertex -7.281153e-02 5.290067e-02 1.333333e-02 + endloop + endfacet + facet normal -4.679210e-01 2.993480e-01 -8.315291e-01 + outer loop + vertex -7.907961e-02 5.264423e-02 1.666667e-02 + vertex -8.544194e-02 5.195840e-02 2.000000e-02 + vertex -8.298853e-02 5.579340e-02 2.000000e-02 + endloop + endfacet + facet normal -4.694729e-01 2.710503e-01 -8.403136e-01 + outer loop + vertex -7.907961e-02 5.264423e-02 1.666667e-02 + vertex -8.771826e-02 4.801569e-02 2.000000e-02 + vertex -8.544194e-02 5.195840e-02 2.000000e-02 + endloop + endfacet + facet normal -4.975822e-01 2.735481e-01 -8.231545e-01 + outer loop + vertex -7.691030e-02 3.619124e-02 1.000000e-02 + vertex -7.176787e-02 4.554528e-02 1.000000e-02 + vertex -7.010453e-02 3.854029e-02 6.666667e-03 + endloop + endfacet + facet normal -5.144881e-01 2.420997e-01 -8.226115e-01 + outer loop + vertex -7.691030e-02 3.619124e-02 1.000000e-02 + vertex -8.367988e-02 3.313121e-02 1.333333e-02 + vertex -7.886760e-02 4.335783e-02 1.333333e-02 + endloop + endfacet + facet normal -4.750005e-01 2.611337e-01 -8.403474e-01 + outer loop + vertex -7.691030e-02 3.619124e-02 1.000000e-02 + vertex -7.886760e-02 4.335783e-02 1.333333e-02 + vertex -7.176787e-02 4.554528e-02 1.000000e-02 + endloop + endfacet + facet normal -4.911219e-01 2.311044e-01 -8.398750e-01 + outer loop + vertex -7.691030e-02 3.619124e-02 1.000000e-02 + vertex -7.010453e-02 3.854029e-02 6.666667e-03 + vertex -7.438212e-02 2.944996e-02 6.666667e-03 + endloop + endfacet + facet normal -5.456447e-01 8.907799e-02 -8.332688e-01 + outer loop + vertex -7.340025e-02 1.540789e-02 3.333333e-03 + vertex -6.958966e-02 7.568331e-03 0.000000e+00 + vertex -7.936918e-02 1.002666e-02 6.666667e-03 + endloop + endfacet + facet normal -2.194898e-01 5.102412e-01 -8.315517e-01 + outer loop + vertex -3.406234e-02 7.238616e-02 6.666667e-03 + vertex -2.590967e-02 6.502837e-02 0.000000e+00 + vertex -2.939224e-02 6.353028e-02 0.000000e+00 + endloop + endfacet + facet normal -5.382144e-01 1.286072e-01 -8.329378e-01 + outer loop + vertex -7.340025e-02 1.540789e-02 3.333333e-03 + vertex -7.748665e-02 1.989519e-02 6.666667e-03 + vertex -6.744850e-02 1.872698e-02 0.000000e+00 + endloop + endfacet + facet normal -2.463110e-01 4.966405e-01 -8.322735e-01 + outer loop + vertex -3.406234e-02 7.238616e-02 6.666667e-03 + vertex -2.939224e-02 6.353028e-02 0.000000e+00 + vertex -3.278859e-02 6.184584e-02 0.000000e+00 + endloop + endfacet + facet normal -5.559978e-01 1.060623e-01 -8.243890e-01 + outer loop + vertex -7.340025e-02 1.540789e-02 3.333333e-03 + vertex -7.936918e-02 1.002666e-02 6.666667e-03 + vertex -7.748665e-02 1.989519e-02 6.666667e-03 + endloop + endfacet + facet normal -5.401871e-01 1.343385e-01 -8.307533e-01 + outer loop + vertex -7.340025e-02 1.540789e-02 3.333333e-03 + vertex -6.744850e-02 1.872698e-02 0.000000e+00 + vertex -6.836344e-02 1.504793e-02 0.000000e+00 + endloop + endfacet + facet normal -5.436772e-01 1.043225e-01 -8.327856e-01 + outer loop + vertex -7.340025e-02 1.540789e-02 3.333333e-03 + vertex -6.836344e-02 1.504793e-02 0.000000e+00 + vertex -6.907786e-02 1.132474e-02 0.000000e+00 + endloop + endfacet + facet normal -5.624791e-01 7.663624e-02 -8.232522e-01 + outer loop + vertex -7.340025e-02 1.540789e-02 3.333333e-03 + vertex -6.907786e-02 1.132474e-02 0.000000e+00 + vertex -6.958966e-02 7.568331e-03 0.000000e+00 + endloop + endfacet + facet normal -5.162143e-01 1.677282e-01 -8.398750e-01 + outer loop + vertex -8.083980e-02 2.626644e-02 1.000000e-02 + vertex -7.438212e-02 2.944996e-02 6.666667e-03 + vertex -7.748665e-02 1.989519e-02 6.666667e-03 + endloop + endfacet + facet normal -5.039837e-01 1.995413e-01 -8.403474e-01 + outer loop + vertex -8.083980e-02 2.626644e-02 1.000000e-02 + vertex -8.367988e-02 3.313121e-02 1.333333e-02 + vertex -7.691030e-02 3.619124e-02 1.000000e-02 + endloop + endfacet + facet normal -5.279433e-01 2.090275e-01 -8.231545e-01 + outer loop + vertex -8.083980e-02 2.626644e-02 1.000000e-02 + vertex -7.691030e-02 3.619124e-02 1.000000e-02 + vertex -7.438212e-02 2.944996e-02 6.666667e-03 + endloop + endfacet + facet normal -1.491434e-01 5.322997e-01 -8.333146e-01 + outer loop + vertex -2.781153e-02 8.559509e-02 1.333333e-02 + vertex -2.916459e-02 9.565263e-02 2.000000e-02 + vertex -2.478078e-02 9.688092e-02 2.000000e-02 + endloop + endfacet + facet normal -1.741129e-01 5.276775e-01 -8.314091e-01 + outer loop + vertex -2.781153e-02 8.559509e-02 1.333333e-02 + vertex -3.348796e-02 9.422609e-02 2.000000e-02 + vertex -2.916459e-02 9.565263e-02 2.000000e-02 + endloop + endfacet + facet normal -5.407744e-01 1.757082e-01 -8.226115e-01 + outer loop + vertex -8.083980e-02 2.626644e-02 1.000000e-02 + vertex -8.717248e-02 2.238209e-02 1.333333e-02 + vertex -8.367988e-02 3.313121e-02 1.333333e-02 + endloop + endfacet + facet normal -1.964235e-01 5.152033e-01 -8.342561e-01 + outer loop + vertex -2.781153e-02 8.559509e-02 1.333333e-02 + vertex -3.774192e-02 9.260425e-02 2.000000e-02 + vertex -3.348796e-02 9.422609e-02 2.000000e-02 + endloop + endfacet + facet normal -4.973653e-01 2.457544e-01 -8.320051e-01 + outer loop + vertex -8.689205e-02 3.840275e-02 1.666667e-02 + vertex -8.771826e-02 4.801569e-02 2.000000e-02 + vertex -7.886760e-02 4.335783e-02 1.333333e-02 + endloop + endfacet + facet normal -4.915851e-01 2.313224e-01 -8.395439e-01 + outer loop + vertex -8.689205e-02 3.840275e-02 1.666667e-02 + vertex -7.886760e-02 4.335783e-02 1.333333e-02 + vertex -8.367988e-02 3.313121e-02 1.333333e-02 + endloop + endfacet + facet normal -5.218550e-01 2.055191e-01 -8.279066e-01 + outer loop + vertex -8.689205e-02 3.840275e-02 1.666667e-02 + vertex -8.367988e-02 3.313121e-02 1.333333e-02 + vertex -9.496397e-02 3.133440e-02 2.000000e-02 + endloop + endfacet + facet normal -4.820386e-01 2.497723e-01 -8.397932e-01 + outer loop + vertex -8.689205e-02 3.840275e-02 1.666667e-02 + vertex -8.981277e-02 4.397347e-02 2.000000e-02 + vertex -8.771826e-02 4.801569e-02 2.000000e-02 + endloop + endfacet + facet normal -1.362688e-01 5.307318e-01 -8.365133e-01 + outer loop + vertex -2.781153e-02 8.559509e-02 1.333333e-02 + vertex -2.478078e-02 9.688092e-02 2.000000e-02 + vertex -1.686432e-02 8.840585e-02 1.333333e-02 + endloop + endfacet + facet normal -5.045332e-01 2.329413e-01 -8.313751e-01 + outer loop + vertex -8.689205e-02 3.840275e-02 1.666667e-02 + vertex -9.172113e-02 3.984011e-02 2.000000e-02 + vertex -8.981277e-02 4.397347e-02 2.000000e-02 + endloop + endfacet + facet normal -5.126521e-01 2.089372e-01 -8.327863e-01 + outer loop + vertex -8.689205e-02 3.840275e-02 1.666667e-02 + vertex -9.343938e-02 3.562417e-02 2.000000e-02 + vertex -9.172113e-02 3.984011e-02 2.000000e-02 + endloop + endfacet + facet normal -5.058280e-01 1.797713e-01 -8.436944e-01 + outer loop + vertex -8.689205e-02 3.840275e-02 1.666667e-02 + vertex -9.496397e-02 3.133440e-02 2.000000e-02 + vertex -9.343938e-02 3.562417e-02 2.000000e-02 + endloop + endfacet + facet normal -5.331657e-01 1.017068e-01 -8.398750e-01 + outer loop + vertex -8.349442e-02 1.592741e-02 1.000000e-02 + vertex -7.748665e-02 1.989519e-02 6.666667e-03 + vertex -7.936918e-02 1.002666e-02 6.666667e-03 + endloop + endfacet + facet normal -5.250188e-01 1.348019e-01 -8.403474e-01 + outer loop + vertex -8.349442e-02 1.592741e-02 1.000000e-02 + vertex -8.717248e-02 2.238209e-02 1.333333e-02 + vertex -8.083980e-02 2.626644e-02 1.000000e-02 + endloop + endfacet + facet normal -5.499784e-01 1.412105e-01 -8.231545e-01 + outer loop + vertex -8.349442e-02 1.592741e-02 1.000000e-02 + vertex -8.083980e-02 2.626644e-02 1.000000e-02 + vertex -7.748665e-02 1.989519e-02 6.666667e-03 + endloop + endfacet + facet normal -5.585323e-01 1.065457e-01 -8.226115e-01 + outer loop + vertex -8.349442e-02 1.592741e-02 1.000000e-02 + vertex -8.929032e-02 1.127999e-02 1.333333e-02 + vertex -8.717248e-02 2.238209e-02 1.333333e-02 + endloop + endfacet + facet normal -2.700229e-01 4.911698e-01 -8.281545e-01 + outer loop + vertex -4.286614e-02 6.754623e-02 6.666667e-03 + vertex -3.406234e-02 7.238616e-02 6.666667e-03 + vertex -3.278859e-02 6.184584e-02 0.000000e+00 + endloop + endfacet + facet normal -5.377740e-01 6.793666e-02 -8.403474e-01 + outer loop + vertex -8.483227e-02 5.337194e-03 1.000000e-02 + vertex -8.929032e-02 1.127999e-02 1.333333e-02 + vertex -8.349442e-02 1.592741e-02 1.000000e-02 + endloop + endfacet + facet normal -2.744826e-01 4.854872e-01 -8.300370e-01 + outer loop + vertex -4.286614e-02 6.754623e-02 6.666667e-03 + vertex -3.278859e-02 6.184584e-02 0.000000e+00 + vertex -3.608877e-02 5.998000e-02 0.000000e+00 + endloop + endfacet + facet normal -5.417088e-01 3.408143e-02 -8.398750e-01 + outer loop + vertex -8.483227e-02 5.337194e-03 1.000000e-02 + vertex -7.936918e-02 1.002666e-02 6.666667e-03 + vertex -8.000000e-02 -9.678424e-17 6.666667e-03 + endloop + endfacet + facet normal -5.633400e-01 7.116640e-02 -8.231545e-01 + outer loop + vertex -8.483227e-02 5.337194e-03 1.000000e-02 + vertex -8.349442e-02 1.592741e-02 1.000000e-02 + vertex -7.936918e-02 1.002666e-02 6.666667e-03 + endloop + endfacet + facet normal -5.674818e-01 3.570293e-02 -8.226115e-01 + outer loop + vertex -8.483227e-02 5.337194e-03 1.000000e-02 + vertex -9.000000e-02 -1.088823e-16 1.333333e-02 + vertex -8.929032e-02 1.127999e-02 1.333333e-02 + endloop + endfacet + facet normal -5.304842e-01 8.525885e-02 -8.433964e-01 + outer loop + vertex -9.465219e-02 8.121790e-03 1.666667e-02 + vertex -9.906859e-02 1.361666e-02 2.000000e-02 + vertex -9.834617e-02 1.811162e-02 2.000000e-02 + endloop + endfacet + facet normal -5.502009e-01 6.289895e-02 -8.326600e-01 + outer loop + vertex -9.465219e-02 8.121790e-03 1.666667e-02 + vertex -9.958568e-02 9.093486e-03 2.000000e-02 + vertex -9.906859e-02 1.361666e-02 2.000000e-02 + endloop + endfacet + facet normal -5.543042e-01 3.791544e-02 -8.314501e-01 + outer loop + vertex -9.465219e-02 8.121790e-03 1.666667e-02 + vertex -9.989637e-02 4.551460e-03 2.000000e-02 + vertex -9.958568e-02 9.093486e-03 2.000000e-02 + endloop + endfacet + facet normal -5.562997e-01 7.056887e-02 -8.279799e-01 + outer loop + vertex -9.465219e-02 8.121790e-03 1.666667e-02 + vertex -9.834617e-02 1.811162e-02 2.000000e-02 + vertex -8.929032e-02 1.127999e-02 1.333333e-02 + endloop + endfacet + facet normal -5.423657e-01 1.234918e-02 -8.400518e-01 + outer loop + vertex -9.465219e-02 8.121790e-03 1.666667e-02 + vertex -1.000000e-01 -2.542071e-16 2.000000e-02 + vertex -9.989637e-02 4.551460e-03 2.000000e-02 + endloop + endfacet + facet normal -5.545438e-01 2.374815e-02 -8.318156e-01 + outer loop + vertex -9.465219e-02 8.121790e-03 1.666667e-02 + vertex -9.000000e-02 -1.088823e-16 1.333333e-02 + vertex -1.000000e-01 -2.542071e-16 2.000000e-02 + endloop + endfacet + facet normal -5.420708e-01 3.410420e-02 -8.396405e-01 + outer loop + vertex -9.465219e-02 8.121790e-03 1.666667e-02 + vertex -8.929032e-02 1.127999e-02 1.333333e-02 + vertex -9.000000e-02 -1.088823e-16 1.333333e-02 + endloop + endfacet + facet normal -5.674818e-01 -3.570293e-02 -8.226115e-01 + outer loop + vertex -8.483227e-02 -5.337194e-03 1.000000e-02 + vertex -8.929032e-02 -1.127999e-02 1.333333e-02 + vertex -9.000000e-02 -1.088823e-16 1.333333e-02 + endloop + endfacet + facet normal -5.678175e-01 -7.382203e-16 -8.231545e-01 + outer loop + vertex -8.483227e-02 -5.337194e-03 1.000000e-02 + vertex -8.483227e-02 5.337194e-03 1.000000e-02 + vertex -8.000000e-02 -9.678424e-17 6.666667e-03 + endloop + endfacet + facet normal -2.017816e-01 5.096422e-01 -8.363905e-01 + outer loop + vertex -3.832014e-02 8.143443e-02 1.333333e-02 + vertex -3.774192e-02 9.260425e-02 2.000000e-02 + vertex -2.781153e-02 8.559509e-02 1.333333e-02 + endloop + endfacet + facet normal -5.420482e-01 -7.226109e-16 -8.403474e-01 + outer loop + vertex -8.483227e-02 -5.337194e-03 1.000000e-02 + vertex -9.000000e-02 -1.088823e-16 1.333333e-02 + vertex -8.483227e-02 5.337194e-03 1.000000e-02 + endloop + endfacet + facet normal -5.417088e-01 -3.408143e-02 -8.398750e-01 + outer loop + vertex -8.483227e-02 -5.337194e-03 1.000000e-02 + vertex -8.000000e-02 -9.678424e-17 6.666667e-03 + vertex -7.936918e-02 -1.002666e-02 6.666667e-03 + endloop + endfacet + facet normal -5.401871e-01 -1.343385e-01 -8.307533e-01 + outer loop + vertex -7.340025e-02 -1.540789e-02 3.333333e-03 + vertex -6.836344e-02 -1.504793e-02 0.000000e+00 + vertex -6.744850e-02 -1.872698e-02 0.000000e+00 + endloop + endfacet + facet normal -5.559978e-01 -1.060623e-01 -8.243890e-01 + outer loop + vertex -7.340025e-02 -1.540789e-02 3.333333e-03 + vertex -7.748665e-02 -1.989519e-02 6.666667e-03 + vertex -7.936918e-02 -1.002666e-02 6.666667e-03 + endloop + endfacet + facet normal -5.456447e-01 -8.907799e-02 -8.332688e-01 + outer loop + vertex -7.340025e-02 -1.540789e-02 3.333333e-03 + vertex -7.936918e-02 -1.002666e-02 6.666667e-03 + vertex -6.958966e-02 -7.568331e-03 0.000000e+00 + endloop + endfacet + facet normal -5.382144e-01 -1.286072e-01 -8.329378e-01 + outer loop + vertex -7.340025e-02 -1.540789e-02 3.333333e-03 + vertex -6.744850e-02 -1.872698e-02 0.000000e+00 + vertex -7.748665e-02 -1.989519e-02 6.666667e-03 + endloop + endfacet + facet normal -5.624791e-01 -7.663624e-02 -8.232522e-01 + outer loop + vertex -7.340025e-02 -1.540789e-02 3.333333e-03 + vertex -6.958966e-02 -7.568331e-03 0.000000e+00 + vertex -6.907786e-02 -1.132474e-02 0.000000e+00 + endloop + endfacet + facet normal -5.436772e-01 -1.043225e-01 -8.327856e-01 + outer loop + vertex -7.340025e-02 -1.540789e-02 3.333333e-03 + vertex -6.907786e-02 -1.132474e-02 0.000000e+00 + vertex -6.836344e-02 -1.504793e-02 0.000000e+00 + endloop + endfacet + facet normal -5.585323e-01 -1.065457e-01 -8.226115e-01 + outer loop + vertex -8.349442e-02 -1.592741e-02 1.000000e-02 + vertex -8.717248e-02 -2.238209e-02 1.333333e-02 + vertex -8.929032e-02 -1.127999e-02 1.333333e-02 + endloop + endfacet + facet normal -5.633400e-01 -7.116640e-02 -8.231545e-01 + outer loop + vertex -8.349442e-02 -1.592741e-02 1.000000e-02 + vertex -8.483227e-02 -5.337194e-03 1.000000e-02 + vertex -7.936918e-02 -1.002666e-02 6.666667e-03 + endloop + endfacet + facet normal -3.714136e-01 4.139973e-01 -8.310585e-01 + outer loop + vertex -5.099392e-02 6.164106e-02 6.666667e-03 + vertex -4.531704e-02 5.335134e-02 0.000000e+00 + vertex -4.813896e-02 5.081968e-02 0.000000e+00 + endloop + endfacet + facet normal -5.331657e-01 -1.017068e-01 -8.398750e-01 + outer loop + vertex -8.349442e-02 -1.592741e-02 1.000000e-02 + vertex -7.936918e-02 -1.002666e-02 6.666667e-03 + vertex -7.748665e-02 -1.989519e-02 6.666667e-03 + endloop + endfacet + facet normal -5.377740e-01 -6.793666e-02 -8.403474e-01 + outer loop + vertex -8.349442e-02 -1.592741e-02 1.000000e-02 + vertex -8.929032e-02 -1.127999e-02 1.333333e-02 + vertex -8.483227e-02 -5.337194e-03 1.000000e-02 + endloop + endfacet + facet normal -5.562997e-01 -7.056887e-02 -8.279799e-01 + outer loop + vertex -9.465219e-02 -8.121790e-03 1.666667e-02 + vertex -8.929032e-02 -1.127999e-02 1.333333e-02 + vertex -9.834617e-02 -1.811162e-02 2.000000e-02 + endloop + endfacet + facet normal -3.093690e-01 4.601633e-01 -8.321902e-01 + outer loop + vertex -4.822441e-02 7.598951e-02 1.333333e-02 + vertex -5.766803e-02 8.169699e-02 2.000000e-02 + vertex -5.388986e-02 8.423706e-02 2.000000e-02 + endloop + endfacet + facet normal -5.420708e-01 -3.410420e-02 -8.396405e-01 + outer loop + vertex -9.465219e-02 -8.121790e-03 1.666667e-02 + vertex -9.000000e-02 -1.088823e-16 1.333333e-02 + vertex -8.929032e-02 -1.127999e-02 1.333333e-02 + endloop + endfacet + facet normal -5.423657e-01 -1.234918e-02 -8.400518e-01 + outer loop + vertex -9.465219e-02 -8.121790e-03 1.666667e-02 + vertex -9.989637e-02 -4.551460e-03 2.000000e-02 + vertex -1.000000e-01 -2.542071e-16 2.000000e-02 + endloop + endfacet + facet normal -5.543042e-01 -3.791544e-02 -8.314501e-01 + outer loop + vertex -9.465219e-02 -8.121790e-03 1.666667e-02 + vertex -9.958568e-02 -9.093486e-03 2.000000e-02 + vertex -9.989637e-02 -4.551460e-03 2.000000e-02 + endloop + endfacet + facet normal -5.502009e-01 -6.289895e-02 -8.326600e-01 + outer loop + vertex -9.465219e-02 -8.121790e-03 1.666667e-02 + vertex -9.906859e-02 -1.361666e-02 2.000000e-02 + vertex -9.958568e-02 -9.093486e-03 2.000000e-02 + endloop + endfacet + facet normal -5.304842e-01 -8.525885e-02 -8.433964e-01 + outer loop + vertex -9.465219e-02 -8.121790e-03 1.666667e-02 + vertex -9.834617e-02 -1.811162e-02 2.000000e-02 + vertex -9.906859e-02 -1.361666e-02 2.000000e-02 + endloop + endfacet + facet normal -5.545438e-01 -2.374815e-02 -8.318156e-01 + outer loop + vertex -9.465219e-02 -8.121790e-03 1.666667e-02 + vertex -1.000000e-01 -2.542071e-16 2.000000e-02 + vertex -9.000000e-02 -1.088823e-16 1.333333e-02 + endloop + endfacet + facet normal -5.162143e-01 -1.677282e-01 -8.398750e-01 + outer loop + vertex -8.083980e-02 -2.626644e-02 1.000000e-02 + vertex -7.748665e-02 -1.989519e-02 6.666667e-03 + vertex -7.438212e-02 -2.944996e-02 6.666667e-03 + endloop + endfacet + facet normal -5.499784e-01 -1.412105e-01 -8.231545e-01 + outer loop + vertex -8.083980e-02 -2.626644e-02 1.000000e-02 + vertex -8.349442e-02 -1.592741e-02 1.000000e-02 + vertex -7.748665e-02 -1.989519e-02 6.666667e-03 + endloop + endfacet + facet normal -5.407744e-01 -1.757082e-01 -8.226115e-01 + outer loop + vertex -8.083980e-02 -2.626644e-02 1.000000e-02 + vertex -8.367988e-02 -3.313121e-02 1.333333e-02 + vertex -8.717248e-02 -2.238209e-02 1.333333e-02 + endloop + endfacet + facet normal -5.250188e-01 -1.348019e-01 -8.403474e-01 + outer loop + vertex -8.083980e-02 -2.626644e-02 1.000000e-02 + vertex -8.717248e-02 -2.238209e-02 1.333333e-02 + vertex -8.349442e-02 -1.592741e-02 1.000000e-02 + endloop + endfacet + facet normal -4.911219e-01 -2.311044e-01 -8.398750e-01 + outer loop + vertex -7.691030e-02 -3.619124e-02 1.000000e-02 + vertex -7.438212e-02 -2.944996e-02 6.666667e-03 + vertex -7.010453e-02 -3.854029e-02 6.666667e-03 + endloop + endfacet + facet normal -5.039837e-01 -1.995413e-01 -8.403474e-01 + outer loop + vertex -7.691030e-02 -3.619124e-02 1.000000e-02 + vertex -8.367988e-02 -3.313121e-02 1.333333e-02 + vertex -8.083980e-02 -2.626644e-02 1.000000e-02 + endloop + endfacet + facet normal -5.144881e-01 -2.420997e-01 -8.226115e-01 + outer loop + vertex -7.691030e-02 -3.619124e-02 1.000000e-02 + vertex -7.886760e-02 -4.335783e-02 1.333333e-02 + vertex -8.367988e-02 -3.313121e-02 1.333333e-02 + endloop + endfacet + facet normal -3.838862e-01 4.087973e-01 -8.279591e-01 + outer loop + vertex -5.831749e-02 5.476377e-02 6.666667e-03 + vertex -5.099392e-02 6.164106e-02 6.666667e-03 + vertex -4.813896e-02 5.081968e-02 0.000000e+00 + endloop + endfacet + facet normal -5.279433e-01 -2.090275e-01 -8.231545e-01 + outer loop + vertex -7.691030e-02 -3.619124e-02 1.000000e-02 + vertex -8.083980e-02 -2.626644e-02 1.000000e-02 + vertex -7.438212e-02 -2.944996e-02 6.666667e-03 + endloop + endfacet + facet normal -4.937651e-01 -2.791628e-01 -8.235679e-01 + outer loop + vertex -6.252898e-02 -4.141409e-02 3.333333e-03 + vertex -6.184584e-02 -3.278859e-02 0.000000e+00 + vertex -5.998000e-02 -3.608877e-02 0.000000e+00 + endloop + endfacet + facet normal -3.926074e-01 3.926074e-01 -8.316964e-01 + outer loop + vertex -5.831749e-02 5.476377e-02 6.666667e-03 + vertex -4.813896e-02 5.081968e-02 0.000000e+00 + vertex -5.081968e-02 4.813896e-02 0.000000e+00 + endloop + endfacet + facet normal -4.663617e-01 -2.980926e-01 -8.328550e-01 + outer loop + vertex -6.252898e-02 -4.141409e-02 3.333333e-03 + vertex -5.998000e-02 -3.608877e-02 0.000000e+00 + vertex -5.793823e-02 -3.928309e-02 0.000000e+00 + endloop + endfacet + facet normal -4.127500e-01 3.702946e-01 -8.321775e-01 + outer loop + vertex -5.831749e-02 5.476377e-02 6.666667e-03 + vertex -5.081968e-02 4.813896e-02 0.000000e+00 + vertex -5.335134e-02 4.531704e-02 0.000000e+00 + endloop + endfacet + facet normal -4.522879e-01 -3.248780e-01 -8.305961e-01 + outer loop + vertex -6.252898e-02 -4.141409e-02 3.333333e-03 + vertex -5.793823e-02 -3.928309e-02 0.000000e+00 + vertex -5.572651e-02 -4.236220e-02 0.000000e+00 + endloop + endfacet + facet normal -4.525522e-01 -3.181876e-01 -8.330385e-01 + outer loop + vertex -6.252898e-02 -4.141409e-02 3.333333e-03 + vertex -5.572651e-02 -4.236220e-02 0.000000e+00 + vertex -6.472136e-02 -4.702282e-02 6.666667e-03 + endloop + endfacet + facet normal -4.778065e-01 -3.032252e-01 -8.244728e-01 + outer loop + vertex -6.252898e-02 -4.141409e-02 3.333333e-03 + vertex -6.472136e-02 -4.702282e-02 6.666667e-03 + vertex -7.010453e-02 -3.854029e-02 6.666667e-03 + endloop + endfacet + facet normal -4.744450e-01 -2.843717e-01 -8.330874e-01 + outer loop + vertex -6.252898e-02 -4.141409e-02 3.333333e-03 + vertex -7.010453e-02 -3.854029e-02 6.666667e-03 + vertex -6.184584e-02 -3.278859e-02 0.000000e+00 + endloop + endfacet + facet normal -5.218550e-01 -2.055191e-01 -8.279066e-01 + outer loop + vertex -8.689205e-02 -3.840275e-02 1.666667e-02 + vertex -9.496397e-02 -3.133440e-02 2.000000e-02 + vertex -8.367988e-02 -3.313121e-02 1.333333e-02 + endloop + endfacet + facet normal -3.277551e-01 4.425843e-01 -8.346830e-01 + outer loop + vertex -5.736816e-02 6.934619e-02 1.333333e-02 + vertex -6.132668e-02 7.898759e-02 2.000000e-02 + vertex -5.766803e-02 8.169699e-02 2.000000e-02 + endloop + endfacet + facet normal -4.973653e-01 -2.457544e-01 -8.320051e-01 + outer loop + vertex -8.689205e-02 -3.840275e-02 1.666667e-02 + vertex -7.886760e-02 -4.335783e-02 1.333333e-02 + vertex -8.771826e-02 -4.801569e-02 2.000000e-02 + endloop + endfacet + facet normal -3.506200e-01 4.309699e-01 -8.314629e-01 + outer loop + vertex -5.736816e-02 6.934619e-02 1.333333e-02 + vertex -6.485821e-02 7.611447e-02 2.000000e-02 + vertex -6.132668e-02 7.898759e-02 2.000000e-02 + endloop + endfacet + facet normal -4.915851e-01 -2.313224e-01 -8.395439e-01 + outer loop + vertex -8.689205e-02 -3.840275e-02 1.666667e-02 + vertex -8.367988e-02 -3.313121e-02 1.333333e-02 + vertex -7.886760e-02 -4.335783e-02 1.333333e-02 + endloop + endfacet + facet normal -3.683470e-01 4.128556e-01 -8.329890e-01 + outer loop + vertex -5.736816e-02 6.934619e-02 1.333333e-02 + vertex -6.825531e-02 7.308360e-02 2.000000e-02 + vertex -6.485821e-02 7.611447e-02 2.000000e-02 + endloop + endfacet + facet normal -5.058280e-01 -1.797713e-01 -8.436944e-01 + outer loop + vertex -8.689205e-02 -3.840275e-02 1.666667e-02 + vertex -9.343938e-02 -3.562417e-02 2.000000e-02 + vertex -9.496397e-02 -3.133440e-02 2.000000e-02 + endloop + endfacet + facet normal -5.126521e-01 -2.089372e-01 -8.327863e-01 + outer loop + vertex -8.689205e-02 -3.840275e-02 1.666667e-02 + vertex -9.172113e-02 -3.984011e-02 2.000000e-02 + vertex -9.343938e-02 -3.562417e-02 2.000000e-02 + endloop + endfacet + facet normal -5.045332e-01 -2.329413e-01 -8.313751e-01 + outer loop + vertex -8.689205e-02 -3.840275e-02 1.666667e-02 + vertex -8.981277e-02 -4.397347e-02 2.000000e-02 + vertex -9.172113e-02 -3.984011e-02 2.000000e-02 + endloop + endfacet + facet normal -4.820386e-01 -2.497723e-01 -8.397932e-01 + outer loop + vertex -8.689205e-02 -3.840275e-02 1.666667e-02 + vertex -8.771826e-02 -4.801569e-02 2.000000e-02 + vertex -8.981277e-02 -4.397347e-02 2.000000e-02 + endloop + endfacet + facet normal -4.975822e-01 -2.735481e-01 -8.231545e-01 + outer loop + vertex -7.176787e-02 -4.554528e-02 1.000000e-02 + vertex -7.691030e-02 -3.619124e-02 1.000000e-02 + vertex -7.010453e-02 -3.854029e-02 6.666667e-03 + endloop + endfacet + facet normal -4.582842e-01 -2.908360e-01 -8.398750e-01 + outer loop + vertex -7.176787e-02 -4.554528e-02 1.000000e-02 + vertex -7.010453e-02 -3.854029e-02 6.666667e-03 + vertex -6.472136e-02 -4.702282e-02 6.666667e-03 + endloop + endfacet + facet normal -3.222807e-01 4.435813e-01 -8.362839e-01 + outer loop + vertex -5.736816e-02 6.934619e-02 1.333333e-02 + vertex -5.766803e-02 8.169699e-02 2.000000e-02 + vertex -4.822441e-02 7.598951e-02 1.333333e-02 + endloop + endfacet + facet normal -4.750005e-01 -2.611337e-01 -8.403474e-01 + outer loop + vertex -7.176787e-02 -4.554528e-02 1.000000e-02 + vertex -7.886760e-02 -4.335783e-02 1.333333e-02 + vertex -7.691030e-02 -3.619124e-02 1.000000e-02 + endloop + endfacet + facet normal -4.319368e-01 3.573292e-01 -8.280981e-01 + outer loop + vertex -6.472136e-02 4.702282e-02 6.666667e-03 + vertex -5.831749e-02 5.476377e-02 6.666667e-03 + vertex -5.335134e-02 4.531704e-02 0.000000e+00 + endloop + endfacet + facet normal -4.800881e-01 -3.046732e-01 -8.226115e-01 + outer loop + vertex -7.176787e-02 -4.554528e-02 1.000000e-02 + vertex -7.281153e-02 -5.290067e-02 1.333333e-02 + vertex -7.886760e-02 -4.335783e-02 1.333333e-02 + endloop + endfacet + facet normal -4.593740e-01 -3.337547e-01 -8.231545e-01 + outer loop + vertex -6.549363e-02 -5.418104e-02 1.000000e-02 + vertex -7.176787e-02 -4.554528e-02 1.000000e-02 + vertex -6.472136e-02 -4.702282e-02 6.666667e-03 + endloop + endfacet + facet normal -4.385262e-01 -3.186080e-01 -8.403474e-01 + outer loop + vertex -6.549363e-02 -5.418104e-02 1.000000e-02 + vertex -7.281153e-02 -5.290067e-02 1.333333e-02 + vertex -7.176787e-02 -4.554528e-02 1.000000e-02 + endloop + endfacet + facet normal -4.381168e-01 -3.624417e-01 -8.226115e-01 + outer loop + vertex -6.549363e-02 -5.418104e-02 1.000000e-02 + vertex -6.560718e-02 -6.160924e-02 1.333333e-02 + vertex -7.281153e-02 -5.290067e-02 1.333333e-02 + endloop + endfacet + facet normal -4.182191e-01 -3.459809e-01 -8.398750e-01 + outer loop + vertex -6.549363e-02 -5.418104e-02 1.000000e-02 + vertex -6.472136e-02 -4.702282e-02 6.666667e-03 + vertex -5.831749e-02 -5.476377e-02 6.666667e-03 + endloop + endfacet + facet normal -4.750230e-01 -2.876655e-01 -8.316259e-01 + outer loop + vertex -7.907961e-02 -5.264423e-02 1.666667e-02 + vertex -8.771826e-02 -4.801569e-02 2.000000e-02 + vertex -7.886760e-02 -4.335783e-02 1.333333e-02 + endloop + endfacet + facet normal -4.538247e-01 -3.291853e-01 -8.280581e-01 + outer loop + vertex -7.907961e-02 -5.264423e-02 1.666667e-02 + vertex -7.281153e-02 -5.290067e-02 1.333333e-02 + vertex -7.757113e-02 -6.310879e-02 2.000000e-02 + endloop + endfacet + facet normal -4.344248e-01 3.492005e-01 -8.302615e-01 + outer loop + vertex -6.472136e-02 4.702282e-02 6.666667e-03 + vertex -5.335134e-02 4.531704e-02 0.000000e+00 + vertex -5.572651e-02 4.236220e-02 0.000000e+00 + endloop + endfacet + facet normal -4.584693e-01 -2.909535e-01 -8.397332e-01 + outer loop + vertex -7.907961e-02 -5.264423e-02 1.666667e-02 + vertex -7.886760e-02 -4.335783e-02 1.333333e-02 + vertex -7.281153e-02 -5.290067e-02 1.333333e-02 + endloop + endfacet + facet normal -4.694729e-01 -2.710503e-01 -8.403136e-01 + outer loop + vertex -7.907961e-02 -5.264423e-02 1.666667e-02 + vertex -8.544194e-02 -5.195840e-02 2.000000e-02 + vertex -8.771826e-02 -4.801569e-02 2.000000e-02 + endloop + endfacet + facet normal -4.679210e-01 -2.993480e-01 -8.315291e-01 + outer loop + vertex -7.907961e-02 -5.264423e-02 1.666667e-02 + vertex -8.298853e-02 -5.579340e-02 2.000000e-02 + vertex -8.544194e-02 -5.195840e-02 2.000000e-02 + endloop + endfacet + facet normal -4.525757e-01 -3.194628e-01 -8.325375e-01 + outer loop + vertex -7.907961e-02 -5.264423e-02 1.666667e-02 + vertex -8.036311e-02 -5.951277e-02 2.000000e-02 + vertex -8.298853e-02 -5.579340e-02 2.000000e-02 + endloop + endfacet + facet normal -4.247597e-01 -3.297873e-01 -8.431012e-01 + outer loop + vertex -7.907961e-02 -5.264423e-02 1.666667e-02 + vertex -7.757113e-02 -6.310879e-02 2.000000e-02 + vertex -8.036311e-02 -5.951277e-02 2.000000e-02 + endloop + endfacet + facet normal -3.862302e-01 3.951244e-01 -8.334884e-01 + outer loop + vertex -6.560718e-02 6.160924e-02 1.333333e-02 + vertex -7.151095e-02 6.990124e-02 2.000000e-02 + vertex -6.825531e-02 7.308360e-02 2.000000e-02 + endloop + endfacet + facet normal -3.892361e-01 -4.144944e-01 -8.226115e-01 + outer loop + vertex -5.818650e-02 -6.196233e-02 1.000000e-02 + vertex -5.736816e-02 -6.934619e-02 1.333333e-02 + vertex -6.560718e-02 -6.160924e-02 1.333333e-02 + endloop + endfacet + facet normal -4.061136e-01 3.792837e-01 -8.313938e-01 + outer loop + vertex -6.560718e-02 6.160924e-02 1.333333e-02 + vertex -7.461837e-02 6.657401e-02 2.000000e-02 + vertex -7.151095e-02 6.990124e-02 2.000000e-02 + endloop + endfacet + facet normal -3.715584e-01 -3.956695e-01 -8.398750e-01 + outer loop + vertex -5.818650e-02 -6.196233e-02 1.000000e-02 + vertex -5.831749e-02 -5.476377e-02 6.666667e-03 + vertex -5.099392e-02 -6.164106e-02 6.666667e-03 + endloop + endfacet + facet normal -4.199111e-01 3.578122e-01 -8.340534e-01 + outer loop + vertex -6.560718e-02 6.160924e-02 1.333333e-02 + vertex -7.757113e-02 6.310879e-02 2.000000e-02 + vertex -7.461837e-02 6.657401e-02 2.000000e-02 + endloop + endfacet + facet normal -4.139211e-01 -3.886978e-01 -8.231545e-01 + outer loop + vertex -5.818650e-02 -6.196233e-02 1.000000e-02 + vertex -6.549363e-02 -5.418104e-02 1.000000e-02 + vertex -5.831749e-02 -5.476377e-02 6.666667e-03 + endloop + endfacet + facet normal -3.951362e-01 -3.710576e-01 -8.403474e-01 + outer loop + vertex -5.818650e-02 -6.196233e-02 1.000000e-02 + vertex -6.560718e-02 -6.160924e-02 1.333333e-02 + vertex -6.549363e-02 -5.418104e-02 1.000000e-02 + endloop + endfacet + facet normal -3.550852e-01 -4.417458e-01 -8.238781e-01 + outer loop + vertex -4.282575e-02 -6.157073e-02 3.333333e-03 + vertex -4.531704e-02 -5.335134e-02 0.000000e+00 + vertex -4.236220e-02 -5.572651e-02 0.000000e+00 + endloop + endfacet + facet normal -3.228468e-01 -4.494600e-01 -8.329199e-01 + outer loop + vertex -4.282575e-02 -6.157073e-02 3.333333e-03 + vertex -4.236220e-02 -5.572651e-02 0.000000e+00 + vertex -3.928309e-02 -5.793823e-02 0.000000e+00 + endloop + endfacet + facet normal -3.751038e-01 3.994450e-01 -8.365051e-01 + outer loop + vertex -6.560718e-02 6.160924e-02 1.333333e-02 + vertex -6.825531e-02 7.308360e-02 2.000000e-02 + vertex -5.736816e-02 6.934619e-02 1.333333e-02 + endloop + endfacet + facet normal -3.000452e-01 -4.694166e-01 -8.304342e-01 + outer loop + vertex -4.282575e-02 -6.157073e-02 3.333333e-03 + vertex -3.928309e-02 -5.793823e-02 0.000000e+00 + vertex -3.608877e-02 -5.998000e-02 0.000000e+00 + endloop + endfacet + facet normal -3.325528e-01 -4.577197e-01 -8.245613e-01 + outer loop + vertex -4.282575e-02 -6.157073e-02 3.333333e-03 + vertex -4.286614e-02 -6.754623e-02 6.666667e-03 + vertex -5.099392e-02 -6.164106e-02 6.666667e-03 + endloop + endfacet + facet normal -3.361132e-01 -4.396561e-01 -8.329048e-01 + outer loop + vertex -4.282575e-02 -6.157073e-02 3.333333e-03 + vertex -5.099392e-02 -6.164106e-02 6.666667e-03 + vertex -4.531704e-02 -5.335134e-02 0.000000e+00 + endloop + endfacet + facet normal -3.029675e-01 -4.627032e-01 -8.331365e-01 + outer loop + vertex -4.282575e-02 -6.157073e-02 3.333333e-03 + vertex -3.608877e-02 -5.998000e-02 0.000000e+00 + vertex -4.286614e-02 -6.754623e-02 6.666667e-03 + endloop + endfacet + facet normal -3.342170e-01 -4.600102e-01 -8.226115e-01 + outer loop + vertex -4.996175e-02 -6.876644e-02 1.000000e-02 + vertex -4.822441e-02 -7.598951e-02 1.333333e-02 + vertex -5.736816e-02 -6.934619e-02 1.333333e-02 + endloop + endfacet + facet normal -3.190380e-01 -4.391181e-01 -8.398750e-01 + outer loop + vertex -4.996175e-02 -6.876644e-02 1.000000e-02 + vertex -5.099392e-02 -6.164106e-02 6.666667e-03 + vertex -4.286614e-02 -6.754623e-02 6.666667e-03 + endloop + endfacet + facet normal -3.455146e-01 -4.176553e-01 -8.403474e-01 + outer loop + vertex -4.996175e-02 -6.876644e-02 1.000000e-02 + vertex -5.736816e-02 -6.934619e-02 1.333333e-02 + vertex -5.818650e-02 -6.196233e-02 1.000000e-02 + endloop + endfacet + facet normal -3.619405e-01 -4.375109e-01 -8.231545e-01 + outer loop + vertex -4.996175e-02 -6.876644e-02 1.000000e-02 + vertex -5.818650e-02 -6.196233e-02 1.000000e-02 + vertex -5.099392e-02 -6.164106e-02 6.666667e-03 + endloop + endfacet + facet normal -3.042518e-01 -4.794241e-01 -8.231545e-01 + outer loop + vertex -4.094906e-02 -7.448607e-02 1.000000e-02 + vertex -4.996175e-02 -6.876644e-02 1.000000e-02 + vertex -4.286614e-02 -6.754623e-02 6.666667e-03 + endloop + endfacet + facet normal -4.985173e-01 2.472418e-01 -8.308743e-01 + outer loop + vertex -7.010453e-02 3.854029e-02 6.666667e-03 + vertex -6.184584e-02 3.278859e-02 0.000000e+00 + vertex -6.353028e-02 2.939224e-02 0.000000e+00 + endloop + endfacet + facet normal -2.614862e-01 -4.756416e-01 -8.398750e-01 + outer loop + vertex -4.094906e-02 -7.448607e-02 1.000000e-02 + vertex -4.286614e-02 -6.754623e-02 6.666667e-03 + vertex -3.406234e-02 -7.238616e-02 6.666667e-03 + endloop + endfacet + facet normal -2.739270e-01 -4.982713e-01 -8.226115e-01 + outer loop + vertex -4.094906e-02 -7.448607e-02 1.000000e-02 + vertex -3.832014e-02 -8.143443e-02 1.333333e-02 + vertex -4.822441e-02 -7.598951e-02 1.333333e-02 + endloop + endfacet + facet normal -2.904440e-01 -4.576665e-01 -8.403474e-01 + outer loop + vertex -4.094906e-02 -7.448607e-02 1.000000e-02 + vertex -4.822441e-02 -7.598951e-02 1.333333e-02 + vertex -4.996175e-02 -6.876644e-02 1.000000e-02 + endloop + endfacet + facet normal -1.998106e-01 -5.046639e-01 -8.398750e-01 + outer loop + vertex -3.129059e-02 -7.903100e-02 1.000000e-02 + vertex -3.406234e-02 -7.238616e-02 6.666667e-03 + vertex -2.472136e-02 -7.608452e-02 6.666667e-03 + endloop + endfacet + facet normal -4.222964e-01 3.493540e-01 -8.364314e-01 + outer loop + vertex -7.281153e-02 5.290067e-02 1.333333e-02 + vertex -7.757113e-02 6.310879e-02 2.000000e-02 + vertex -6.560718e-02 6.160924e-02 1.333333e-02 + endloop + endfacet + facet normal -2.417649e-01 -5.137766e-01 -8.231545e-01 + outer loop + vertex -3.129059e-02 -7.903100e-02 1.000000e-02 + vertex -4.094906e-02 -7.448607e-02 1.000000e-02 + vertex -3.406234e-02 -7.238616e-02 6.666667e-03 + endloop + endfacet + facet normal -2.307929e-01 -4.904599e-01 -8.403474e-01 + outer loop + vertex -3.129059e-02 -7.903100e-02 1.000000e-02 + vertex -3.832014e-02 -8.143443e-02 1.333333e-02 + vertex -4.094906e-02 -7.448607e-02 1.000000e-02 + endloop + endfacet + facet normal -2.093170e-01 -5.286745e-01 -8.226115e-01 + outer loop + vertex -3.129059e-02 -7.903100e-02 1.000000e-02 + vertex -2.781153e-02 -8.559509e-02 1.333333e-02 + vertex -3.832014e-02 -8.143443e-02 1.333333e-02 + endloop + endfacet + facet normal -1.662288e-01 -5.413785e-01 -8.241828e-01 + outer loop + vertex -1.707358e-02 -7.303077e-02 3.333333e-03 + vertex -2.235111e-02 -6.633572e-02 0.000000e+00 + vertex -1.872698e-02 -6.744850e-02 0.000000e+00 + endloop + endfacet + facet normal -1.406682e-01 -5.478663e-01 -8.246545e-01 + outer loop + vertex -1.707358e-02 -7.303077e-02 3.333333e-03 + vertex -1.499051e-02 -7.858298e-02 6.666667e-03 + vertex -2.472136e-02 -7.608452e-02 6.666667e-03 + endloop + endfacet + facet normal -1.335329e-01 -5.369476e-01 -8.329803e-01 + outer loop + vertex -1.707358e-02 -7.303077e-02 3.333333e-03 + vertex -1.872698e-02 -6.744850e-02 0.000000e+00 + vertex -1.504793e-02 -6.836344e-02 0.000000e+00 + endloop + endfacet + facet normal -1.050329e-01 -5.473793e-01 -8.302675e-01 + outer loop + vertex -1.707358e-02 -7.303077e-02 3.333333e-03 + vertex -1.504793e-02 -6.836344e-02 0.000000e+00 + vertex -1.132474e-02 -6.907786e-02 0.000000e+00 + endloop + endfacet + facet normal -1.501409e-01 -5.329478e-01 -8.327210e-01 + outer loop + vertex -1.707358e-02 -7.303077e-02 3.333333e-03 + vertex -2.472136e-02 -7.608452e-02 6.666667e-03 + vertex -2.235111e-02 -6.633572e-02 0.000000e+00 + endloop + endfacet + facet normal -5.073876e-01 2.387585e-01 -8.279808e-01 + outer loop + vertex -7.438212e-02 2.944996e-02 6.666667e-03 + vertex -7.010453e-02 3.854029e-02 6.666667e-03 + vertex -6.353028e-02 2.939224e-02 0.000000e+00 + endloop + endfacet + facet normal -2.615256e-01 -4.757133e-01 -8.398221e-01 + outer loop + vertex -4.401312e-02 -8.418934e-02 1.666667e-02 + vertex -4.822441e-02 -7.598951e-02 1.333333e-02 + vertex -3.832014e-02 -8.143443e-02 1.333333e-02 + endloop + endfacet + facet normal -2.782805e-01 -4.809094e-01 -8.314362e-01 + outer loop + vertex -4.401312e-02 -8.418934e-02 1.666667e-02 + vertex -5.388986e-02 -8.423706e-02 2.000000e-02 + vertex -4.822441e-02 -7.598951e-02 1.333333e-02 + endloop + endfacet + facet normal -2.397003e-01 -5.066815e-01 -8.281411e-01 + outer loop + vertex -4.401312e-02 -8.418934e-02 1.666667e-02 + vertex -3.832014e-02 -8.143443e-02 1.333333e-02 + vertex -3.774192e-02 -9.260425e-02 2.000000e-02 + endloop + endfacet + facet normal -2.814533e-01 -4.628302e-01 -8.405785e-01 + outer loop + vertex -4.401312e-02 -8.418934e-02 1.666667e-02 + vertex -5.000000e-02 -8.660254e-02 2.000000e-02 + vertex -5.388986e-02 -8.423706e-02 2.000000e-02 + endloop + endfacet + facet normal -2.666585e-01 -4.871494e-01 -8.316121e-01 + outer loop + vertex -4.401312e-02 -8.418934e-02 1.666667e-02 + vertex -4.600650e-02 -8.878852e-02 2.000000e-02 + vertex -5.000000e-02 -8.660254e-02 2.000000e-02 + endloop + endfacet + facet normal -2.436776e-01 -4.976946e-01 -8.324190e-01 + outer loop + vertex -4.401312e-02 -8.418934e-02 1.666667e-02 + vertex -4.191765e-02 -9.079048e-02 2.000000e-02 + vertex -4.600650e-02 -8.878852e-02 2.000000e-02 + endloop + endfacet + facet normal -2.144246e-01 -4.936550e-01 -8.428089e-01 + outer loop + vertex -4.401312e-02 -8.418934e-02 1.666667e-02 + vertex -3.774192e-02 -9.260425e-02 2.000000e-02 + vertex -4.191765e-02 -9.079048e-02 2.000000e-02 + endloop + endfacet + facet normal -7.468450e-02 -5.481540e-01 -8.330362e-01 + outer loop + vertex -1.109017e-02 -7.417552e-02 3.333333e-03 + vertex -1.132474e-02 -6.907786e-02 0.000000e+00 + vertex -7.568331e-03 -6.958966e-02 0.000000e+00 + endloop + endfacet + facet normal -5.098565e-01 2.193243e-01 -8.318312e-01 + outer loop + vertex -7.438212e-02 2.944996e-02 6.666667e-03 + vertex -6.353028e-02 2.939224e-02 0.000000e+00 + vertex -6.502837e-02 2.590967e-02 0.000000e+00 + endloop + endfacet + facet normal -4.592677e-02 -5.640215e-01 -8.244820e-01 + outer loop + vertex -1.109017e-02 -7.417552e-02 3.333333e-03 + vertex -7.568331e-03 -6.958966e-02 0.000000e+00 + vertex -3.789724e-03 -6.989734e-02 0.000000e+00 + endloop + endfacet + facet normal -5.206442e-01 1.912752e-01 -8.320718e-01 + outer loop + vertex -7.438212e-02 2.944996e-02 6.666667e-03 + vertex -6.502837e-02 2.590967e-02 0.000000e+00 + vertex -6.633572e-02 2.235111e-02 0.000000e+00 + endloop + endfacet + facet normal -5.723149e-02 -5.510062e-01 -8.325363e-01 + outer loop + vertex -1.109017e-02 -7.417552e-02 3.333333e-03 + vertex -3.789724e-03 -6.989734e-02 0.000000e+00 + vertex -5.023242e-03 -7.984214e-02 6.666667e-03 + endloop + endfacet + facet normal -1.033486e-01 -5.401825e-01 -8.351778e-01 + outer loop + vertex -1.109017e-02 -7.417552e-02 3.333333e-03 + vertex -1.499051e-02 -7.858298e-02 6.666667e-03 + vertex -1.707358e-02 -7.303077e-02 3.333333e-03 + endloop + endfacet + facet normal -1.047750e-01 -5.476379e-01 -8.301294e-01 + outer loop + vertex -1.109017e-02 -7.417552e-02 3.333333e-03 + vertex -1.707358e-02 -7.303077e-02 3.333333e-03 + vertex -1.132474e-02 -6.907786e-02 0.000000e+00 + endloop + endfacet + facet normal -7.087519e-02 -5.610349e-01 -8.247524e-01 + outer loop + vertex -1.109017e-02 -7.417552e-02 3.333333e-03 + vertex -5.023242e-03 -7.984214e-02 6.666667e-03 + vertex -1.499051e-02 -7.858298e-02 6.666667e-03 + endloop + endfacet + facet normal -1.349839e-01 -5.257274e-01 -8.398750e-01 + outer loop + vertex -2.113864e-02 -8.232957e-02 1.000000e-02 + vertex -2.472136e-02 -7.608452e-02 6.666667e-03 + vertex -1.499051e-02 -7.858298e-02 6.666667e-03 + endloop + endfacet + facet normal -1.414060e-01 -5.507401e-01 -8.226115e-01 + outer loop + vertex -2.113864e-02 -8.232957e-02 1.000000e-02 + vertex -1.686432e-02 -8.840585e-02 1.333333e-02 + vertex -2.781153e-02 -8.559509e-02 1.333333e-02 + endloop + endfacet + facet normal -1.675021e-01 -5.155185e-01 -8.403474e-01 + outer loop + vertex -2.113864e-02 -8.232957e-02 1.000000e-02 + vertex -2.781153e-02 -8.559509e-02 1.333333e-02 + vertex -3.129059e-02 -7.903100e-02 1.000000e-02 + endloop + endfacet + facet normal -1.754652e-01 -5.400265e-01 -8.231545e-01 + outer loop + vertex -2.113864e-02 -8.232957e-02 1.000000e-02 + vertex -3.129059e-02 -7.903100e-02 1.000000e-02 + vertex -2.472136e-02 -7.608452e-02 6.666667e-03 + endloop + endfacet + facet normal -7.126496e-02 -5.641202e-01 -8.226115e-01 + outer loop + vertex -1.065332e-02 -8.432975e-02 1.000000e-02 + vertex -5.651147e-03 -8.982241e-02 1.333333e-02 + vertex -1.686432e-02 -8.840585e-02 1.333333e-02 + endloop + endfacet + facet normal -6.802835e-02 -5.384999e-01 -8.398750e-01 + outer loop + vertex -1.065332e-02 -8.432975e-02 1.000000e-02 + vertex -1.499051e-02 -7.858298e-02 6.666667e-03 + vertex -5.023242e-03 -7.984214e-02 6.666667e-03 + endloop + endfacet + facet normal -1.015697e-01 -5.324471e-01 -8.403474e-01 + outer loop + vertex -1.065332e-02 -8.432975e-02 1.000000e-02 + vertex -1.686432e-02 -8.840585e-02 1.333333e-02 + vertex -2.113864e-02 -8.232957e-02 1.000000e-02 + endloop + endfacet + facet normal -5.332135e-01 1.732516e-01 -8.280503e-01 + outer loop + vertex -7.748665e-02 1.989519e-02 6.666667e-03 + vertex -7.438212e-02 2.944996e-02 6.666667e-03 + vertex -6.633572e-02 2.235111e-02 0.000000e+00 + endloop + endfacet + facet normal -1.063984e-01 -5.577598e-01 -8.231545e-01 + outer loop + vertex -1.065332e-02 -8.432975e-02 1.000000e-02 + vertex -2.113864e-02 -8.232957e-02 1.000000e-02 + vertex -1.499051e-02 -7.858298e-02 6.666667e-03 + endloop + endfacet + facet normal -3.403549e-02 -5.409786e-01 -8.403474e-01 + outer loop + vertex 2.863664e-16 -8.500000e-02 1.000000e-02 + vertex -5.651147e-03 -8.982241e-02 1.333333e-02 + vertex -1.065332e-02 -8.432975e-02 1.000000e-02 + endloop + endfacet + facet normal 2.249320e-15 -5.427798e-01 -8.398750e-01 + outer loop + vertex 2.863664e-16 -8.500000e-02 1.000000e-02 + vertex -5.023242e-03 -7.984214e-02 6.666667e-03 + vertex 5.023242e-03 -7.984214e-02 6.666667e-03 + endloop + endfacet + facet normal -3.565355e-02 -5.666970e-01 -8.231545e-01 + outer loop + vertex 2.863664e-16 -8.500000e-02 1.000000e-02 + vertex -1.065332e-02 -8.432975e-02 1.000000e-02 + vertex -5.023242e-03 -7.984214e-02 6.666667e-03 + endloop + endfacet + facet normal 2.094521e-15 -5.686038e-01 -8.226115e-01 + outer loop + vertex 2.863664e-16 -8.500000e-02 1.000000e-02 + vertex 5.651147e-03 -8.982241e-02 1.333333e-02 + vertex -5.651147e-03 -8.982241e-02 1.333333e-02 + endloop + endfacet + facet normal 5.723149e-02 -5.510062e-01 -8.325363e-01 + outer loop + vertex 1.109017e-02 -7.417552e-02 3.333333e-03 + vertex 5.023242e-03 -7.984214e-02 6.666667e-03 + vertex 3.789724e-03 -6.989734e-02 0.000000e+00 + endloop + endfacet + facet normal 4.592677e-02 -5.640215e-01 -8.244820e-01 + outer loop + vertex 1.109017e-02 -7.417552e-02 3.333333e-03 + vertex 3.789724e-03 -6.989734e-02 0.000000e+00 + vertex 7.568331e-03 -6.958966e-02 0.000000e+00 + endloop + endfacet + facet normal -5.325177e-01 1.635081e-01 -8.304758e-01 + outer loop + vertex -7.748665e-02 1.989519e-02 6.666667e-03 + vertex -6.633572e-02 2.235111e-02 0.000000e+00 + vertex -6.744850e-02 1.872698e-02 0.000000e+00 + endloop + endfacet + facet normal 7.468450e-02 -5.481540e-01 -8.330362e-01 + outer loop + vertex 1.109017e-02 -7.417552e-02 3.333333e-03 + vertex 7.568331e-03 -6.958966e-02 0.000000e+00 + vertex 1.132474e-02 -6.907786e-02 0.000000e+00 + endloop + endfacet + facet normal 7.087519e-02 -5.610349e-01 -8.247524e-01 + outer loop + vertex 1.109017e-02 -7.417552e-02 3.333333e-03 + vertex 1.499051e-02 -7.858298e-02 6.666667e-03 + vertex 5.023242e-03 -7.984214e-02 6.666667e-03 + endloop + endfacet + facet normal 1.033486e-01 -5.401825e-01 -8.351778e-01 + outer loop + vertex 1.707358e-02 -7.303077e-02 3.333333e-03 + vertex 1.499051e-02 -7.858298e-02 6.666667e-03 + vertex 1.109017e-02 -7.417552e-02 3.333333e-03 + endloop + endfacet + facet normal 1.406682e-01 -5.478663e-01 -8.246545e-01 + outer loop + vertex 1.707358e-02 -7.303077e-02 3.333333e-03 + vertex 2.472136e-02 -7.608452e-02 6.666667e-03 + vertex 1.499051e-02 -7.858298e-02 6.666667e-03 + endloop + endfacet + facet normal 1.050329e-01 -5.473793e-01 -8.302675e-01 + outer loop + vertex 1.707358e-02 -7.303077e-02 3.333333e-03 + vertex 1.132474e-02 -6.907786e-02 0.000000e+00 + vertex 1.504793e-02 -6.836344e-02 0.000000e+00 + endloop + endfacet + facet normal 1.335329e-01 -5.369476e-01 -8.329803e-01 + outer loop + vertex 1.707358e-02 -7.303077e-02 3.333333e-03 + vertex 1.504793e-02 -6.836344e-02 0.000000e+00 + vertex 1.872698e-02 -6.744850e-02 0.000000e+00 + endloop + endfacet + facet normal 1.662288e-01 -5.413785e-01 -8.241828e-01 + outer loop + vertex 1.707358e-02 -7.303077e-02 3.333333e-03 + vertex 1.872698e-02 -6.744850e-02 0.000000e+00 + vertex 2.235111e-02 -6.633572e-02 0.000000e+00 + endloop + endfacet + facet normal 1.501409e-01 -5.329478e-01 -8.327210e-01 + outer loop + vertex 1.707358e-02 -7.303077e-02 3.333333e-03 + vertex 2.235111e-02 -6.633572e-02 0.000000e+00 + vertex 2.472136e-02 -7.608452e-02 6.666667e-03 + endloop + endfacet + facet normal 1.047750e-01 -5.476379e-01 -8.301294e-01 + outer loop + vertex 1.707358e-02 -7.303077e-02 3.333333e-03 + vertex 1.109017e-02 -7.417552e-02 3.333333e-03 + vertex 1.132474e-02 -6.907786e-02 0.000000e+00 + endloop + endfacet + facet normal -4.898350e-02 -5.364340e-01 -8.425195e-01 + outer loop + vertex -1.903040e-03 -9.498094e-02 1.666667e-02 + vertex -6.824241e-03 -9.976688e-02 2.000000e-02 + vertex -1.135802e-02 -9.935288e-02 2.000000e-02 + endloop + endfacet + facet normal -2.522961e-02 -5.537445e-01 -8.323043e-01 + outer loop + vertex -1.903040e-03 -9.498094e-02 1.666667e-02 + vertex -2.276320e-03 -9.997409e-02 2.000000e-02 + vertex -6.824241e-03 -9.976688e-02 2.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -5.552266e-01 -8.316991e-01 + outer loop + vertex -1.903040e-03 -9.498094e-02 1.666667e-02 + vertex 2.276320e-03 -9.997409e-02 2.000000e-02 + vertex -2.276320e-03 -9.997409e-02 2.000000e-02 + endloop + endfacet + facet normal 2.463585e-02 -5.407126e-01 -8.408466e-01 + outer loop + vertex -1.903040e-03 -9.498094e-02 1.666667e-02 + vertex 6.824241e-03 -9.976688e-02 2.000000e-02 + vertex 2.276320e-03 -9.997409e-02 2.000000e-02 + endloop + endfacet + facet normal 1.271821e-02 -5.557584e-01 -8.312465e-01 + outer loop + vertex -1.903040e-03 -9.498094e-02 1.666667e-02 + vertex 5.651147e-03 -8.982241e-02 1.333333e-02 + vertex 6.824241e-03 -9.976688e-02 2.000000e-02 + endloop + endfacet + facet normal -3.332666e-02 -5.593984e-01 -8.282287e-01 + outer loop + vertex -1.903040e-03 -9.498094e-02 1.666667e-02 + vertex -1.135802e-02 -9.935288e-02 2.000000e-02 + vertex -5.651147e-03 -8.982241e-02 1.333333e-02 + endloop + endfacet + facet normal 1.999212e-15 -5.427301e-01 -8.399071e-01 + outer loop + vertex -1.903040e-03 -9.498094e-02 1.666667e-02 + vertex -5.651147e-03 -8.982241e-02 1.333333e-02 + vertex 5.651147e-03 -8.982241e-02 1.333333e-02 + endloop + endfacet + facet normal 3.403549e-02 -5.409786e-01 -8.403474e-01 + outer loop + vertex 1.065332e-02 -8.432975e-02 1.000000e-02 + vertex 5.651147e-03 -8.982241e-02 1.333333e-02 + vertex 2.863664e-16 -8.500000e-02 1.000000e-02 + endloop + endfacet + facet normal 7.126496e-02 -5.641202e-01 -8.226115e-01 + outer loop + vertex 1.065332e-02 -8.432975e-02 1.000000e-02 + vertex 1.686432e-02 -8.840585e-02 1.333333e-02 + vertex 5.651147e-03 -8.982241e-02 1.333333e-02 + endloop + endfacet + facet normal 3.565355e-02 -5.666970e-01 -8.231545e-01 + outer loop + vertex 1.065332e-02 -8.432975e-02 1.000000e-02 + vertex 2.863664e-16 -8.500000e-02 1.000000e-02 + vertex 5.023242e-03 -7.984214e-02 6.666667e-03 + endloop + endfacet + facet normal 6.802835e-02 -5.384999e-01 -8.398750e-01 + outer loop + vertex 1.065332e-02 -8.432975e-02 1.000000e-02 + vertex 5.023242e-03 -7.984214e-02 6.666667e-03 + vertex 1.499051e-02 -7.858298e-02 6.666667e-03 + endloop + endfacet + facet normal 1.015697e-01 -5.324471e-01 -8.403474e-01 + outer loop + vertex 2.113864e-02 -8.232957e-02 1.000000e-02 + vertex 1.686432e-02 -8.840585e-02 1.333333e-02 + vertex 1.065332e-02 -8.432975e-02 1.000000e-02 + endloop + endfacet + facet normal 1.063984e-01 -5.577598e-01 -8.231545e-01 + outer loop + vertex 2.113864e-02 -8.232957e-02 1.000000e-02 + vertex 1.065332e-02 -8.432975e-02 1.000000e-02 + vertex 1.499051e-02 -7.858298e-02 6.666667e-03 + endloop + endfacet + facet normal 1.414060e-01 -5.507401e-01 -8.226115e-01 + outer loop + vertex 2.113864e-02 -8.232957e-02 1.000000e-02 + vertex 2.781153e-02 -8.559509e-02 1.333333e-02 + vertex 1.686432e-02 -8.840585e-02 1.333333e-02 + endloop + endfacet + facet normal -5.549135e-01 4.518513e-02 -8.306800e-01 + outer loop + vertex -7.936918e-02 1.002666e-02 6.666667e-03 + vertex -6.958966e-02 7.568331e-03 0.000000e+00 + vertex -6.989734e-02 3.789724e-03 0.000000e+00 + endloop + endfacet + facet normal 1.349839e-01 -5.257274e-01 -8.398750e-01 + outer loop + vertex 2.113864e-02 -8.232957e-02 1.000000e-02 + vertex 1.499051e-02 -7.858298e-02 6.666667e-03 + vertex 2.472136e-02 -7.608452e-02 6.666667e-03 + endloop + endfacet + facet normal 1.675021e-01 -5.155185e-01 -8.403474e-01 + outer loop + vertex 3.129059e-02 -7.903100e-02 1.000000e-02 + vertex 2.781153e-02 -8.559509e-02 1.333333e-02 + vertex 2.113864e-02 -8.232957e-02 1.000000e-02 + endloop + endfacet + facet normal 1.754652e-01 -5.400265e-01 -8.231545e-01 + outer loop + vertex 3.129059e-02 -7.903100e-02 1.000000e-02 + vertex 2.113864e-02 -8.232957e-02 1.000000e-02 + vertex 2.472136e-02 -7.608452e-02 6.666667e-03 + endloop + endfacet + facet normal 2.093170e-01 -5.286745e-01 -8.226115e-01 + outer loop + vertex 3.129059e-02 -7.903100e-02 1.000000e-02 + vertex 3.832014e-02 -8.143443e-02 1.333333e-02 + vertex 2.781153e-02 -8.559509e-02 1.333333e-02 + endloop + endfacet + facet normal -5.211638e-01 1.693364e-01 -8.364888e-01 + outer loop + vertex -8.717248e-02 2.238209e-02 1.333333e-02 + vertex -9.496397e-02 3.133440e-02 2.000000e-02 + vertex -8.367988e-02 3.313121e-02 1.333333e-02 + endloop + endfacet + facet normal 1.998106e-01 -5.046639e-01 -8.398750e-01 + outer loop + vertex 3.129059e-02 -7.903100e-02 1.000000e-02 + vertex 2.472136e-02 -7.608452e-02 6.666667e-03 + vertex 3.406234e-02 -7.238616e-02 6.666667e-03 + endloop + endfacet + facet normal 3.325528e-01 -4.577197e-01 -8.245613e-01 + outer loop + vertex 4.282575e-02 -6.157073e-02 3.333333e-03 + vertex 5.099392e-02 -6.164106e-02 6.666667e-03 + vertex 4.286614e-02 -6.754623e-02 6.666667e-03 + endloop + endfacet + facet normal -5.282548e-01 1.610655e-01 -8.336695e-01 + outer loop + vertex -8.717248e-02 2.238209e-02 1.333333e-02 + vertex -9.629173e-02 2.697968e-02 2.000000e-02 + vertex -9.496397e-02 3.133440e-02 2.000000e-02 + endloop + endfacet + facet normal 3.000452e-01 -4.694166e-01 -8.304342e-01 + outer loop + vertex 4.282575e-02 -6.157073e-02 3.333333e-03 + vertex 3.608877e-02 -5.998000e-02 0.000000e+00 + vertex 3.928309e-02 -5.793823e-02 0.000000e+00 + endloop + endfacet + facet normal -5.383626e-01 1.377056e-01 -8.313861e-01 + outer loop + vertex -8.717248e-02 2.238209e-02 1.333333e-02 + vertex -9.741991e-02 2.256904e-02 2.000000e-02 + vertex -9.629173e-02 2.697968e-02 2.000000e-02 + endloop + endfacet + facet normal 3.228468e-01 -4.494600e-01 -8.329199e-01 + outer loop + vertex 4.282575e-02 -6.157073e-02 3.333333e-03 + vertex 3.928309e-02 -5.793823e-02 0.000000e+00 + vertex 4.236220e-02 -5.572651e-02 0.000000e+00 + endloop + endfacet + facet normal -5.404341e-01 1.123035e-01 -8.338578e-01 + outer loop + vertex -8.717248e-02 2.238209e-02 1.333333e-02 + vertex -9.834617e-02 1.811162e-02 2.000000e-02 + vertex -9.741991e-02 2.256904e-02 2.000000e-02 + endloop + endfacet + facet normal 3.550852e-01 -4.417458e-01 -8.238781e-01 + outer loop + vertex 4.282575e-02 -6.157073e-02 3.333333e-03 + vertex 4.236220e-02 -5.572651e-02 0.000000e+00 + vertex 4.531704e-02 -5.335134e-02 0.000000e+00 + endloop + endfacet + facet normal 3.361132e-01 -4.396561e-01 -8.329048e-01 + outer loop + vertex 4.282575e-02 -6.157073e-02 3.333333e-03 + vertex 4.531704e-02 -5.335134e-02 0.000000e+00 + vertex 5.099392e-02 -6.164106e-02 6.666667e-03 + endloop + endfacet + facet normal 3.029675e-01 -4.627032e-01 -8.331365e-01 + outer loop + vertex 4.282575e-02 -6.157073e-02 3.333333e-03 + vertex 4.286614e-02 -6.754623e-02 6.666667e-03 + vertex 3.608877e-02 -5.998000e-02 0.000000e+00 + endloop + endfacet + facet normal -5.596051e-01 3.520737e-02 -8.280112e-01 + outer loop + vertex -8.000000e-02 -9.678424e-17 6.666667e-03 + vertex -7.936918e-02 1.002666e-02 6.666667e-03 + vertex -6.989734e-02 3.789724e-03 0.000000e+00 + endloop + endfacet + facet normal 2.417649e-01 -5.137766e-01 -8.231545e-01 + outer loop + vertex 4.094906e-02 -7.448607e-02 1.000000e-02 + vertex 3.129059e-02 -7.903100e-02 1.000000e-02 + vertex 3.406234e-02 -7.238616e-02 6.666667e-03 + endloop + endfacet + facet normal 2.307929e-01 -4.904599e-01 -8.403474e-01 + outer loop + vertex 4.094906e-02 -7.448607e-02 1.000000e-02 + vertex 3.832014e-02 -8.143443e-02 1.333333e-02 + vertex 3.129059e-02 -7.903100e-02 1.000000e-02 + endloop + endfacet + facet normal 2.614862e-01 -4.756416e-01 -8.398750e-01 + outer loop + vertex 4.094906e-02 -7.448607e-02 1.000000e-02 + vertex 3.406234e-02 -7.238616e-02 6.666667e-03 + vertex 4.286614e-02 -6.754623e-02 6.666667e-03 + endloop + endfacet + facet normal 2.739270e-01 -4.982713e-01 -8.226115e-01 + outer loop + vertex 4.094906e-02 -7.448607e-02 1.000000e-02 + vertex 4.822441e-02 -7.598951e-02 1.333333e-02 + vertex 3.832014e-02 -8.143443e-02 1.333333e-02 + endloop + endfacet + facet normal 2.144246e-01 -4.936550e-01 -8.428089e-01 + outer loop + vertex 4.401312e-02 -8.418934e-02 1.666667e-02 + vertex 4.191765e-02 -9.079048e-02 2.000000e-02 + vertex 3.774192e-02 -9.260425e-02 2.000000e-02 + endloop + endfacet + facet normal 2.436776e-01 -4.976946e-01 -8.324190e-01 + outer loop + vertex 4.401312e-02 -8.418934e-02 1.666667e-02 + vertex 4.600650e-02 -8.878852e-02 2.000000e-02 + vertex 4.191765e-02 -9.079048e-02 2.000000e-02 + endloop + endfacet + facet normal 2.666585e-01 -4.871494e-01 -8.316121e-01 + outer loop + vertex 4.401312e-02 -8.418934e-02 1.666667e-02 + vertex 5.000000e-02 -8.660254e-02 2.000000e-02 + vertex 4.600650e-02 -8.878852e-02 2.000000e-02 + endloop + endfacet + facet normal -5.546376e-01 1.502475e-02 -8.319564e-01 + outer loop + vertex -8.000000e-02 -9.678424e-17 6.666667e-03 + vertex -6.989734e-02 3.789724e-03 0.000000e+00 + vertex -7.000000e-02 -5.359996e-17 0.000000e+00 + endloop + endfacet + facet normal 2.814533e-01 -4.628302e-01 -8.405785e-01 + outer loop + vertex 4.401312e-02 -8.418934e-02 1.666667e-02 + vertex 5.388986e-02 -8.423706e-02 2.000000e-02 + vertex 5.000000e-02 -8.660254e-02 2.000000e-02 + endloop + endfacet + facet normal -5.546376e-01 -1.502475e-02 -8.319564e-01 + outer loop + vertex -8.000000e-02 -9.678424e-17 6.666667e-03 + vertex -7.000000e-02 -5.359996e-17 0.000000e+00 + vertex -6.989734e-02 -3.789724e-03 0.000000e+00 + endloop + endfacet + facet normal 2.782805e-01 -4.809094e-01 -8.314362e-01 + outer loop + vertex 4.401312e-02 -8.418934e-02 1.666667e-02 + vertex 4.822441e-02 -7.598951e-02 1.333333e-02 + vertex 5.388986e-02 -8.423706e-02 2.000000e-02 + endloop + endfacet + facet normal 2.397003e-01 -5.066815e-01 -8.281411e-01 + outer loop + vertex 4.401312e-02 -8.418934e-02 1.666667e-02 + vertex 3.774192e-02 -9.260425e-02 2.000000e-02 + vertex 3.832014e-02 -8.143443e-02 1.333333e-02 + endloop + endfacet + facet normal 2.615256e-01 -4.757133e-01 -8.398221e-01 + outer loop + vertex 4.401312e-02 -8.418934e-02 1.666667e-02 + vertex 3.832014e-02 -8.143443e-02 1.333333e-02 + vertex 4.822441e-02 -7.598951e-02 1.333333e-02 + endloop + endfacet + facet normal -5.383146e-01 1.026890e-01 -8.364642e-01 + outer loop + vertex -8.929032e-02 1.127999e-02 1.333333e-02 + vertex -9.834617e-02 1.811162e-02 2.000000e-02 + vertex -8.717248e-02 2.238209e-02 1.333333e-02 + endloop + endfacet + facet normal 3.042518e-01 -4.794241e-01 -8.231545e-01 + outer loop + vertex 4.996175e-02 -6.876644e-02 1.000000e-02 + vertex 4.094906e-02 -7.448607e-02 1.000000e-02 + vertex 4.286614e-02 -6.754623e-02 6.666667e-03 + endloop + endfacet + facet normal 3.342170e-01 -4.600102e-01 -8.226115e-01 + outer loop + vertex 4.996175e-02 -6.876644e-02 1.000000e-02 + vertex 5.736816e-02 -6.934619e-02 1.333333e-02 + vertex 4.822441e-02 -7.598951e-02 1.333333e-02 + endloop + endfacet + facet normal 3.190380e-01 -4.391181e-01 -8.398750e-01 + outer loop + vertex 4.996175e-02 -6.876644e-02 1.000000e-02 + vertex 4.286614e-02 -6.754623e-02 6.666667e-03 + vertex 5.099392e-02 -6.164106e-02 6.666667e-03 + endloop + endfacet + facet normal 2.904440e-01 -4.576665e-01 -8.403474e-01 + outer loop + vertex 4.996175e-02 -6.876644e-02 1.000000e-02 + vertex 4.822441e-02 -7.598951e-02 1.333333e-02 + vertex 4.094906e-02 -7.448607e-02 1.000000e-02 + endloop + endfacet + facet normal 3.619405e-01 -4.375109e-01 -8.231545e-01 + outer loop + vertex 5.818650e-02 -6.196233e-02 1.000000e-02 + vertex 4.996175e-02 -6.876644e-02 1.000000e-02 + vertex 5.099392e-02 -6.164106e-02 6.666667e-03 + endloop + endfacet + facet normal 3.892361e-01 -4.144944e-01 -8.226115e-01 + outer loop + vertex 5.818650e-02 -6.196233e-02 1.000000e-02 + vertex 6.560718e-02 -6.160924e-02 1.333333e-02 + vertex 5.736816e-02 -6.934619e-02 1.333333e-02 + endloop + endfacet + facet normal 3.455146e-01 -4.176553e-01 -8.403474e-01 + outer loop + vertex 5.818650e-02 -6.196233e-02 1.000000e-02 + vertex 5.736816e-02 -6.934619e-02 1.333333e-02 + vertex 4.996175e-02 -6.876644e-02 1.000000e-02 + endloop + endfacet + facet normal 3.715584e-01 -3.956695e-01 -8.398750e-01 + outer loop + vertex 5.818650e-02 -6.196233e-02 1.000000e-02 + vertex 5.099392e-02 -6.164106e-02 6.666667e-03 + vertex 5.831749e-02 -5.476377e-02 6.666667e-03 + endloop + endfacet + facet normal 4.525522e-01 -3.181876e-01 -8.330385e-01 + outer loop + vertex 6.252898e-02 -4.141409e-02 3.333333e-03 + vertex 6.472136e-02 -4.702282e-02 6.666667e-03 + vertex 5.572651e-02 -4.236220e-02 0.000000e+00 + endloop + endfacet + facet normal 4.522879e-01 -3.248780e-01 -8.305961e-01 + outer loop + vertex 6.252898e-02 -4.141409e-02 3.333333e-03 + vertex 5.572651e-02 -4.236220e-02 0.000000e+00 + vertex 5.793823e-02 -3.928309e-02 0.000000e+00 + endloop + endfacet + facet normal 4.744450e-01 -2.843717e-01 -8.330874e-01 + outer loop + vertex 6.252898e-02 -4.141409e-02 3.333333e-03 + vertex 6.184584e-02 -3.278859e-02 0.000000e+00 + vertex 7.010453e-02 -3.854029e-02 6.666667e-03 + endloop + endfacet + facet normal 4.663617e-01 -2.980926e-01 -8.328550e-01 + outer loop + vertex 6.252898e-02 -4.141409e-02 3.333333e-03 + vertex 5.793823e-02 -3.928309e-02 0.000000e+00 + vertex 5.998000e-02 -3.608877e-02 0.000000e+00 + endloop + endfacet + facet normal -5.596051e-01 -3.520737e-02 -8.280112e-01 + outer loop + vertex -7.936918e-02 -1.002666e-02 6.666667e-03 + vertex -8.000000e-02 -9.678424e-17 6.666667e-03 + vertex -6.989734e-02 -3.789724e-03 0.000000e+00 + endloop + endfacet + facet normal 4.937651e-01 -2.791628e-01 -8.235679e-01 + outer loop + vertex 6.252898e-02 -4.141409e-02 3.333333e-03 + vertex 5.998000e-02 -3.608877e-02 0.000000e+00 + vertex 6.184584e-02 -3.278859e-02 0.000000e+00 + endloop + endfacet + facet normal 4.778065e-01 -3.032252e-01 -8.244728e-01 + outer loop + vertex 6.252898e-02 -4.141409e-02 3.333333e-03 + vertex 7.010453e-02 -3.854029e-02 6.666667e-03 + vertex 6.472136e-02 -4.702282e-02 6.666667e-03 + endloop + endfacet + facet normal 4.182191e-01 -3.459809e-01 -8.398750e-01 + outer loop + vertex 6.549363e-02 -5.418104e-02 1.000000e-02 + vertex 5.831749e-02 -5.476377e-02 6.666667e-03 + vertex 6.472136e-02 -4.702282e-02 6.666667e-03 + endloop + endfacet + facet normal 3.951362e-01 -3.710576e-01 -8.403474e-01 + outer loop + vertex 6.549363e-02 -5.418104e-02 1.000000e-02 + vertex 6.560718e-02 -6.160924e-02 1.333333e-02 + vertex 5.818650e-02 -6.196233e-02 1.000000e-02 + endloop + endfacet + facet normal 4.139211e-01 -3.886978e-01 -8.231545e-01 + outer loop + vertex 6.549363e-02 -5.418104e-02 1.000000e-02 + vertex 5.818650e-02 -6.196233e-02 1.000000e-02 + vertex 5.831749e-02 -5.476377e-02 6.666667e-03 + endloop + endfacet + facet normal 4.381168e-01 -3.624417e-01 -8.226115e-01 + outer loop + vertex 6.549363e-02 -5.418104e-02 1.000000e-02 + vertex 7.281153e-02 -5.290067e-02 1.333333e-02 + vertex 6.560718e-02 -6.160924e-02 1.333333e-02 + endloop + endfacet + facet normal -5.549135e-01 -4.518513e-02 -8.306800e-01 + outer loop + vertex -7.936918e-02 -1.002666e-02 6.666667e-03 + vertex -6.989734e-02 -3.789724e-03 0.000000e+00 + vertex -6.958966e-02 -7.568331e-03 0.000000e+00 + endloop + endfacet + facet normal 4.385262e-01 -3.186080e-01 -8.403474e-01 + outer loop + vertex 7.176787e-02 -4.554528e-02 1.000000e-02 + vertex 7.281153e-02 -5.290067e-02 1.333333e-02 + vertex 6.549363e-02 -5.418104e-02 1.000000e-02 + endloop + endfacet + facet normal 4.593740e-01 -3.337547e-01 -8.231545e-01 + outer loop + vertex 7.176787e-02 -4.554528e-02 1.000000e-02 + vertex 6.549363e-02 -5.418104e-02 1.000000e-02 + vertex 6.472136e-02 -4.702282e-02 6.666667e-03 + endloop + endfacet + facet normal 4.582842e-01 -2.908360e-01 -8.398750e-01 + outer loop + vertex 7.176787e-02 -4.554528e-02 1.000000e-02 + vertex 6.472136e-02 -4.702282e-02 6.666667e-03 + vertex 7.010453e-02 -3.854029e-02 6.666667e-03 + endloop + endfacet + facet normal 4.800881e-01 -3.046732e-01 -8.226115e-01 + outer loop + vertex 7.176787e-02 -4.554528e-02 1.000000e-02 + vertex 7.886760e-02 -4.335783e-02 1.333333e-02 + vertex 7.281153e-02 -5.290067e-02 1.333333e-02 + endloop + endfacet + facet normal 4.538247e-01 -3.291853e-01 -8.280581e-01 + outer loop + vertex 7.907961e-02 -5.264423e-02 1.666667e-02 + vertex 7.757113e-02 -6.310879e-02 2.000000e-02 + vertex 7.281153e-02 -5.290067e-02 1.333333e-02 + endloop + endfacet + facet normal 4.247597e-01 -3.297873e-01 -8.431012e-01 + outer loop + vertex 7.907961e-02 -5.264423e-02 1.666667e-02 + vertex 8.036311e-02 -5.951277e-02 2.000000e-02 + vertex 7.757113e-02 -6.310879e-02 2.000000e-02 + endloop + endfacet + facet normal 4.525757e-01 -3.194628e-01 -8.325375e-01 + outer loop + vertex 7.907961e-02 -5.264423e-02 1.666667e-02 + vertex 8.298853e-02 -5.579340e-02 2.000000e-02 + vertex 8.036311e-02 -5.951277e-02 2.000000e-02 + endloop + endfacet + facet normal 4.679210e-01 -2.993480e-01 -8.315291e-01 + outer loop + vertex 7.907961e-02 -5.264423e-02 1.666667e-02 + vertex 8.544194e-02 -5.195840e-02 2.000000e-02 + vertex 8.298853e-02 -5.579340e-02 2.000000e-02 + endloop + endfacet + facet normal 4.694729e-01 -2.710503e-01 -8.403136e-01 + outer loop + vertex 7.907961e-02 -5.264423e-02 1.666667e-02 + vertex 8.771826e-02 -4.801569e-02 2.000000e-02 + vertex 8.544194e-02 -5.195840e-02 2.000000e-02 + endloop + endfacet + facet normal 4.750230e-01 -2.876655e-01 -8.316259e-01 + outer loop + vertex 7.907961e-02 -5.264423e-02 1.666667e-02 + vertex 7.886760e-02 -4.335783e-02 1.333333e-02 + vertex 8.771826e-02 -4.801569e-02 2.000000e-02 + endloop + endfacet + facet normal 4.584693e-01 -2.909535e-01 -8.397332e-01 + outer loop + vertex 7.907961e-02 -5.264423e-02 1.666667e-02 + vertex 7.281153e-02 -5.290067e-02 1.333333e-02 + vertex 7.886760e-02 -4.335783e-02 1.333333e-02 + endloop + endfacet + facet normal 4.975822e-01 -2.735481e-01 -8.231545e-01 + outer loop + vertex 7.691030e-02 -3.619124e-02 1.000000e-02 + vertex 7.176787e-02 -4.554528e-02 1.000000e-02 + vertex 7.010453e-02 -3.854029e-02 6.666667e-03 + endloop + endfacet + facet normal -5.325177e-01 -1.635081e-01 -8.304758e-01 + outer loop + vertex -7.748665e-02 -1.989519e-02 6.666667e-03 + vertex -6.744850e-02 -1.872698e-02 0.000000e+00 + vertex -6.633572e-02 -2.235111e-02 0.000000e+00 + endloop + endfacet + facet normal 4.750005e-01 -2.611337e-01 -8.403474e-01 + outer loop + vertex 7.691030e-02 -3.619124e-02 1.000000e-02 + vertex 7.886760e-02 -4.335783e-02 1.333333e-02 + vertex 7.176787e-02 -4.554528e-02 1.000000e-02 + endloop + endfacet + facet normal 5.144881e-01 -2.420997e-01 -8.226115e-01 + outer loop + vertex 7.691030e-02 -3.619124e-02 1.000000e-02 + vertex 8.367988e-02 -3.313121e-02 1.333333e-02 + vertex 7.886760e-02 -4.335783e-02 1.333333e-02 + endloop + endfacet + facet normal 4.911219e-01 -2.311044e-01 -8.398750e-01 + outer loop + vertex 7.691030e-02 -3.619124e-02 1.000000e-02 + vertex 7.010453e-02 -3.854029e-02 6.666667e-03 + vertex 7.438212e-02 -2.944996e-02 6.666667e-03 + endloop + endfacet + facet normal 5.401871e-01 -1.343385e-01 -8.307533e-01 + outer loop + vertex 7.340025e-02 -1.540789e-02 3.333333e-03 + vertex 6.744850e-02 -1.872698e-02 0.000000e+00 + vertex 6.836344e-02 -1.504793e-02 0.000000e+00 + endloop + endfacet + facet normal 5.436772e-01 -1.043225e-01 -8.327856e-01 + outer loop + vertex 7.340025e-02 -1.540789e-02 3.333333e-03 + vertex 6.836344e-02 -1.504793e-02 0.000000e+00 + vertex 6.907786e-02 -1.132474e-02 0.000000e+00 + endloop + endfacet + facet normal 5.624791e-01 -7.663624e-02 -8.232522e-01 + outer loop + vertex 7.340025e-02 -1.540789e-02 3.333333e-03 + vertex 6.907786e-02 -1.132474e-02 0.000000e+00 + vertex 6.958966e-02 -7.568331e-03 0.000000e+00 + endloop + endfacet + facet normal 5.382144e-01 -1.286072e-01 -8.329378e-01 + outer loop + vertex 7.340025e-02 -1.540789e-02 3.333333e-03 + vertex 7.748665e-02 -1.989519e-02 6.666667e-03 + vertex 6.744850e-02 -1.872698e-02 0.000000e+00 + endloop + endfacet + facet normal 5.559978e-01 -1.060623e-01 -8.243890e-01 + outer loop + vertex 7.340025e-02 -1.540789e-02 3.333333e-03 + vertex 7.936918e-02 -1.002666e-02 6.666667e-03 + vertex 7.748665e-02 -1.989519e-02 6.666667e-03 + endloop + endfacet + facet normal 5.039837e-01 -1.995413e-01 -8.403474e-01 + outer loop + vertex 8.083980e-02 -2.626644e-02 1.000000e-02 + vertex 8.367988e-02 -3.313121e-02 1.333333e-02 + vertex 7.691030e-02 -3.619124e-02 1.000000e-02 + endloop + endfacet + facet normal 5.279433e-01 -2.090275e-01 -8.231545e-01 + outer loop + vertex 8.083980e-02 -2.626644e-02 1.000000e-02 + vertex 7.691030e-02 -3.619124e-02 1.000000e-02 + vertex 7.438212e-02 -2.944996e-02 6.666667e-03 + endloop + endfacet + facet normal 5.162143e-01 -1.677282e-01 -8.398750e-01 + outer loop + vertex 8.083980e-02 -2.626644e-02 1.000000e-02 + vertex 7.438212e-02 -2.944996e-02 6.666667e-03 + vertex 7.748665e-02 -1.989519e-02 6.666667e-03 + endloop + endfacet + facet normal 5.407744e-01 -1.757082e-01 -8.226115e-01 + outer loop + vertex 8.083980e-02 -2.626644e-02 1.000000e-02 + vertex 8.717248e-02 -2.238209e-02 1.333333e-02 + vertex 8.367988e-02 -3.313121e-02 1.333333e-02 + endloop + endfacet + facet normal 5.218550e-01 -2.055191e-01 -8.279066e-01 + outer loop + vertex 8.689205e-02 -3.840275e-02 1.666667e-02 + vertex 8.367988e-02 -3.313121e-02 1.333333e-02 + vertex 9.496397e-02 -3.133440e-02 2.000000e-02 + endloop + endfacet + facet normal 4.820386e-01 -2.497723e-01 -8.397932e-01 + outer loop + vertex 8.689205e-02 -3.840275e-02 1.666667e-02 + vertex 8.981277e-02 -4.397347e-02 2.000000e-02 + vertex 8.771826e-02 -4.801569e-02 2.000000e-02 + endloop + endfacet + facet normal 5.045332e-01 -2.329413e-01 -8.313751e-01 + outer loop + vertex 8.689205e-02 -3.840275e-02 1.666667e-02 + vertex 9.172113e-02 -3.984011e-02 2.000000e-02 + vertex 8.981277e-02 -4.397347e-02 2.000000e-02 + endloop + endfacet + facet normal 5.126521e-01 -2.089372e-01 -8.327863e-01 + outer loop + vertex 8.689205e-02 -3.840275e-02 1.666667e-02 + vertex 9.343938e-02 -3.562417e-02 2.000000e-02 + vertex 9.172113e-02 -3.984011e-02 2.000000e-02 + endloop + endfacet + facet normal 5.058280e-01 -1.797713e-01 -8.436944e-01 + outer loop + vertex 8.689205e-02 -3.840275e-02 1.666667e-02 + vertex 9.496397e-02 -3.133440e-02 2.000000e-02 + vertex 9.343938e-02 -3.562417e-02 2.000000e-02 + endloop + endfacet + facet normal 4.973653e-01 -2.457544e-01 -8.320051e-01 + outer loop + vertex 8.689205e-02 -3.840275e-02 1.666667e-02 + vertex 8.771826e-02 -4.801569e-02 2.000000e-02 + vertex 7.886760e-02 -4.335783e-02 1.333333e-02 + endloop + endfacet + facet normal 4.915851e-01 -2.313224e-01 -8.395439e-01 + outer loop + vertex 8.689205e-02 -3.840275e-02 1.666667e-02 + vertex 7.886760e-02 -4.335783e-02 1.333333e-02 + vertex 8.367988e-02 -3.313121e-02 1.333333e-02 + endloop + endfacet + facet normal -5.206442e-01 -1.912752e-01 -8.320718e-01 + outer loop + vertex -7.438212e-02 -2.944996e-02 6.666667e-03 + vertex -6.633572e-02 -2.235111e-02 0.000000e+00 + vertex -6.502837e-02 -2.590967e-02 0.000000e+00 + endloop + endfacet + facet normal 5.628305e-01 -7.637363e-02 -8.230364e-01 + outer loop + vertex 7.485200e-02 -4.709289e-03 3.333333e-03 + vertex 7.340025e-02 -1.540789e-02 3.333333e-03 + vertex 6.958966e-02 -7.568331e-03 0.000000e+00 + endloop + endfacet + facet normal -5.098565e-01 -2.193243e-01 -8.318312e-01 + outer loop + vertex -7.438212e-02 -2.944996e-02 6.666667e-03 + vertex -6.502837e-02 -2.590967e-02 0.000000e+00 + vertex -6.353028e-02 -2.939224e-02 0.000000e+00 + endloop + endfacet + facet normal 5.354116e-01 -7.265300e-02 -8.414606e-01 + outer loop + vertex 7.485200e-02 -4.709289e-03 3.333333e-03 + vertex 7.936918e-02 -1.002666e-02 6.666667e-03 + vertex 7.340025e-02 -1.540789e-02 3.333333e-03 + endloop + endfacet + facet normal 5.518802e-01 -4.493814e-02 -8.327117e-01 + outer loop + vertex 7.485200e-02 -4.709289e-03 3.333333e-03 + vertex 6.958966e-02 -7.568331e-03 0.000000e+00 + vertex 6.989734e-02 -3.789724e-03 0.000000e+00 + endloop + endfacet + facet normal 5.562092e-01 -1.506733e-02 -8.309057e-01 + outer loop + vertex 7.485200e-02 -4.709289e-03 3.333333e-03 + vertex 6.989734e-02 -3.789724e-03 0.000000e+00 + vertex 7.000000e-02 -1.714506e-17 0.000000e+00 + endloop + endfacet + facet normal -5.332135e-01 -1.732516e-01 -8.280503e-01 + outer loop + vertex -7.438212e-02 -2.944996e-02 6.666667e-03 + vertex -7.748665e-02 -1.989519e-02 6.666667e-03 + vertex -6.633572e-02 -2.235111e-02 0.000000e+00 + endloop + endfacet + facet normal 5.585323e-01 -1.065457e-01 -8.226115e-01 + outer loop + vertex 8.349442e-02 -1.592741e-02 1.000000e-02 + vertex 8.929032e-02 -1.127999e-02 1.333333e-02 + vertex 8.717248e-02 -2.238209e-02 1.333333e-02 + endloop + endfacet + facet normal 5.499784e-01 -1.412105e-01 -8.231545e-01 + outer loop + vertex 8.349442e-02 -1.592741e-02 1.000000e-02 + vertex 8.083980e-02 -2.626644e-02 1.000000e-02 + vertex 7.748665e-02 -1.989519e-02 6.666667e-03 + endloop + endfacet + facet normal 5.250188e-01 -1.348019e-01 -8.403474e-01 + outer loop + vertex 8.349442e-02 -1.592741e-02 1.000000e-02 + vertex 8.717248e-02 -2.238209e-02 1.333333e-02 + vertex 8.083980e-02 -2.626644e-02 1.000000e-02 + endloop + endfacet + facet normal 5.331657e-01 -1.017068e-01 -8.398750e-01 + outer loop + vertex 8.349442e-02 -1.592741e-02 1.000000e-02 + vertex 7.748665e-02 -1.989519e-02 6.666667e-03 + vertex 7.936918e-02 -1.002666e-02 6.666667e-03 + endloop + endfacet + facet normal 5.480581e-01 -8.680388e-02 -8.319239e-01 + outer loop + vertex 8.349442e-02 -1.592741e-02 1.000000e-02 + vertex 7.936918e-02 -1.002666e-02 6.666667e-03 + vertex 8.929032e-02 -1.127999e-02 1.333333e-02 + endloop + endfacet + facet normal 5.524271e-01 -5.221974e-02 -8.319239e-01 + outer loop + vertex 7.984214e-02 -5.023242e-03 6.666667e-03 + vertex 7.936918e-02 -1.002666e-02 6.666667e-03 + vertex 7.485200e-02 -4.709289e-03 3.333333e-03 + endloop + endfacet + facet normal 5.546159e-01 -1.742951e-02 -8.319239e-01 + outer loop + vertex 7.984214e-02 -5.023242e-03 6.666667e-03 + vertex 7.485200e-02 -4.709289e-03 3.333333e-03 + vertex 7.000000e-02 -1.714506e-17 0.000000e+00 + endloop + endfacet + facet normal 5.524271e-01 -5.221974e-02 -8.319239e-01 + outer loop + vertex 7.984214e-02 -5.023242e-03 6.666667e-03 + vertex 8.929032e-02 -1.127999e-02 1.333333e-02 + vertex 7.936918e-02 -1.002666e-02 6.666667e-03 + endloop + endfacet + facet normal -5.383146e-01 -1.026890e-01 -8.364642e-01 + outer loop + vertex -8.717248e-02 -2.238209e-02 1.333333e-02 + vertex -9.834617e-02 -1.811162e-02 2.000000e-02 + vertex -8.929032e-02 -1.127999e-02 1.333333e-02 + endloop + endfacet + facet normal 5.304842e-01 -8.525885e-02 -8.433964e-01 + outer loop + vertex 9.465219e-02 -8.121790e-03 1.666667e-02 + vertex 9.906859e-02 -1.361666e-02 2.000000e-02 + vertex 9.834617e-02 -1.811162e-02 2.000000e-02 + endloop + endfacet + facet normal 5.502009e-01 -6.289895e-02 -8.326600e-01 + outer loop + vertex 9.465219e-02 -8.121790e-03 1.666667e-02 + vertex 9.958568e-02 -9.093486e-03 2.000000e-02 + vertex 9.906859e-02 -1.361666e-02 2.000000e-02 + endloop + endfacet + facet normal -5.404341e-01 -1.123035e-01 -8.338578e-01 + outer loop + vertex -8.717248e-02 -2.238209e-02 1.333333e-02 + vertex -9.741991e-02 -2.256904e-02 2.000000e-02 + vertex -9.834617e-02 -1.811162e-02 2.000000e-02 + endloop + endfacet + facet normal -5.383626e-01 -1.377056e-01 -8.313861e-01 + outer loop + vertex -8.717248e-02 -2.238209e-02 1.333333e-02 + vertex -9.629173e-02 -2.697968e-02 2.000000e-02 + vertex -9.741991e-02 -2.256904e-02 2.000000e-02 + endloop + endfacet + facet normal -5.282548e-01 -1.610655e-01 -8.336695e-01 + outer loop + vertex -8.717248e-02 -2.238209e-02 1.333333e-02 + vertex -9.496397e-02 -3.133440e-02 2.000000e-02 + vertex -9.629173e-02 -2.697968e-02 2.000000e-02 + endloop + endfacet + facet normal 5.562997e-01 -7.056887e-02 -8.279799e-01 + outer loop + vertex 9.465219e-02 -8.121790e-03 1.666667e-02 + vertex 9.834617e-02 -1.811162e-02 2.000000e-02 + vertex 8.929032e-02 -1.127999e-02 1.333333e-02 + endloop + endfacet + facet normal 5.552889e-01 -3.798280e-02 -8.307897e-01 + outer loop + vertex 9.481254e-02 -5.965099e-03 1.666667e-02 + vertex 9.989637e-02 -4.551460e-03 2.000000e-02 + vertex 9.958568e-02 -9.093486e-03 2.000000e-02 + endloop + endfacet + facet normal -4.985173e-01 -2.472418e-01 -8.308743e-01 + outer loop + vertex -7.010453e-02 -3.854029e-02 6.666667e-03 + vertex -6.353028e-02 -2.939224e-02 0.000000e+00 + vertex -6.184584e-02 -3.278859e-02 0.000000e+00 + endloop + endfacet + facet normal 5.507126e-01 -1.253923e-02 -8.346007e-01 + outer loop + vertex 9.481254e-02 -5.965099e-03 1.666667e-02 + vertex 1.000000e-01 -2.449294e-17 2.000000e-02 + vertex 9.989637e-02 -4.551460e-03 2.000000e-02 + endloop + endfacet + facet normal 5.537893e-01 -4.117478e-02 -8.316382e-01 + outer loop + vertex 9.481254e-02 -5.965099e-03 1.666667e-02 + vertex 9.958568e-02 -9.093486e-03 2.000000e-02 + vertex 9.465219e-02 -8.121790e-03 1.666667e-02 + endloop + endfacet + facet normal 5.533953e-01 2.079694e-02 -8.326591e-01 + outer loop + vertex 8.995559e-02 2.826968e-03 1.333333e-02 + vertex 7.000000e-02 -1.714506e-17 0.000000e+00 + vertex 7.984214e-02 5.023242e-03 6.666667e-03 + endloop + endfacet + facet normal -5.073876e-01 -2.387585e-01 -8.279808e-01 + outer loop + vertex -7.010453e-02 -3.854029e-02 6.666667e-03 + vertex -7.438212e-02 -2.944996e-02 6.666667e-03 + vertex -6.353028e-02 -2.939224e-02 0.000000e+00 + endloop + endfacet + facet normal 5.564542e-01 4.379389e-02 -8.297234e-01 + outer loop + vertex 8.995559e-02 2.826968e-03 1.333333e-02 + vertex 7.984214e-02 5.023242e-03 6.666667e-03 + vertex 8.929032e-02 1.127999e-02 1.333333e-02 + endloop + endfacet + facet normal 5.455994e-01 4.293960e-02 -8.369453e-01 + outer loop + vertex 8.995559e-02 2.826968e-03 1.333333e-02 + vertex 8.929032e-02 1.127999e-02 1.333333e-02 + vertex 9.465219e-02 8.121790e-03 1.666667e-02 + endloop + endfacet + facet normal 5.473800e-01 4.069825e-02 -8.358940e-01 + outer loop + vertex 8.995559e-02 2.826968e-03 1.333333e-02 + vertex 9.465219e-02 8.121790e-03 1.666667e-02 + vertex 9.481254e-02 5.965099e-03 1.666667e-02 + endloop + endfacet + facet normal 5.546791e-01 8.713596e-03 -8.320187e-01 + outer loop + vertex 8.995559e-02 2.826968e-03 1.333333e-02 + vertex 1.000000e-01 -2.449294e-17 2.000000e-02 + vertex 7.000000e-02 -1.714506e-17 0.000000e+00 + endloop + endfacet + facet normal 5.568295e-01 2.021687e-02 -8.303807e-01 + outer loop + vertex 8.995559e-02 2.826968e-03 1.333333e-02 + vertex 9.481254e-02 5.965099e-03 1.666667e-02 + vertex 1.000000e-01 -2.449294e-17 2.000000e-02 + endloop + endfacet + facet normal 5.546791e-01 -8.713596e-03 -8.320187e-01 + outer loop + vertex 8.995559e-02 -2.826968e-03 1.333333e-02 + vertex 7.000000e-02 -1.714506e-17 0.000000e+00 + vertex 1.000000e-01 -2.449294e-17 2.000000e-02 + endloop + endfacet + facet normal 5.533953e-01 -2.079694e-02 -8.326591e-01 + outer loop + vertex 8.995559e-02 -2.826968e-03 1.333333e-02 + vertex 7.984214e-02 -5.023242e-03 6.666667e-03 + vertex 7.000000e-02 -1.714506e-17 0.000000e+00 + endloop + endfacet + facet normal 5.564542e-01 -4.379389e-02 -8.297234e-01 + outer loop + vertex 8.995559e-02 -2.826968e-03 1.333333e-02 + vertex 8.929032e-02 -1.127999e-02 1.333333e-02 + vertex 7.984214e-02 -5.023242e-03 6.666667e-03 + endloop + endfacet + facet normal 5.455994e-01 -4.293960e-02 -8.369453e-01 + outer loop + vertex 8.995559e-02 -2.826968e-03 1.333333e-02 + vertex 9.465219e-02 -8.121790e-03 1.666667e-02 + vertex 8.929032e-02 -1.127999e-02 1.333333e-02 + endloop + endfacet + facet normal -5.211638e-01 -1.693364e-01 -8.364888e-01 + outer loop + vertex -8.367988e-02 -3.313121e-02 1.333333e-02 + vertex -9.496397e-02 -3.133440e-02 2.000000e-02 + vertex -8.717248e-02 -2.238209e-02 1.333333e-02 + endloop + endfacet + facet normal 5.473800e-01 -4.069825e-02 -8.358940e-01 + outer loop + vertex 8.995559e-02 -2.826968e-03 1.333333e-02 + vertex 9.481254e-02 -5.965099e-03 1.666667e-02 + vertex 9.465219e-02 -8.121790e-03 1.666667e-02 + endloop + endfacet + facet normal 5.568295e-01 -2.021687e-02 -8.303807e-01 + outer loop + vertex 8.995559e-02 -2.826968e-03 1.333333e-02 + vertex 1.000000e-01 -2.449294e-17 2.000000e-02 + vertex 9.481254e-02 -5.965099e-03 1.666667e-02 + endloop + endfacet + facet normal -4.344248e-01 -3.492005e-01 -8.302615e-01 + outer loop + vertex -6.472136e-02 -4.702282e-02 6.666667e-03 + vertex -5.572651e-02 -4.236220e-02 0.000000e+00 + vertex -5.335134e-02 -4.531704e-02 0.000000e+00 + endloop + endfacet + facet normal -4.127500e-01 -3.702946e-01 -8.321775e-01 + outer loop + vertex -5.831749e-02 -5.476377e-02 6.666667e-03 + vertex -5.335134e-02 -4.531704e-02 0.000000e+00 + vertex -5.081968e-02 -4.813896e-02 0.000000e+00 + endloop + endfacet + facet normal -3.926074e-01 -3.926074e-01 -8.316964e-01 + outer loop + vertex -5.831749e-02 -5.476377e-02 6.666667e-03 + vertex -5.081968e-02 -4.813896e-02 0.000000e+00 + vertex -4.813896e-02 -5.081968e-02 0.000000e+00 + endloop + endfacet + facet normal -4.319368e-01 -3.573292e-01 -8.280981e-01 + outer loop + vertex -5.831749e-02 -5.476377e-02 6.666667e-03 + vertex -6.472136e-02 -4.702282e-02 6.666667e-03 + vertex -5.335134e-02 -4.531704e-02 0.000000e+00 + endloop + endfacet + facet normal -3.714136e-01 -4.139973e-01 -8.310585e-01 + outer loop + vertex -5.099392e-02 -6.164106e-02 6.666667e-03 + vertex -4.813896e-02 -5.081968e-02 0.000000e+00 + vertex -4.531704e-02 -5.335134e-02 0.000000e+00 + endloop + endfacet + facet normal -3.838862e-01 -4.087973e-01 -8.279591e-01 + outer loop + vertex -5.099392e-02 -6.164106e-02 6.666667e-03 + vertex -5.831749e-02 -5.476377e-02 6.666667e-03 + vertex -4.813896e-02 -5.081968e-02 0.000000e+00 + endloop + endfacet + facet normal -4.222964e-01 -3.493540e-01 -8.364314e-01 + outer loop + vertex -6.560718e-02 -6.160924e-02 1.333333e-02 + vertex -7.757113e-02 -6.310879e-02 2.000000e-02 + vertex -7.281153e-02 -5.290067e-02 1.333333e-02 + endloop + endfacet + facet normal -4.199111e-01 -3.578122e-01 -8.340534e-01 + outer loop + vertex -6.560718e-02 -6.160924e-02 1.333333e-02 + vertex -7.461837e-02 -6.657401e-02 2.000000e-02 + vertex -7.757113e-02 -6.310879e-02 2.000000e-02 + endloop + endfacet + facet normal -4.061136e-01 -3.792837e-01 -8.313938e-01 + outer loop + vertex -6.560718e-02 -6.160924e-02 1.333333e-02 + vertex -7.151095e-02 -6.990124e-02 2.000000e-02 + vertex -7.461837e-02 -6.657401e-02 2.000000e-02 + endloop + endfacet + facet normal -3.862302e-01 -3.951244e-01 -8.334884e-01 + outer loop + vertex -6.560718e-02 -6.160924e-02 1.333333e-02 + vertex -6.825531e-02 -7.308360e-02 2.000000e-02 + vertex -7.151095e-02 -6.990124e-02 2.000000e-02 + endloop + endfacet + facet normal -2.744826e-01 -4.854872e-01 -8.300370e-01 + outer loop + vertex -4.286614e-02 -6.754623e-02 6.666667e-03 + vertex -3.608877e-02 -5.998000e-02 0.000000e+00 + vertex -3.278859e-02 -6.184584e-02 0.000000e+00 + endloop + endfacet + facet normal -3.751038e-01 -3.994450e-01 -8.365051e-01 + outer loop + vertex -5.736816e-02 -6.934619e-02 1.333333e-02 + vertex -6.825531e-02 -7.308360e-02 2.000000e-02 + vertex -6.560718e-02 -6.160924e-02 1.333333e-02 + endloop + endfacet + facet normal -3.683470e-01 -4.128556e-01 -8.329890e-01 + outer loop + vertex -5.736816e-02 -6.934619e-02 1.333333e-02 + vertex -6.485821e-02 -7.611447e-02 2.000000e-02 + vertex -6.825531e-02 -7.308360e-02 2.000000e-02 + endloop + endfacet + facet normal -3.506200e-01 -4.309699e-01 -8.314629e-01 + outer loop + vertex -5.736816e-02 -6.934619e-02 1.333333e-02 + vertex -6.132668e-02 -7.898759e-02 2.000000e-02 + vertex -6.485821e-02 -7.611447e-02 2.000000e-02 + endloop + endfacet + facet normal -3.277551e-01 -4.425843e-01 -8.346830e-01 + outer loop + vertex -5.736816e-02 -6.934619e-02 1.333333e-02 + vertex -5.766803e-02 -8.169699e-02 2.000000e-02 + vertex -6.132668e-02 -7.898759e-02 2.000000e-02 + endloop + endfacet + facet normal -2.700229e-01 -4.911698e-01 -8.281545e-01 + outer loop + vertex -3.406234e-02 -7.238616e-02 6.666667e-03 + vertex -4.286614e-02 -6.754623e-02 6.666667e-03 + vertex -3.278859e-02 -6.184584e-02 0.000000e+00 + endloop + endfacet + facet normal -2.463110e-01 -4.966405e-01 -8.322735e-01 + outer loop + vertex -3.406234e-02 -7.238616e-02 6.666667e-03 + vertex -3.278859e-02 -6.184584e-02 0.000000e+00 + vertex -2.939224e-02 -6.353028e-02 0.000000e+00 + endloop + endfacet + facet normal -2.194898e-01 -5.102412e-01 -8.315517e-01 + outer loop + vertex -3.406234e-02 -7.238616e-02 6.666667e-03 + vertex -2.939224e-02 -6.353028e-02 0.000000e+00 + vertex -2.590967e-02 -6.502837e-02 0.000000e+00 + endloop + endfacet + facet normal -3.222807e-01 -4.435813e-01 -8.362839e-01 + outer loop + vertex -4.822441e-02 -7.598951e-02 1.333333e-02 + vertex -5.766803e-02 -8.169699e-02 2.000000e-02 + vertex -5.736816e-02 -6.934619e-02 1.333333e-02 + endloop + endfacet + facet normal -3.093690e-01 -4.601633e-01 -8.321902e-01 + outer loop + vertex -4.822441e-02 -7.598951e-02 1.333333e-02 + vertex -5.388986e-02 -8.423706e-02 2.000000e-02 + vertex -5.766803e-02 -8.169699e-02 2.000000e-02 + endloop + endfacet + facet normal -1.917085e-01 -5.218237e-01 -8.312328e-01 + outer loop + vertex -2.472136e-02 -7.608452e-02 6.666667e-03 + vertex -2.590967e-02 -6.502837e-02 0.000000e+00 + vertex -2.235111e-02 -6.633572e-02 0.000000e+00 + endloop + endfacet + facet normal -2.064471e-01 -5.214259e-01 -8.279460e-01 + outer loop + vertex -2.472136e-02 -7.608452e-02 6.666667e-03 + vertex -3.406234e-02 -7.238616e-02 6.666667e-03 + vertex -2.590967e-02 -6.502837e-02 0.000000e+00 + endloop + endfacet + facet normal -2.017816e-01 -5.096422e-01 -8.363905e-01 + outer loop + vertex -2.781153e-02 -8.559509e-02 1.333333e-02 + vertex -3.774192e-02 -9.260425e-02 2.000000e-02 + vertex -3.832014e-02 -8.143443e-02 1.333333e-02 + endloop + endfacet + facet normal -1.964235e-01 -5.152033e-01 -8.342561e-01 + outer loop + vertex -2.781153e-02 -8.559509e-02 1.333333e-02 + vertex -3.348796e-02 -9.422609e-02 2.000000e-02 + vertex -3.774192e-02 -9.260425e-02 2.000000e-02 + endloop + endfacet + facet normal -1.741129e-01 -5.276775e-01 -8.314091e-01 + outer loop + vertex -2.781153e-02 -8.559509e-02 1.333333e-02 + vertex -2.916459e-02 -9.565263e-02 2.000000e-02 + vertex -3.348796e-02 -9.422609e-02 2.000000e-02 + endloop + endfacet + facet normal -1.491434e-01 -5.322997e-01 -8.333146e-01 + outer loop + vertex -2.781153e-02 -8.559509e-02 1.333333e-02 + vertex -2.478078e-02 -9.688092e-02 2.000000e-02 + vertex -2.916459e-02 -9.565263e-02 2.000000e-02 + endloop + endfacet + facet normal -1.504744e-02 -5.554749e-01 -8.313971e-01 + outer loop + vertex -5.023242e-03 -7.984214e-02 6.666667e-03 + vertex -3.789724e-03 -6.989734e-02 0.000000e+00 + vertex -1.372038e-16 -7.000000e-02 0.000000e+00 + endloop + endfacet + facet normal -7.503591e-02 -5.459268e-01 -8.344660e-01 + outer loop + vertex -1.686432e-02 -8.840585e-02 1.333333e-02 + vertex -1.135802e-02 -9.935288e-02 2.000000e-02 + vertex -1.586825e-02 -9.873297e-02 2.000000e-02 + endloop + endfacet + facet normal -1.362688e-01 -5.307318e-01 -8.365133e-01 + outer loop + vertex -1.686432e-02 -8.840585e-02 1.333333e-02 + vertex -2.478078e-02 -9.688092e-02 2.000000e-02 + vertex -2.781153e-02 -8.559509e-02 1.333333e-02 + endloop + endfacet + facet normal -1.248180e-01 -5.387807e-01 -8.331481e-01 + outer loop + vertex -1.686432e-02 -8.840585e-02 1.333333e-02 + vertex -2.034560e-02 -9.790841e-02 2.000000e-02 + vertex -2.478078e-02 -9.688092e-02 2.000000e-02 + endloop + endfacet + facet normal -1.006329e-01 -5.464371e-01 -8.314322e-01 + outer loop + vertex -1.686432e-02 -8.840585e-02 1.333333e-02 + vertex -1.586825e-02 -9.873297e-02 2.000000e-02 + vertex -2.034560e-02 -9.790841e-02 2.000000e-02 + endloop + endfacet + facet normal 1.504744e-02 -5.554749e-01 -8.313971e-01 + outer loop + vertex 5.023242e-03 -7.984214e-02 6.666667e-03 + vertex -1.372038e-16 -7.000000e-02 0.000000e+00 + vertex 3.789724e-03 -6.989734e-02 0.000000e+00 + endloop + endfacet + facet normal 2.324055e-15 -5.608142e-01 -8.279417e-01 + outer loop + vertex 5.023242e-03 -7.984214e-02 6.666667e-03 + vertex -5.023242e-03 -7.984214e-02 6.666667e-03 + vertex -1.372038e-16 -7.000000e-02 0.000000e+00 + endloop + endfacet + facet normal -6.870882e-02 -5.438863e-01 -8.363413e-01 + outer loop + vertex -5.651147e-03 -8.982241e-02 1.333333e-02 + vertex -1.135802e-02 -9.935288e-02 2.000000e-02 + vertex -1.686432e-02 -8.840585e-02 1.333333e-02 + endloop + endfacet + facet normal 5.040688e-02 -5.520219e-01 -8.323046e-01 + outer loop + vertex 5.651147e-03 -8.982241e-02 1.333333e-02 + vertex 1.135802e-02 -9.935288e-02 2.000000e-02 + vertex 6.824241e-03 -9.976688e-02 2.000000e-02 + endloop + endfacet + facet normal 1.917085e-01 -5.218237e-01 -8.312328e-01 + outer loop + vertex 2.472136e-02 -7.608452e-02 6.666667e-03 + vertex 2.235111e-02 -6.633572e-02 0.000000e+00 + vertex 2.590967e-02 -6.502837e-02 0.000000e+00 + endloop + endfacet + facet normal 7.503591e-02 -5.459268e-01 -8.344660e-01 + outer loop + vertex 1.686432e-02 -8.840585e-02 1.333333e-02 + vertex 1.586825e-02 -9.873297e-02 2.000000e-02 + vertex 1.135802e-02 -9.935288e-02 2.000000e-02 + endloop + endfacet + facet normal 1.006329e-01 -5.464371e-01 -8.314322e-01 + outer loop + vertex 1.686432e-02 -8.840585e-02 1.333333e-02 + vertex 2.034560e-02 -9.790841e-02 2.000000e-02 + vertex 1.586825e-02 -9.873297e-02 2.000000e-02 + endloop + endfacet + facet normal 1.248180e-01 -5.387807e-01 -8.331481e-01 + outer loop + vertex 1.686432e-02 -8.840585e-02 1.333333e-02 + vertex 2.478078e-02 -9.688092e-02 2.000000e-02 + vertex 2.034560e-02 -9.790841e-02 2.000000e-02 + endloop + endfacet + facet normal 6.870882e-02 -5.438863e-01 -8.363413e-01 + outer loop + vertex 1.686432e-02 -8.840585e-02 1.333333e-02 + vertex 1.135802e-02 -9.935288e-02 2.000000e-02 + vertex 5.651147e-03 -8.982241e-02 1.333333e-02 + endloop + endfacet + facet normal 2.194898e-01 -5.102412e-01 -8.315517e-01 + outer loop + vertex 3.406234e-02 -7.238616e-02 6.666667e-03 + vertex 2.590967e-02 -6.502837e-02 0.000000e+00 + vertex 2.939224e-02 -6.353028e-02 0.000000e+00 + endloop + endfacet + facet normal 2.463110e-01 -4.966405e-01 -8.322735e-01 + outer loop + vertex 3.406234e-02 -7.238616e-02 6.666667e-03 + vertex 2.939224e-02 -6.353028e-02 0.000000e+00 + vertex 3.278859e-02 -6.184584e-02 0.000000e+00 + endloop + endfacet + facet normal 2.064471e-01 -5.214259e-01 -8.279460e-01 + outer loop + vertex 3.406234e-02 -7.238616e-02 6.666667e-03 + vertex 2.472136e-02 -7.608452e-02 6.666667e-03 + vertex 2.590967e-02 -6.502837e-02 0.000000e+00 + endloop + endfacet + facet normal 1.491434e-01 -5.322997e-01 -8.333146e-01 + outer loop + vertex 2.781153e-02 -8.559509e-02 1.333333e-02 + vertex 2.916459e-02 -9.565263e-02 2.000000e-02 + vertex 2.478078e-02 -9.688092e-02 2.000000e-02 + endloop + endfacet + facet normal 1.741129e-01 -5.276775e-01 -8.314091e-01 + outer loop + vertex 2.781153e-02 -8.559509e-02 1.333333e-02 + vertex 3.348796e-02 -9.422609e-02 2.000000e-02 + vertex 2.916459e-02 -9.565263e-02 2.000000e-02 + endloop + endfacet + facet normal 1.964235e-01 -5.152033e-01 -8.342561e-01 + outer loop + vertex 2.781153e-02 -8.559509e-02 1.333333e-02 + vertex 3.774192e-02 -9.260425e-02 2.000000e-02 + vertex 3.348796e-02 -9.422609e-02 2.000000e-02 + endloop + endfacet + facet normal 1.362688e-01 -5.307318e-01 -8.365133e-01 + outer loop + vertex 2.781153e-02 -8.559509e-02 1.333333e-02 + vertex 2.478078e-02 -9.688092e-02 2.000000e-02 + vertex 1.686432e-02 -8.840585e-02 1.333333e-02 + endloop + endfacet + facet normal 2.744826e-01 -4.854872e-01 -8.300370e-01 + outer loop + vertex 4.286614e-02 -6.754623e-02 6.666667e-03 + vertex 3.278859e-02 -6.184584e-02 0.000000e+00 + vertex 3.608877e-02 -5.998000e-02 0.000000e+00 + endloop + endfacet + facet normal 2.700229e-01 -4.911698e-01 -8.281545e-01 + outer loop + vertex 4.286614e-02 -6.754623e-02 6.666667e-03 + vertex 3.406234e-02 -7.238616e-02 6.666667e-03 + vertex 3.278859e-02 -6.184584e-02 0.000000e+00 + endloop + endfacet + facet normal 2.017816e-01 -5.096422e-01 -8.363905e-01 + outer loop + vertex 3.832014e-02 -8.143443e-02 1.333333e-02 + vertex 3.774192e-02 -9.260425e-02 2.000000e-02 + vertex 2.781153e-02 -8.559509e-02 1.333333e-02 + endloop + endfacet + facet normal 3.714136e-01 -4.139973e-01 -8.310585e-01 + outer loop + vertex 5.099392e-02 -6.164106e-02 6.666667e-03 + vertex 4.531704e-02 -5.335134e-02 0.000000e+00 + vertex 4.813896e-02 -5.081968e-02 0.000000e+00 + endloop + endfacet + facet normal 3.093690e-01 -4.601633e-01 -8.321902e-01 + outer loop + vertex 4.822441e-02 -7.598951e-02 1.333333e-02 + vertex 5.766803e-02 -8.169699e-02 2.000000e-02 + vertex 5.388986e-02 -8.423706e-02 2.000000e-02 + endloop + endfacet + facet normal 3.838862e-01 -4.087973e-01 -8.279591e-01 + outer loop + vertex 5.831749e-02 -5.476377e-02 6.666667e-03 + vertex 5.099392e-02 -6.164106e-02 6.666667e-03 + vertex 4.813896e-02 -5.081968e-02 0.000000e+00 + endloop + endfacet + facet normal 3.926074e-01 -3.926074e-01 -8.316964e-01 + outer loop + vertex 5.831749e-02 -5.476377e-02 6.666667e-03 + vertex 4.813896e-02 -5.081968e-02 0.000000e+00 + vertex 5.081968e-02 -4.813896e-02 0.000000e+00 + endloop + endfacet + facet normal 4.127500e-01 -3.702946e-01 -8.321775e-01 + outer loop + vertex 5.831749e-02 -5.476377e-02 6.666667e-03 + vertex 5.081968e-02 -4.813896e-02 0.000000e+00 + vertex 5.335134e-02 -4.531704e-02 0.000000e+00 + endloop + endfacet + facet normal 3.277551e-01 -4.425843e-01 -8.346830e-01 + outer loop + vertex 5.736816e-02 -6.934619e-02 1.333333e-02 + vertex 6.132668e-02 -7.898759e-02 2.000000e-02 + vertex 5.766803e-02 -8.169699e-02 2.000000e-02 + endloop + endfacet + facet normal 3.506200e-01 -4.309699e-01 -8.314629e-01 + outer loop + vertex 5.736816e-02 -6.934619e-02 1.333333e-02 + vertex 6.485821e-02 -7.611447e-02 2.000000e-02 + vertex 6.132668e-02 -7.898759e-02 2.000000e-02 + endloop + endfacet + facet normal 3.683470e-01 -4.128556e-01 -8.329890e-01 + outer loop + vertex 5.736816e-02 -6.934619e-02 1.333333e-02 + vertex 6.825531e-02 -7.308360e-02 2.000000e-02 + vertex 6.485821e-02 -7.611447e-02 2.000000e-02 + endloop + endfacet + facet normal 3.222807e-01 -4.435813e-01 -8.362839e-01 + outer loop + vertex 5.736816e-02 -6.934619e-02 1.333333e-02 + vertex 5.766803e-02 -8.169699e-02 2.000000e-02 + vertex 4.822441e-02 -7.598951e-02 1.333333e-02 + endloop + endfacet + facet normal 4.319368e-01 -3.573292e-01 -8.280981e-01 + outer loop + vertex 6.472136e-02 -4.702282e-02 6.666667e-03 + vertex 5.831749e-02 -5.476377e-02 6.666667e-03 + vertex 5.335134e-02 -4.531704e-02 0.000000e+00 + endloop + endfacet +endsolid diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r1.stl b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r1.stl new file mode 100644 index 00000000..360d9c1e --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r1.stl @@ -0,0 +1,3894 @@ +solid + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.997986e-02 8.972966e-04 8.000000e-02 + vertex 2.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.991949e-02 1.792786e-03 8.000000e-02 + vertex 1.997986e-02 8.972966e-04 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.981900e-02 2.684665e-03 8.000000e-02 + vertex 1.991949e-02 1.792786e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.967859e-02 3.571138e-03 8.000000e-02 + vertex 1.981900e-02 2.684665e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.949856e-02 4.450419e-03 8.000000e-02 + vertex 1.967859e-02 3.571138e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.927926e-02 5.320737e-03 8.000000e-02 + vertex 1.949856e-02 4.450419e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.902113e-02 6.180340e-03 8.000000e-02 + vertex 1.927926e-02 5.320737e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.872470e-02 7.027496e-03 8.000000e-02 + vertex 1.902113e-02 6.180340e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.839056e-02 7.860501e-03 8.000000e-02 + vertex 1.872470e-02 7.027496e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.801938e-02 8.677675e-03 8.000000e-02 + vertex 1.839056e-02 7.860501e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.761191e-02 9.477373e-03 8.000000e-02 + vertex 1.801938e-02 8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.716898e-02 1.025799e-02 8.000000e-02 + vertex 1.761191e-02 9.477373e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.669147e-02 1.101794e-02 8.000000e-02 + vertex 1.716898e-02 1.025799e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.618034e-02 1.175571e-02 8.000000e-02 + vertex 1.669147e-02 1.101794e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.563663e-02 1.246980e-02 8.000000e-02 + vertex 1.618034e-02 1.175571e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.506143e-02 1.315877e-02 8.000000e-02 + vertex 1.563663e-02 1.246980e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.445590e-02 1.382125e-02 8.000000e-02 + vertex 1.506143e-02 1.315877e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.445590e-02 1.382125e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.315877e-02 1.506143e-02 8.000000e-02 + vertex 1.382125e-02 1.445590e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.246980e-02 1.563663e-02 8.000000e-02 + vertex 1.315877e-02 1.506143e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.175571e-02 1.618034e-02 8.000000e-02 + vertex 1.246980e-02 1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.101794e-02 1.669147e-02 8.000000e-02 + vertex 1.175571e-02 1.618034e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.025799e-02 1.716898e-02 8.000000e-02 + vertex 1.101794e-02 1.669147e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 9.477373e-03 1.761191e-02 8.000000e-02 + vertex 1.025799e-02 1.716898e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 8.677675e-03 1.801938e-02 8.000000e-02 + vertex 9.477373e-03 1.761191e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 7.860501e-03 1.839056e-02 8.000000e-02 + vertex 8.677675e-03 1.801938e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 7.027496e-03 1.872470e-02 8.000000e-02 + vertex 7.860501e-03 1.839056e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 6.180340e-03 1.902113e-02 8.000000e-02 + vertex 7.027496e-03 1.872470e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 5.320737e-03 1.927926e-02 8.000000e-02 + vertex 6.180340e-03 1.902113e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 4.450419e-03 1.949856e-02 8.000000e-02 + vertex 5.320737e-03 1.927926e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 3.571138e-03 1.967859e-02 8.000000e-02 + vertex 4.450419e-03 1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 2.684665e-03 1.981900e-02 8.000000e-02 + vertex 3.571138e-03 1.967859e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.792786e-03 1.991949e-02 8.000000e-02 + vertex 2.684665e-03 1.981900e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 8.972966e-04 1.997986e-02 8.000000e-02 + vertex 1.792786e-03 1.991949e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.224647e-18 2.000000e-02 8.000000e-02 + vertex 8.972966e-04 1.997986e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -8.972966e-04 1.997986e-02 8.000000e-02 + vertex 1.224647e-18 2.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.792786e-03 1.991949e-02 8.000000e-02 + vertex -8.972966e-04 1.997986e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -2.684665e-03 1.981900e-02 8.000000e-02 + vertex -1.792786e-03 1.991949e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -3.571138e-03 1.967859e-02 8.000000e-02 + vertex -2.684665e-03 1.981900e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -4.450419e-03 1.949856e-02 8.000000e-02 + vertex -3.571138e-03 1.967859e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -5.320737e-03 1.927926e-02 8.000000e-02 + vertex -4.450419e-03 1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -6.180340e-03 1.902113e-02 8.000000e-02 + vertex -5.320737e-03 1.927926e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -7.027496e-03 1.872470e-02 8.000000e-02 + vertex -6.180340e-03 1.902113e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -7.860501e-03 1.839056e-02 8.000000e-02 + vertex -7.027496e-03 1.872470e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -8.677675e-03 1.801938e-02 8.000000e-02 + vertex -7.860501e-03 1.839056e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -9.477373e-03 1.761191e-02 8.000000e-02 + vertex -8.677675e-03 1.801938e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.025799e-02 1.716898e-02 8.000000e-02 + vertex -9.477373e-03 1.761191e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.101794e-02 1.669147e-02 8.000000e-02 + vertex -1.025799e-02 1.716898e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.175571e-02 1.618034e-02 8.000000e-02 + vertex -1.101794e-02 1.669147e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.246980e-02 1.563663e-02 8.000000e-02 + vertex -1.175571e-02 1.618034e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.315877e-02 1.506143e-02 8.000000e-02 + vertex -1.246980e-02 1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.506143e-02 1.315877e-02 8.000000e-02 + vertex -1.445590e-02 1.382125e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.563663e-02 1.246980e-02 8.000000e-02 + vertex -1.506143e-02 1.315877e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.618034e-02 1.175571e-02 8.000000e-02 + vertex -1.563663e-02 1.246980e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.669147e-02 1.101794e-02 8.000000e-02 + vertex -1.618034e-02 1.175571e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.716898e-02 1.025799e-02 8.000000e-02 + vertex -1.669147e-02 1.101794e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.761191e-02 9.477373e-03 8.000000e-02 + vertex -1.716898e-02 1.025799e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.801938e-02 8.677675e-03 8.000000e-02 + vertex -1.761191e-02 9.477373e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.839056e-02 7.860501e-03 8.000000e-02 + vertex -1.801938e-02 8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.872470e-02 7.027496e-03 8.000000e-02 + vertex -1.839056e-02 7.860501e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.902113e-02 6.180340e-03 8.000000e-02 + vertex -1.872470e-02 7.027496e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.927926e-02 5.320737e-03 8.000000e-02 + vertex -1.902113e-02 6.180340e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.949856e-02 4.450419e-03 8.000000e-02 + vertex -1.927926e-02 5.320737e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.967859e-02 3.571138e-03 8.000000e-02 + vertex -1.949856e-02 4.450419e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.981900e-02 2.684665e-03 8.000000e-02 + vertex -1.967859e-02 3.571138e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.991949e-02 1.792786e-03 8.000000e-02 + vertex -1.981900e-02 2.684665e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.997986e-02 8.972966e-04 8.000000e-02 + vertex -1.991949e-02 1.792786e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -2.000000e-02 2.449294e-18 8.000000e-02 + vertex -1.997986e-02 8.972966e-04 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.997986e-02 -8.972966e-04 8.000000e-02 + vertex -2.000000e-02 2.449294e-18 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.991949e-02 -1.792786e-03 8.000000e-02 + vertex -1.997986e-02 -8.972966e-04 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.981900e-02 -2.684665e-03 8.000000e-02 + vertex -1.991949e-02 -1.792786e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.967859e-02 -3.571138e-03 8.000000e-02 + vertex -1.981900e-02 -2.684665e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.949856e-02 -4.450419e-03 8.000000e-02 + vertex -1.967859e-02 -3.571138e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.927926e-02 -5.320737e-03 8.000000e-02 + vertex -1.949856e-02 -4.450419e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.902113e-02 -6.180340e-03 8.000000e-02 + vertex -1.927926e-02 -5.320737e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.872470e-02 -7.027496e-03 8.000000e-02 + vertex -1.902113e-02 -6.180340e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.839056e-02 -7.860501e-03 8.000000e-02 + vertex -1.872470e-02 -7.027496e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.801938e-02 -8.677675e-03 8.000000e-02 + vertex -1.839056e-02 -7.860501e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.761191e-02 -9.477373e-03 8.000000e-02 + vertex -1.801938e-02 -8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.716898e-02 -1.025799e-02 8.000000e-02 + vertex -1.761191e-02 -9.477373e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.669147e-02 -1.101794e-02 8.000000e-02 + vertex -1.716898e-02 -1.025799e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.618034e-02 -1.175571e-02 8.000000e-02 + vertex -1.669147e-02 -1.101794e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.563663e-02 -1.246980e-02 8.000000e-02 + vertex -1.618034e-02 -1.175571e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.506143e-02 -1.315877e-02 8.000000e-02 + vertex -1.563663e-02 -1.246980e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.445590e-02 -1.382125e-02 8.000000e-02 + vertex -1.506143e-02 -1.315877e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.382125e-02 -1.445590e-02 8.000000e-02 + vertex -1.445590e-02 -1.382125e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.315877e-02 -1.506143e-02 8.000000e-02 + vertex -1.382125e-02 -1.445590e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.246980e-02 -1.563663e-02 8.000000e-02 + vertex -1.315877e-02 -1.506143e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.175571e-02 -1.618034e-02 8.000000e-02 + vertex -1.246980e-02 -1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.101794e-02 -1.669147e-02 8.000000e-02 + vertex -1.175571e-02 -1.618034e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.025799e-02 -1.716898e-02 8.000000e-02 + vertex -1.101794e-02 -1.669147e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -9.477373e-03 -1.761191e-02 8.000000e-02 + vertex -1.025799e-02 -1.716898e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -8.677675e-03 -1.801938e-02 8.000000e-02 + vertex -9.477373e-03 -1.761191e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -7.860501e-03 -1.839056e-02 8.000000e-02 + vertex -8.677675e-03 -1.801938e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -7.027496e-03 -1.872470e-02 8.000000e-02 + vertex -7.860501e-03 -1.839056e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -6.180340e-03 -1.902113e-02 8.000000e-02 + vertex -7.027496e-03 -1.872470e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -5.320737e-03 -1.927926e-02 8.000000e-02 + vertex -6.180340e-03 -1.902113e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -4.450419e-03 -1.949856e-02 8.000000e-02 + vertex -5.320737e-03 -1.927926e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -3.571138e-03 -1.967859e-02 8.000000e-02 + vertex -4.450419e-03 -1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -2.684665e-03 -1.981900e-02 8.000000e-02 + vertex -3.571138e-03 -1.967859e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.792786e-03 -1.991949e-02 8.000000e-02 + vertex -2.684665e-03 -1.981900e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -8.972966e-04 -1.997986e-02 8.000000e-02 + vertex -1.792786e-03 -1.991949e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -3.673940e-18 -2.000000e-02 8.000000e-02 + vertex -8.972966e-04 -1.997986e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 8.972966e-04 -1.997986e-02 8.000000e-02 + vertex -3.673940e-18 -2.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.792786e-03 -1.991949e-02 8.000000e-02 + vertex 8.972966e-04 -1.997986e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 2.684665e-03 -1.981900e-02 8.000000e-02 + vertex 1.792786e-03 -1.991949e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 3.571138e-03 -1.967859e-02 8.000000e-02 + vertex 2.684665e-03 -1.981900e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 4.450419e-03 -1.949856e-02 8.000000e-02 + vertex 3.571138e-03 -1.967859e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 5.320737e-03 -1.927926e-02 8.000000e-02 + vertex 4.450419e-03 -1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 6.180340e-03 -1.902113e-02 8.000000e-02 + vertex 5.320737e-03 -1.927926e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 7.027496e-03 -1.872470e-02 8.000000e-02 + vertex 6.180340e-03 -1.902113e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 7.860501e-03 -1.839056e-02 8.000000e-02 + vertex 7.027496e-03 -1.872470e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 8.677675e-03 -1.801938e-02 8.000000e-02 + vertex 7.860501e-03 -1.839056e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 9.477373e-03 -1.761191e-02 8.000000e-02 + vertex 8.677675e-03 -1.801938e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.025799e-02 -1.716898e-02 8.000000e-02 + vertex 9.477373e-03 -1.761191e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.101794e-02 -1.669147e-02 8.000000e-02 + vertex 1.025799e-02 -1.716898e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.175571e-02 -1.618034e-02 8.000000e-02 + vertex 1.101794e-02 -1.669147e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.246980e-02 -1.563663e-02 8.000000e-02 + vertex 1.175571e-02 -1.618034e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.315877e-02 -1.506143e-02 8.000000e-02 + vertex 1.246980e-02 -1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.382125e-02 -1.445590e-02 8.000000e-02 + vertex 1.315877e-02 -1.506143e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.445590e-02 -1.382125e-02 8.000000e-02 + vertex 1.382125e-02 -1.445590e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.506143e-02 -1.315877e-02 8.000000e-02 + vertex 1.445590e-02 -1.382125e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.563663e-02 -1.246980e-02 8.000000e-02 + vertex 1.506143e-02 -1.315877e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.618034e-02 -1.175571e-02 8.000000e-02 + vertex 1.563663e-02 -1.246980e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.669147e-02 -1.101794e-02 8.000000e-02 + vertex 1.618034e-02 -1.175571e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.716898e-02 -1.025799e-02 8.000000e-02 + vertex 1.669147e-02 -1.101794e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.761191e-02 -9.477373e-03 8.000000e-02 + vertex 1.716898e-02 -1.025799e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.801938e-02 -8.677675e-03 8.000000e-02 + vertex 1.761191e-02 -9.477373e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.839056e-02 -7.860501e-03 8.000000e-02 + vertex 1.801938e-02 -8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.872470e-02 -7.027496e-03 8.000000e-02 + vertex 1.839056e-02 -7.860501e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.902113e-02 -6.180340e-03 8.000000e-02 + vertex 1.872470e-02 -7.027496e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.927926e-02 -5.320737e-03 8.000000e-02 + vertex 1.902113e-02 -6.180340e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.949856e-02 -4.450419e-03 8.000000e-02 + vertex 1.927926e-02 -5.320737e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.967859e-02 -3.571138e-03 8.000000e-02 + vertex 1.949856e-02 -4.450419e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.981900e-02 -2.684665e-03 8.000000e-02 + vertex 1.967859e-02 -3.571138e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.991949e-02 -1.792786e-03 8.000000e-02 + vertex 1.981900e-02 -2.684665e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.997986e-02 -8.972966e-04 8.000000e-02 + vertex 1.991949e-02 -1.792786e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex 2.000000e-02 0.000000e+00 8.000000e-02 + vertex 1.997986e-02 -8.972966e-04 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 -7.956245e-01 -0.000000e+00 + outer loop + vertex -1.175571e-02 -1.618034e-02 1.000000e-01 + vertex -1.246980e-02 -1.563663e-02 1.000000e-01 + vertex -1.246980e-02 -1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex -1.175571e-02 -1.618034e-02 1.000000e-01 + vertex -1.246980e-02 -1.563663e-02 8.000000e-02 + vertex -1.175571e-02 -1.618034e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 -8.220021e-01 -0.000000e+00 + outer loop + vertex -1.101794e-02 -1.669147e-02 1.000000e-01 + vertex -1.175571e-02 -1.618034e-02 1.000000e-01 + vertex -1.175571e-02 -1.618034e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex -1.101794e-02 -1.669147e-02 1.000000e-01 + vertex -1.175571e-02 -1.618034e-02 8.000000e-02 + vertex -1.101794e-02 -1.669147e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 -8.467242e-01 -0.000000e+00 + outer loop + vertex -1.025799e-02 -1.716898e-02 1.000000e-01 + vertex -1.101794e-02 -1.669147e-02 1.000000e-01 + vertex -1.101794e-02 -1.669147e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex -1.025799e-02 -1.716898e-02 1.000000e-01 + vertex -1.101794e-02 -1.669147e-02 8.000000e-02 + vertex -1.025799e-02 -1.716898e-02 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex 1.997986e-02 8.972966e-04 1.000000e-01 + vertex 2.000000e-02 0.000000e+00 8.000000e-02 + vertex 1.997986e-02 8.972966e-04 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex 1.997986e-02 8.972966e-04 1.000000e-01 + vertex 2.000000e-02 0.000000e+00 1.000000e-01 + vertex 2.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 -8.697411e-01 -0.000000e+00 + outer loop + vertex -9.477373e-03 -1.761191e-02 1.000000e-01 + vertex -1.025799e-02 -1.716898e-02 1.000000e-01 + vertex -1.025799e-02 -1.716898e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex -9.477373e-03 -1.761191e-02 1.000000e-01 + vertex -1.025799e-02 -1.716898e-02 8.000000e-02 + vertex -9.477373e-03 -1.761191e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex 1.991949e-02 1.792786e-03 1.000000e-01 + vertex 1.997986e-02 8.972966e-04 8.000000e-02 + vertex 1.991949e-02 1.792786e-03 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex 1.991949e-02 1.792786e-03 1.000000e-01 + vertex 1.997986e-02 8.972966e-04 1.000000e-01 + vertex 1.997986e-02 8.972966e-04 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 -8.910065e-01 -0.000000e+00 + outer loop + vertex -8.677675e-03 -1.801938e-02 1.000000e-01 + vertex -9.477373e-03 -1.761191e-02 1.000000e-01 + vertex -9.477373e-03 -1.761191e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex -8.677675e-03 -1.801938e-02 1.000000e-01 + vertex -9.477373e-03 -1.761191e-02 8.000000e-02 + vertex -8.677675e-03 -1.801938e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex 1.981900e-02 2.684665e-03 1.000000e-01 + vertex 1.991949e-02 1.792786e-03 8.000000e-02 + vertex 1.981900e-02 2.684665e-03 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex 1.981900e-02 2.684665e-03 1.000000e-01 + vertex 1.991949e-02 1.792786e-03 1.000000e-01 + vertex 1.991949e-02 1.792786e-03 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 -9.104775e-01 -0.000000e+00 + outer loop + vertex -7.860501e-03 -1.839056e-02 1.000000e-01 + vertex -8.677675e-03 -1.801938e-02 1.000000e-01 + vertex -8.677675e-03 -1.801938e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex -7.860501e-03 -1.839056e-02 1.000000e-01 + vertex -8.677675e-03 -1.801938e-02 8.000000e-02 + vertex -7.860501e-03 -1.839056e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex 1.967859e-02 3.571138e-03 1.000000e-01 + vertex 1.981900e-02 2.684665e-03 1.000000e-01 + vertex 1.981900e-02 2.684665e-03 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex 1.967859e-02 3.571138e-03 1.000000e-01 + vertex 1.981900e-02 2.684665e-03 8.000000e-02 + vertex 1.967859e-02 3.571138e-03 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 -9.281150e-01 -0.000000e+00 + outer loop + vertex -7.027496e-03 -1.872470e-02 1.000000e-01 + vertex -7.860501e-03 -1.839056e-02 1.000000e-01 + vertex -7.860501e-03 -1.839056e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex -7.027496e-03 -1.872470e-02 1.000000e-01 + vertex -7.860501e-03 -1.839056e-02 8.000000e-02 + vertex -7.027496e-03 -1.872470e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex 1.949856e-02 4.450419e-03 1.000000e-01 + vertex 1.967859e-02 3.571138e-03 1.000000e-01 + vertex 1.967859e-02 3.571138e-03 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex 1.949856e-02 4.450419e-03 1.000000e-01 + vertex 1.967859e-02 3.571138e-03 8.000000e-02 + vertex 1.949856e-02 4.450419e-03 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 -9.438833e-01 -0.000000e+00 + outer loop + vertex -6.180340e-03 -1.902113e-02 1.000000e-01 + vertex -7.027496e-03 -1.872470e-02 1.000000e-01 + vertex -7.027496e-03 -1.872470e-02 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex -6.180340e-03 -1.902113e-02 1.000000e-01 + vertex -7.027496e-03 -1.872470e-02 8.000000e-02 + vertex -6.180340e-03 -1.902113e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex 1.927926e-02 5.320737e-03 1.000000e-01 + vertex 1.949856e-02 4.450419e-03 8.000000e-02 + vertex 1.927926e-02 5.320737e-03 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex 1.927926e-02 5.320737e-03 1.000000e-01 + vertex 1.949856e-02 4.450419e-03 1.000000e-01 + vertex 1.949856e-02 4.450419e-03 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 -9.577508e-01 -0.000000e+00 + outer loop + vertex -5.320737e-03 -1.927926e-02 1.000000e-01 + vertex -6.180340e-03 -1.902113e-02 1.000000e-01 + vertex -6.180340e-03 -1.902113e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex 1.902113e-02 6.180340e-03 1.000000e-01 + vertex 1.927926e-02 5.320737e-03 8.000000e-02 + vertex 1.902113e-02 6.180340e-03 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex -5.320737e-03 -1.927926e-02 1.000000e-01 + vertex -6.180340e-03 -1.902113e-02 8.000000e-02 + vertex -5.320737e-03 -1.927926e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex 1.902113e-02 6.180340e-03 1.000000e-01 + vertex 1.927926e-02 5.320737e-03 1.000000e-01 + vertex 1.927926e-02 5.320737e-03 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 -9.696895e-01 -0.000000e+00 + outer loop + vertex -4.450419e-03 -1.949856e-02 1.000000e-01 + vertex -5.320737e-03 -1.927926e-02 1.000000e-01 + vertex -5.320737e-03 -1.927926e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex 1.872470e-02 7.027496e-03 1.000000e-01 + vertex 1.902113e-02 6.180340e-03 1.000000e-01 + vertex 1.902113e-02 6.180340e-03 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex -4.450419e-03 -1.949856e-02 1.000000e-01 + vertex -5.320737e-03 -1.927926e-02 8.000000e-02 + vertex -4.450419e-03 -1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex 1.872470e-02 7.027496e-03 1.000000e-01 + vertex 1.902113e-02 6.180340e-03 8.000000e-02 + vertex 1.872470e-02 7.027496e-03 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex -3.571138e-03 -1.967859e-02 1.000000e-01 + vertex -4.450419e-03 -1.949856e-02 8.000000e-02 + vertex -3.571138e-03 -1.967859e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 -9.796754e-01 -0.000000e+00 + outer loop + vertex -3.571138e-03 -1.967859e-02 1.000000e-01 + vertex -4.450419e-03 -1.949856e-02 1.000000e-01 + vertex -4.450419e-03 -1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex 1.839056e-02 7.860501e-03 1.000000e-01 + vertex 1.872470e-02 7.027496e-03 8.000000e-02 + vertex 1.839056e-02 7.860501e-03 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex 1.839056e-02 7.860501e-03 1.000000e-01 + vertex 1.872470e-02 7.027496e-03 1.000000e-01 + vertex 1.872470e-02 7.027496e-03 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex -2.684665e-03 -1.981900e-02 1.000000e-01 + vertex -3.571138e-03 -1.967859e-02 8.000000e-02 + vertex -2.684665e-03 -1.981900e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 -9.876883e-01 -0.000000e+00 + outer loop + vertex -2.684665e-03 -1.981900e-02 1.000000e-01 + vertex -3.571138e-03 -1.967859e-02 1.000000e-01 + vertex -3.571138e-03 -1.967859e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex 1.801938e-02 8.677675e-03 1.000000e-01 + vertex 1.839056e-02 7.860501e-03 8.000000e-02 + vertex 1.801938e-02 8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex 1.801938e-02 8.677675e-03 1.000000e-01 + vertex 1.839056e-02 7.860501e-03 1.000000e-01 + vertex 1.839056e-02 7.860501e-03 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex -1.792786e-03 -1.991949e-02 1.000000e-01 + vertex -2.684665e-03 -1.981900e-02 8.000000e-02 + vertex -1.792786e-03 -1.991949e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 -9.937122e-01 -0.000000e+00 + outer loop + vertex -1.792786e-03 -1.991949e-02 1.000000e-01 + vertex -2.684665e-03 -1.981900e-02 1.000000e-01 + vertex -2.684665e-03 -1.981900e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex 1.761191e-02 9.477373e-03 1.000000e-01 + vertex 1.801938e-02 8.677675e-03 8.000000e-02 + vertex 1.761191e-02 9.477373e-03 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex 1.761191e-02 9.477373e-03 1.000000e-01 + vertex 1.801938e-02 8.677675e-03 1.000000e-01 + vertex 1.801938e-02 8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex -8.972966e-04 -1.997986e-02 1.000000e-01 + vertex -1.792786e-03 -1.991949e-02 8.000000e-02 + vertex -8.972966e-04 -1.997986e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 -9.977349e-01 -0.000000e+00 + outer loop + vertex -8.972966e-04 -1.997986e-02 1.000000e-01 + vertex -1.792786e-03 -1.991949e-02 1.000000e-01 + vertex -1.792786e-03 -1.991949e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex 1.716898e-02 1.025799e-02 1.000000e-01 + vertex 1.761191e-02 9.477373e-03 8.000000e-02 + vertex 1.716898e-02 1.025799e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex 1.716898e-02 1.025799e-02 1.000000e-01 + vertex 1.761191e-02 9.477373e-03 1.000000e-01 + vertex 1.761191e-02 9.477373e-03 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex -3.673940e-18 -2.000000e-02 1.000000e-01 + vertex -8.972966e-04 -1.997986e-02 8.000000e-02 + vertex -3.673940e-18 -2.000000e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 -9.997482e-01 -0.000000e+00 + outer loop + vertex -3.673940e-18 -2.000000e-02 1.000000e-01 + vertex -8.972966e-04 -1.997986e-02 1.000000e-01 + vertex -8.972966e-04 -1.997986e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex 1.669147e-02 1.101794e-02 1.000000e-01 + vertex 1.716898e-02 1.025799e-02 8.000000e-02 + vertex 1.669147e-02 1.101794e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex 1.669147e-02 1.101794e-02 1.000000e-01 + vertex 1.716898e-02 1.025799e-02 1.000000e-01 + vertex 1.716898e-02 1.025799e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex 8.972966e-04 -1.997986e-02 1.000000e-01 + vertex -3.673940e-18 -2.000000e-02 8.000000e-02 + vertex 8.972966e-04 -1.997986e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex 8.972966e-04 -1.997986e-02 1.000000e-01 + vertex -3.673940e-18 -2.000000e-02 1.000000e-01 + vertex -3.673940e-18 -2.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex 1.618034e-02 1.175571e-02 1.000000e-01 + vertex 1.669147e-02 1.101794e-02 8.000000e-02 + vertex 1.618034e-02 1.175571e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex 1.792786e-03 -1.991949e-02 1.000000e-01 + vertex 8.972966e-04 -1.997986e-02 1.000000e-01 + vertex 8.972966e-04 -1.997986e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex 1.618034e-02 1.175571e-02 1.000000e-01 + vertex 1.669147e-02 1.101794e-02 1.000000e-01 + vertex 1.669147e-02 1.101794e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex 1.792786e-03 -1.991949e-02 1.000000e-01 + vertex 8.972966e-04 -1.997986e-02 8.000000e-02 + vertex 1.792786e-03 -1.991949e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex 1.563663e-02 1.246980e-02 1.000000e-01 + vertex 1.618034e-02 1.175571e-02 8.000000e-02 + vertex 1.563663e-02 1.246980e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex 2.684665e-03 -1.981900e-02 1.000000e-01 + vertex 1.792786e-03 -1.991949e-02 8.000000e-02 + vertex 2.684665e-03 -1.981900e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex 1.563663e-02 1.246980e-02 1.000000e-01 + vertex 1.618034e-02 1.175571e-02 1.000000e-01 + vertex 1.618034e-02 1.175571e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex 2.684665e-03 -1.981900e-02 1.000000e-01 + vertex 1.792786e-03 -1.991949e-02 1.000000e-01 + vertex 1.792786e-03 -1.991949e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex 1.506143e-02 1.315877e-02 1.000000e-01 + vertex 1.563663e-02 1.246980e-02 8.000000e-02 + vertex 1.506143e-02 1.315877e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex 3.571138e-03 -1.967859e-02 1.000000e-01 + vertex 2.684665e-03 -1.981900e-02 8.000000e-02 + vertex 3.571138e-03 -1.967859e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex 1.506143e-02 1.315877e-02 1.000000e-01 + vertex 1.563663e-02 1.246980e-02 1.000000e-01 + vertex 1.563663e-02 1.246980e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex 3.571138e-03 -1.967859e-02 1.000000e-01 + vertex 2.684665e-03 -1.981900e-02 1.000000e-01 + vertex 2.684665e-03 -1.981900e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex 4.450419e-03 -1.949856e-02 1.000000e-01 + vertex 3.571138e-03 -1.967859e-02 8.000000e-02 + vertex 4.450419e-03 -1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.506143e-02 1.315877e-02 8.000000e-02 + vertex 1.445590e-02 1.382125e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex 4.450419e-03 -1.949856e-02 1.000000e-01 + vertex 3.571138e-03 -1.967859e-02 1.000000e-01 + vertex 3.571138e-03 -1.967859e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.506143e-02 1.315877e-02 1.000000e-01 + vertex 1.506143e-02 1.315877e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex 5.320737e-03 -1.927926e-02 1.000000e-01 + vertex 4.450419e-03 -1.949856e-02 8.000000e-02 + vertex 5.320737e-03 -1.927926e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex 1.382125e-02 1.445590e-02 1.000000e-01 + vertex 1.445590e-02 1.382125e-02 8.000000e-02 + vertex 1.382125e-02 1.445590e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex 5.320737e-03 -1.927926e-02 1.000000e-01 + vertex 4.450419e-03 -1.949856e-02 1.000000e-01 + vertex 4.450419e-03 -1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex 1.382125e-02 1.445590e-02 1.000000e-01 + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.445590e-02 1.382125e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex 6.180340e-03 -1.902113e-02 1.000000e-01 + vertex 5.320737e-03 -1.927926e-02 8.000000e-02 + vertex 6.180340e-03 -1.902113e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex 1.315877e-02 1.506143e-02 1.000000e-01 + vertex 1.382125e-02 1.445590e-02 8.000000e-02 + vertex 1.315877e-02 1.506143e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex 6.180340e-03 -1.902113e-02 1.000000e-01 + vertex 5.320737e-03 -1.927926e-02 1.000000e-01 + vertex 5.320737e-03 -1.927926e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex 1.315877e-02 1.506143e-02 1.000000e-01 + vertex 1.382125e-02 1.445590e-02 1.000000e-01 + vertex 1.382125e-02 1.445590e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex 7.027496e-03 -1.872470e-02 1.000000e-01 + vertex 6.180340e-03 -1.902113e-02 8.000000e-02 + vertex 7.027496e-03 -1.872470e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex 7.027496e-03 -1.872470e-02 1.000000e-01 + vertex 6.180340e-03 -1.902113e-02 1.000000e-01 + vertex 6.180340e-03 -1.902113e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex 1.246980e-02 1.563663e-02 1.000000e-01 + vertex 1.315877e-02 1.506143e-02 8.000000e-02 + vertex 1.246980e-02 1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex 1.246980e-02 1.563663e-02 1.000000e-01 + vertex 1.315877e-02 1.506143e-02 1.000000e-01 + vertex 1.315877e-02 1.506143e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex 7.860501e-03 -1.839056e-02 1.000000e-01 + vertex 7.027496e-03 -1.872470e-02 8.000000e-02 + vertex 7.860501e-03 -1.839056e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex 7.860501e-03 -1.839056e-02 1.000000e-01 + vertex 7.027496e-03 -1.872470e-02 1.000000e-01 + vertex 7.027496e-03 -1.872470e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex 1.175571e-02 1.618034e-02 1.000000e-01 + vertex 1.246980e-02 1.563663e-02 8.000000e-02 + vertex 1.175571e-02 1.618034e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex 1.175571e-02 1.618034e-02 1.000000e-01 + vertex 1.246980e-02 1.563663e-02 1.000000e-01 + vertex 1.246980e-02 1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex 8.677675e-03 -1.801938e-02 1.000000e-01 + vertex 7.860501e-03 -1.839056e-02 8.000000e-02 + vertex 8.677675e-03 -1.801938e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex 8.677675e-03 -1.801938e-02 1.000000e-01 + vertex 7.860501e-03 -1.839056e-02 1.000000e-01 + vertex 7.860501e-03 -1.839056e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex 1.101794e-02 1.669147e-02 1.000000e-01 + vertex 1.175571e-02 1.618034e-02 8.000000e-02 + vertex 1.101794e-02 1.669147e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex 1.101794e-02 1.669147e-02 1.000000e-01 + vertex 1.175571e-02 1.618034e-02 1.000000e-01 + vertex 1.175571e-02 1.618034e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex 9.477373e-03 -1.761191e-02 1.000000e-01 + vertex 8.677675e-03 -1.801938e-02 8.000000e-02 + vertex 9.477373e-03 -1.761191e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex 9.477373e-03 -1.761191e-02 1.000000e-01 + vertex 8.677675e-03 -1.801938e-02 1.000000e-01 + vertex 8.677675e-03 -1.801938e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex 1.025799e-02 1.716898e-02 1.000000e-01 + vertex 1.101794e-02 1.669147e-02 8.000000e-02 + vertex 1.025799e-02 1.716898e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex 1.025799e-02 1.716898e-02 1.000000e-01 + vertex 1.101794e-02 1.669147e-02 1.000000e-01 + vertex 1.101794e-02 1.669147e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex 1.025799e-02 -1.716898e-02 1.000000e-01 + vertex 9.477373e-03 -1.761191e-02 8.000000e-02 + vertex 1.025799e-02 -1.716898e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex 1.025799e-02 -1.716898e-02 1.000000e-01 + vertex 9.477373e-03 -1.761191e-02 1.000000e-01 + vertex 9.477373e-03 -1.761191e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex 9.477373e-03 1.761191e-02 1.000000e-01 + vertex 1.025799e-02 1.716898e-02 8.000000e-02 + vertex 9.477373e-03 1.761191e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex 1.101794e-02 -1.669147e-02 1.000000e-01 + vertex 1.025799e-02 -1.716898e-02 8.000000e-02 + vertex 1.101794e-02 -1.669147e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex 9.477373e-03 1.761191e-02 1.000000e-01 + vertex 1.025799e-02 1.716898e-02 1.000000e-01 + vertex 1.025799e-02 1.716898e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex 1.101794e-02 -1.669147e-02 1.000000e-01 + vertex 1.025799e-02 -1.716898e-02 1.000000e-01 + vertex 1.025799e-02 -1.716898e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex 8.677675e-03 1.801938e-02 1.000000e-01 + vertex 9.477373e-03 1.761191e-02 8.000000e-02 + vertex 8.677675e-03 1.801938e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex 1.175571e-02 -1.618034e-02 1.000000e-01 + vertex 1.101794e-02 -1.669147e-02 8.000000e-02 + vertex 1.175571e-02 -1.618034e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex 8.677675e-03 1.801938e-02 1.000000e-01 + vertex 9.477373e-03 1.761191e-02 1.000000e-01 + vertex 9.477373e-03 1.761191e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex 1.175571e-02 -1.618034e-02 1.000000e-01 + vertex 1.101794e-02 -1.669147e-02 1.000000e-01 + vertex 1.101794e-02 -1.669147e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex 7.860501e-03 1.839056e-02 1.000000e-01 + vertex 8.677675e-03 1.801938e-02 8.000000e-02 + vertex 7.860501e-03 1.839056e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex 1.246980e-02 -1.563663e-02 1.000000e-01 + vertex 1.175571e-02 -1.618034e-02 8.000000e-02 + vertex 1.246980e-02 -1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex 7.860501e-03 1.839056e-02 1.000000e-01 + vertex 8.677675e-03 1.801938e-02 1.000000e-01 + vertex 8.677675e-03 1.801938e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex 1.246980e-02 -1.563663e-02 1.000000e-01 + vertex 1.175571e-02 -1.618034e-02 1.000000e-01 + vertex 1.175571e-02 -1.618034e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex 1.315877e-02 -1.506143e-02 1.000000e-01 + vertex 1.246980e-02 -1.563663e-02 8.000000e-02 + vertex 1.315877e-02 -1.506143e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex 7.027496e-03 1.872470e-02 1.000000e-01 + vertex 7.860501e-03 1.839056e-02 8.000000e-02 + vertex 7.027496e-03 1.872470e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex 1.315877e-02 -1.506143e-02 1.000000e-01 + vertex 1.246980e-02 -1.563663e-02 1.000000e-01 + vertex 1.246980e-02 -1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex 7.027496e-03 1.872470e-02 1.000000e-01 + vertex 7.860501e-03 1.839056e-02 1.000000e-01 + vertex 7.860501e-03 1.839056e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex 1.382125e-02 -1.445590e-02 1.000000e-01 + vertex 1.315877e-02 -1.506143e-02 8.000000e-02 + vertex 1.382125e-02 -1.445590e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex 6.180340e-03 1.902113e-02 1.000000e-01 + vertex 7.027496e-03 1.872470e-02 8.000000e-02 + vertex 6.180340e-03 1.902113e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex 1.382125e-02 -1.445590e-02 1.000000e-01 + vertex 1.315877e-02 -1.506143e-02 1.000000e-01 + vertex 1.315877e-02 -1.506143e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex 6.180340e-03 1.902113e-02 1.000000e-01 + vertex 7.027496e-03 1.872470e-02 1.000000e-01 + vertex 7.027496e-03 1.872470e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex 1.445590e-02 -1.382125e-02 1.000000e-01 + vertex 1.382125e-02 -1.445590e-02 8.000000e-02 + vertex 1.445590e-02 -1.382125e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex 1.445590e-02 -1.382125e-02 1.000000e-01 + vertex 1.382125e-02 -1.445590e-02 1.000000e-01 + vertex 1.382125e-02 -1.445590e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex 5.320737e-03 1.927926e-02 1.000000e-01 + vertex 6.180340e-03 1.902113e-02 8.000000e-02 + vertex 5.320737e-03 1.927926e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex 5.320737e-03 1.927926e-02 1.000000e-01 + vertex 6.180340e-03 1.902113e-02 1.000000e-01 + vertex 6.180340e-03 1.902113e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex 1.506143e-02 -1.315877e-02 1.000000e-01 + vertex 1.445590e-02 -1.382125e-02 8.000000e-02 + vertex 1.506143e-02 -1.315877e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex 1.506143e-02 -1.315877e-02 1.000000e-01 + vertex 1.445590e-02 -1.382125e-02 1.000000e-01 + vertex 1.445590e-02 -1.382125e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex 4.450419e-03 1.949856e-02 1.000000e-01 + vertex 5.320737e-03 1.927926e-02 1.000000e-01 + vertex 5.320737e-03 1.927926e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex 4.450419e-03 1.949856e-02 1.000000e-01 + vertex 5.320737e-03 1.927926e-02 8.000000e-02 + vertex 4.450419e-03 1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex 1.563663e-02 -1.246980e-02 1.000000e-01 + vertex 1.506143e-02 -1.315877e-02 8.000000e-02 + vertex 1.563663e-02 -1.246980e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex 1.563663e-02 -1.246980e-02 1.000000e-01 + vertex 1.506143e-02 -1.315877e-02 1.000000e-01 + vertex 1.506143e-02 -1.315877e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex 3.571138e-03 1.967859e-02 1.000000e-01 + vertex 4.450419e-03 1.949856e-02 1.000000e-01 + vertex 4.450419e-03 1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex 3.571138e-03 1.967859e-02 1.000000e-01 + vertex 4.450419e-03 1.949856e-02 8.000000e-02 + vertex 3.571138e-03 1.967859e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex 1.618034e-02 -1.175571e-02 1.000000e-01 + vertex 1.563663e-02 -1.246980e-02 8.000000e-02 + vertex 1.618034e-02 -1.175571e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex 1.618034e-02 -1.175571e-02 1.000000e-01 + vertex 1.563663e-02 -1.246980e-02 1.000000e-01 + vertex 1.563663e-02 -1.246980e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex 2.684665e-03 1.981900e-02 1.000000e-01 + vertex 3.571138e-03 1.967859e-02 1.000000e-01 + vertex 3.571138e-03 1.967859e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex 2.684665e-03 1.981900e-02 1.000000e-01 + vertex 3.571138e-03 1.967859e-02 8.000000e-02 + vertex 2.684665e-03 1.981900e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex 1.669147e-02 -1.101794e-02 1.000000e-01 + vertex 1.618034e-02 -1.175571e-02 8.000000e-02 + vertex 1.669147e-02 -1.101794e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex 1.669147e-02 -1.101794e-02 1.000000e-01 + vertex 1.618034e-02 -1.175571e-02 1.000000e-01 + vertex 1.618034e-02 -1.175571e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex 1.792786e-03 1.991949e-02 1.000000e-01 + vertex 2.684665e-03 1.981900e-02 1.000000e-01 + vertex 2.684665e-03 1.981900e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex 1.792786e-03 1.991949e-02 1.000000e-01 + vertex 2.684665e-03 1.981900e-02 8.000000e-02 + vertex 1.792786e-03 1.991949e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex 1.716898e-02 -1.025799e-02 1.000000e-01 + vertex 1.669147e-02 -1.101794e-02 8.000000e-02 + vertex 1.716898e-02 -1.025799e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex 1.716898e-02 -1.025799e-02 1.000000e-01 + vertex 1.669147e-02 -1.101794e-02 1.000000e-01 + vertex 1.669147e-02 -1.101794e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex 8.972966e-04 1.997986e-02 1.000000e-01 + vertex 1.792786e-03 1.991949e-02 1.000000e-01 + vertex 1.792786e-03 1.991949e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex 8.972966e-04 1.997986e-02 1.000000e-01 + vertex 1.792786e-03 1.991949e-02 8.000000e-02 + vertex 8.972966e-04 1.997986e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex 1.761191e-02 -9.477373e-03 1.000000e-01 + vertex 1.716898e-02 -1.025799e-02 8.000000e-02 + vertex 1.761191e-02 -9.477373e-03 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex 1.761191e-02 -9.477373e-03 1.000000e-01 + vertex 1.716898e-02 -1.025799e-02 1.000000e-01 + vertex 1.716898e-02 -1.025799e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex 1.224647e-18 2.000000e-02 1.000000e-01 + vertex 8.972966e-04 1.997986e-02 1.000000e-01 + vertex 8.972966e-04 1.997986e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex 1.224647e-18 2.000000e-02 1.000000e-01 + vertex 8.972966e-04 1.997986e-02 8.000000e-02 + vertex 1.224647e-18 2.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex 1.801938e-02 -8.677675e-03 1.000000e-01 + vertex 1.761191e-02 -9.477373e-03 1.000000e-01 + vertex 1.761191e-02 -9.477373e-03 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex 1.801938e-02 -8.677675e-03 1.000000e-01 + vertex 1.761191e-02 -9.477373e-03 8.000000e-02 + vertex 1.801938e-02 -8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex 1.839056e-02 -7.860501e-03 1.000000e-01 + vertex 1.801938e-02 -8.677675e-03 1.000000e-01 + vertex 1.801938e-02 -8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex -8.972966e-04 1.997986e-02 1.000000e-01 + vertex 1.224647e-18 2.000000e-02 1.000000e-01 + vertex 1.224647e-18 2.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex 1.839056e-02 -7.860501e-03 1.000000e-01 + vertex 1.801938e-02 -8.677675e-03 8.000000e-02 + vertex 1.839056e-02 -7.860501e-03 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex -8.972966e-04 1.997986e-02 1.000000e-01 + vertex 1.224647e-18 2.000000e-02 8.000000e-02 + vertex -8.972966e-04 1.997986e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex 1.872470e-02 -7.027496e-03 1.000000e-01 + vertex 1.839056e-02 -7.860501e-03 1.000000e-01 + vertex 1.839056e-02 -7.860501e-03 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex -1.792786e-03 1.991949e-02 1.000000e-01 + vertex -8.972966e-04 1.997986e-02 1.000000e-01 + vertex -8.972966e-04 1.997986e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex 1.872470e-02 -7.027496e-03 1.000000e-01 + vertex 1.839056e-02 -7.860501e-03 8.000000e-02 + vertex 1.872470e-02 -7.027496e-03 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex -1.792786e-03 1.991949e-02 1.000000e-01 + vertex -8.972966e-04 1.997986e-02 8.000000e-02 + vertex -1.792786e-03 1.991949e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex 1.902113e-02 -6.180340e-03 1.000000e-01 + vertex 1.872470e-02 -7.027496e-03 1.000000e-01 + vertex 1.872470e-02 -7.027496e-03 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex 1.902113e-02 -6.180340e-03 1.000000e-01 + vertex 1.872470e-02 -7.027496e-03 8.000000e-02 + vertex 1.902113e-02 -6.180340e-03 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex -2.684665e-03 1.981900e-02 1.000000e-01 + vertex -1.792786e-03 1.991949e-02 1.000000e-01 + vertex -1.792786e-03 1.991949e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex -2.684665e-03 1.981900e-02 1.000000e-01 + vertex -1.792786e-03 1.991949e-02 8.000000e-02 + vertex -2.684665e-03 1.981900e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex 1.927926e-02 -5.320737e-03 1.000000e-01 + vertex 1.902113e-02 -6.180340e-03 1.000000e-01 + vertex 1.902113e-02 -6.180340e-03 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex 1.927926e-02 -5.320737e-03 1.000000e-01 + vertex 1.902113e-02 -6.180340e-03 8.000000e-02 + vertex 1.927926e-02 -5.320737e-03 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex -3.571138e-03 1.967859e-02 1.000000e-01 + vertex -2.684665e-03 1.981900e-02 8.000000e-02 + vertex -3.571138e-03 1.967859e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex -3.571138e-03 1.967859e-02 1.000000e-01 + vertex -2.684665e-03 1.981900e-02 1.000000e-01 + vertex -2.684665e-03 1.981900e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex 1.949856e-02 -4.450419e-03 1.000000e-01 + vertex 1.927926e-02 -5.320737e-03 1.000000e-01 + vertex 1.927926e-02 -5.320737e-03 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex 1.949856e-02 -4.450419e-03 1.000000e-01 + vertex 1.927926e-02 -5.320737e-03 8.000000e-02 + vertex 1.949856e-02 -4.450419e-03 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex -4.450419e-03 1.949856e-02 1.000000e-01 + vertex -3.571138e-03 1.967859e-02 8.000000e-02 + vertex -4.450419e-03 1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex -4.450419e-03 1.949856e-02 1.000000e-01 + vertex -3.571138e-03 1.967859e-02 1.000000e-01 + vertex -3.571138e-03 1.967859e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex 1.967859e-02 -3.571138e-03 1.000000e-01 + vertex 1.949856e-02 -4.450419e-03 1.000000e-01 + vertex 1.949856e-02 -4.450419e-03 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex 1.967859e-02 -3.571138e-03 1.000000e-01 + vertex 1.949856e-02 -4.450419e-03 8.000000e-02 + vertex 1.967859e-02 -3.571138e-03 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex -5.320737e-03 1.927926e-02 1.000000e-01 + vertex -4.450419e-03 1.949856e-02 8.000000e-02 + vertex -5.320737e-03 1.927926e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex -5.320737e-03 1.927926e-02 1.000000e-01 + vertex -4.450419e-03 1.949856e-02 1.000000e-01 + vertex -4.450419e-03 1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex 1.981900e-02 -2.684665e-03 1.000000e-01 + vertex 1.967859e-02 -3.571138e-03 1.000000e-01 + vertex 1.967859e-02 -3.571138e-03 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex 1.981900e-02 -2.684665e-03 1.000000e-01 + vertex 1.967859e-02 -3.571138e-03 8.000000e-02 + vertex 1.981900e-02 -2.684665e-03 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex -6.180340e-03 1.902113e-02 1.000000e-01 + vertex -5.320737e-03 1.927926e-02 8.000000e-02 + vertex -6.180340e-03 1.902113e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex -6.180340e-03 1.902113e-02 1.000000e-01 + vertex -5.320737e-03 1.927926e-02 1.000000e-01 + vertex -5.320737e-03 1.927926e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex 1.991949e-02 -1.792786e-03 1.000000e-01 + vertex 1.981900e-02 -2.684665e-03 1.000000e-01 + vertex 1.981900e-02 -2.684665e-03 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex 1.991949e-02 -1.792786e-03 1.000000e-01 + vertex 1.981900e-02 -2.684665e-03 8.000000e-02 + vertex 1.991949e-02 -1.792786e-03 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex -7.027496e-03 1.872470e-02 1.000000e-01 + vertex -6.180340e-03 1.902113e-02 8.000000e-02 + vertex -7.027496e-03 1.872470e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex 1.997986e-02 -8.972966e-04 1.000000e-01 + vertex 1.991949e-02 -1.792786e-03 1.000000e-01 + vertex 1.991949e-02 -1.792786e-03 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex -7.027496e-03 1.872470e-02 1.000000e-01 + vertex -6.180340e-03 1.902113e-02 1.000000e-01 + vertex -6.180340e-03 1.902113e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex 1.997986e-02 -8.972966e-04 1.000000e-01 + vertex 1.991949e-02 -1.792786e-03 8.000000e-02 + vertex 1.997986e-02 -8.972966e-04 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex 2.000000e-02 0.000000e+00 1.000000e-01 + vertex 1.997986e-02 -8.972966e-04 8.000000e-02 + vertex 2.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex 2.000000e-02 0.000000e+00 1.000000e-01 + vertex 1.997986e-02 -8.972966e-04 1.000000e-01 + vertex 1.997986e-02 -8.972966e-04 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex -7.860501e-03 1.839056e-02 1.000000e-01 + vertex -7.027496e-03 1.872470e-02 8.000000e-02 + vertex -7.860501e-03 1.839056e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex -7.860501e-03 1.839056e-02 1.000000e-01 + vertex -7.027496e-03 1.872470e-02 1.000000e-01 + vertex -7.027496e-03 1.872470e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex -8.677675e-03 1.801938e-02 1.000000e-01 + vertex -7.860501e-03 1.839056e-02 8.000000e-02 + vertex -8.677675e-03 1.801938e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex -8.677675e-03 1.801938e-02 1.000000e-01 + vertex -7.860501e-03 1.839056e-02 1.000000e-01 + vertex -7.860501e-03 1.839056e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex -9.477373e-03 1.761191e-02 1.000000e-01 + vertex -8.677675e-03 1.801938e-02 8.000000e-02 + vertex -9.477373e-03 1.761191e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex -9.477373e-03 1.761191e-02 1.000000e-01 + vertex -8.677675e-03 1.801938e-02 1.000000e-01 + vertex -8.677675e-03 1.801938e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex -1.025799e-02 1.716898e-02 1.000000e-01 + vertex -9.477373e-03 1.761191e-02 8.000000e-02 + vertex -1.025799e-02 1.716898e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex -1.025799e-02 1.716898e-02 1.000000e-01 + vertex -9.477373e-03 1.761191e-02 1.000000e-01 + vertex -9.477373e-03 1.761191e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex -1.101794e-02 1.669147e-02 1.000000e-01 + vertex -1.025799e-02 1.716898e-02 8.000000e-02 + vertex -1.101794e-02 1.669147e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex -1.101794e-02 1.669147e-02 1.000000e-01 + vertex -1.025799e-02 1.716898e-02 1.000000e-01 + vertex -1.025799e-02 1.716898e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex -1.175571e-02 1.618034e-02 1.000000e-01 + vertex -1.101794e-02 1.669147e-02 8.000000e-02 + vertex -1.175571e-02 1.618034e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex -1.175571e-02 1.618034e-02 1.000000e-01 + vertex -1.101794e-02 1.669147e-02 1.000000e-01 + vertex -1.101794e-02 1.669147e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex -1.246980e-02 1.563663e-02 1.000000e-01 + vertex -1.175571e-02 1.618034e-02 8.000000e-02 + vertex -1.246980e-02 1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex -1.246980e-02 1.563663e-02 1.000000e-01 + vertex -1.175571e-02 1.618034e-02 1.000000e-01 + vertex -1.175571e-02 1.618034e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex -1.315877e-02 1.506143e-02 1.000000e-01 + vertex -1.246980e-02 1.563663e-02 8.000000e-02 + vertex -1.315877e-02 1.506143e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex -1.315877e-02 1.506143e-02 1.000000e-01 + vertex -1.246980e-02 1.563663e-02 1.000000e-01 + vertex -1.246980e-02 1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 1.000000e-01 + vertex -1.315877e-02 1.506143e-02 8.000000e-02 + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex -1.382125e-02 1.445590e-02 1.000000e-01 + vertex -1.315877e-02 1.506143e-02 1.000000e-01 + vertex -1.315877e-02 1.506143e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex -1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + vertex -1.445590e-02 1.382125e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex -1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.382125e-02 1.445590e-02 1.000000e-01 + vertex -1.382125e-02 1.445590e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex -1.506143e-02 1.315877e-02 1.000000e-01 + vertex -1.445590e-02 1.382125e-02 8.000000e-02 + vertex -1.506143e-02 1.315877e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex -1.506143e-02 1.315877e-02 1.000000e-01 + vertex -1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.445590e-02 1.382125e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex -1.563663e-02 1.246980e-02 1.000000e-01 + vertex -1.506143e-02 1.315877e-02 1.000000e-01 + vertex -1.506143e-02 1.315877e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex -1.563663e-02 1.246980e-02 1.000000e-01 + vertex -1.506143e-02 1.315877e-02 8.000000e-02 + vertex -1.563663e-02 1.246980e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex -1.618034e-02 1.175571e-02 1.000000e-01 + vertex -1.563663e-02 1.246980e-02 1.000000e-01 + vertex -1.563663e-02 1.246980e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex -1.618034e-02 1.175571e-02 1.000000e-01 + vertex -1.563663e-02 1.246980e-02 8.000000e-02 + vertex -1.618034e-02 1.175571e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex -1.669147e-02 1.101794e-02 1.000000e-01 + vertex -1.618034e-02 1.175571e-02 1.000000e-01 + vertex -1.618034e-02 1.175571e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex -1.669147e-02 1.101794e-02 1.000000e-01 + vertex -1.618034e-02 1.175571e-02 8.000000e-02 + vertex -1.669147e-02 1.101794e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex -1.716898e-02 1.025799e-02 1.000000e-01 + vertex -1.669147e-02 1.101794e-02 1.000000e-01 + vertex -1.669147e-02 1.101794e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex -1.716898e-02 1.025799e-02 1.000000e-01 + vertex -1.669147e-02 1.101794e-02 8.000000e-02 + vertex -1.716898e-02 1.025799e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex -1.761191e-02 9.477373e-03 1.000000e-01 + vertex -1.716898e-02 1.025799e-02 1.000000e-01 + vertex -1.716898e-02 1.025799e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex -1.761191e-02 9.477373e-03 1.000000e-01 + vertex -1.716898e-02 1.025799e-02 8.000000e-02 + vertex -1.761191e-02 9.477373e-03 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex -1.801938e-02 8.677675e-03 1.000000e-01 + vertex -1.761191e-02 9.477373e-03 1.000000e-01 + vertex -1.761191e-02 9.477373e-03 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex -1.801938e-02 8.677675e-03 1.000000e-01 + vertex -1.761191e-02 9.477373e-03 8.000000e-02 + vertex -1.801938e-02 8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex -1.839056e-02 7.860501e-03 1.000000e-01 + vertex -1.801938e-02 8.677675e-03 1.000000e-01 + vertex -1.801938e-02 8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex -1.839056e-02 7.860501e-03 1.000000e-01 + vertex -1.801938e-02 8.677675e-03 8.000000e-02 + vertex -1.839056e-02 7.860501e-03 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex -1.872470e-02 7.027496e-03 1.000000e-01 + vertex -1.839056e-02 7.860501e-03 1.000000e-01 + vertex -1.839056e-02 7.860501e-03 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex -1.872470e-02 7.027496e-03 1.000000e-01 + vertex -1.839056e-02 7.860501e-03 8.000000e-02 + vertex -1.872470e-02 7.027496e-03 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex -1.902113e-02 6.180340e-03 1.000000e-01 + vertex -1.872470e-02 7.027496e-03 1.000000e-01 + vertex -1.872470e-02 7.027496e-03 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex -1.902113e-02 6.180340e-03 1.000000e-01 + vertex -1.872470e-02 7.027496e-03 8.000000e-02 + vertex -1.902113e-02 6.180340e-03 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex -1.927926e-02 5.320737e-03 1.000000e-01 + vertex -1.902113e-02 6.180340e-03 1.000000e-01 + vertex -1.902113e-02 6.180340e-03 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex -1.927926e-02 5.320737e-03 1.000000e-01 + vertex -1.902113e-02 6.180340e-03 8.000000e-02 + vertex -1.927926e-02 5.320737e-03 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex -1.949856e-02 4.450419e-03 1.000000e-01 + vertex -1.927926e-02 5.320737e-03 1.000000e-01 + vertex -1.927926e-02 5.320737e-03 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex -1.949856e-02 4.450419e-03 1.000000e-01 + vertex -1.927926e-02 5.320737e-03 8.000000e-02 + vertex -1.949856e-02 4.450419e-03 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex -1.967859e-02 3.571138e-03 1.000000e-01 + vertex -1.949856e-02 4.450419e-03 1.000000e-01 + vertex -1.949856e-02 4.450419e-03 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex -1.967859e-02 3.571138e-03 1.000000e-01 + vertex -1.949856e-02 4.450419e-03 8.000000e-02 + vertex -1.967859e-02 3.571138e-03 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex -1.981900e-02 2.684665e-03 1.000000e-01 + vertex -1.967859e-02 3.571138e-03 1.000000e-01 + vertex -1.967859e-02 3.571138e-03 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex -1.981900e-02 2.684665e-03 1.000000e-01 + vertex -1.967859e-02 3.571138e-03 8.000000e-02 + vertex -1.981900e-02 2.684665e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex -1.991949e-02 1.792786e-03 1.000000e-01 + vertex -1.981900e-02 2.684665e-03 1.000000e-01 + vertex -1.981900e-02 2.684665e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex -1.991949e-02 1.792786e-03 1.000000e-01 + vertex -1.981900e-02 2.684665e-03 8.000000e-02 + vertex -1.991949e-02 1.792786e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex -1.997986e-02 8.972966e-04 1.000000e-01 + vertex -1.991949e-02 1.792786e-03 1.000000e-01 + vertex -1.991949e-02 1.792786e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex -1.997986e-02 8.972966e-04 1.000000e-01 + vertex -1.991949e-02 1.792786e-03 8.000000e-02 + vertex -1.997986e-02 8.972966e-04 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex -2.000000e-02 2.449294e-18 1.000000e-01 + vertex -1.997986e-02 8.972966e-04 1.000000e-01 + vertex -1.997986e-02 8.972966e-04 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex -2.000000e-02 2.449294e-18 1.000000e-01 + vertex -1.997986e-02 8.972966e-04 8.000000e-02 + vertex -2.000000e-02 2.449294e-18 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 -2.243806e-02 -0.000000e+00 + outer loop + vertex -1.997986e-02 -8.972966e-04 1.000000e-01 + vertex -2.000000e-02 2.449294e-18 1.000000e-01 + vertex -2.000000e-02 2.449294e-18 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex -1.997986e-02 -8.972966e-04 1.000000e-01 + vertex -2.000000e-02 2.449294e-18 8.000000e-02 + vertex -1.997986e-02 -8.972966e-04 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex -1.991949e-02 -1.792786e-03 1.000000e-01 + vertex -1.997986e-02 -8.972966e-04 8.000000e-02 + vertex -1.991949e-02 -1.792786e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 -6.726901e-02 -0.000000e+00 + outer loop + vertex -1.991949e-02 -1.792786e-03 1.000000e-01 + vertex -1.997986e-02 -8.972966e-04 1.000000e-01 + vertex -1.997986e-02 -8.972966e-04 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex -1.981900e-02 -2.684665e-03 1.000000e-01 + vertex -1.991949e-02 -1.792786e-03 8.000000e-02 + vertex -1.981900e-02 -2.684665e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 -1.119645e-01 -0.000000e+00 + outer loop + vertex -1.981900e-02 -2.684665e-03 1.000000e-01 + vertex -1.991949e-02 -1.792786e-03 1.000000e-01 + vertex -1.991949e-02 -1.792786e-03 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 -1.564345e-01 -0.000000e+00 + outer loop + vertex -1.967859e-02 -3.571138e-03 1.000000e-01 + vertex -1.981900e-02 -2.684665e-03 1.000000e-01 + vertex -1.981900e-02 -2.684665e-03 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex -1.967859e-02 -3.571138e-03 1.000000e-01 + vertex -1.981900e-02 -2.684665e-03 8.000000e-02 + vertex -1.967859e-02 -3.571138e-03 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex -1.949856e-02 -4.450419e-03 1.000000e-01 + vertex -1.967859e-02 -3.571138e-03 8.000000e-02 + vertex -1.949856e-02 -4.450419e-03 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 -2.005894e-01 -0.000000e+00 + outer loop + vertex -1.949856e-02 -4.450419e-03 1.000000e-01 + vertex -1.967859e-02 -3.571138e-03 1.000000e-01 + vertex -1.967859e-02 -3.571138e-03 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex -1.927926e-02 -5.320737e-03 1.000000e-01 + vertex -1.949856e-02 -4.450419e-03 8.000000e-02 + vertex -1.927926e-02 -5.320737e-03 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 -2.443404e-01 -0.000000e+00 + outer loop + vertex -1.927926e-02 -5.320737e-03 1.000000e-01 + vertex -1.949856e-02 -4.450419e-03 1.000000e-01 + vertex -1.949856e-02 -4.450419e-03 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex -1.902113e-02 -6.180340e-03 1.000000e-01 + vertex -1.927926e-02 -5.320737e-03 8.000000e-02 + vertex -1.902113e-02 -6.180340e-03 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 -2.875993e-01 -0.000000e+00 + outer loop + vertex -1.902113e-02 -6.180340e-03 1.000000e-01 + vertex -1.927926e-02 -5.320737e-03 1.000000e-01 + vertex -1.927926e-02 -5.320737e-03 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex -1.872470e-02 -7.027496e-03 1.000000e-01 + vertex -1.902113e-02 -6.180340e-03 8.000000e-02 + vertex -1.872470e-02 -7.027496e-03 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 -3.302791e-01 -0.000000e+00 + outer loop + vertex -1.872470e-02 -7.027496e-03 1.000000e-01 + vertex -1.902113e-02 -6.180340e-03 1.000000e-01 + vertex -1.902113e-02 -6.180340e-03 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex -1.839056e-02 -7.860501e-03 1.000000e-01 + vertex -1.872470e-02 -7.027496e-03 8.000000e-02 + vertex -1.839056e-02 -7.860501e-03 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 -3.722937e-01 -0.000000e+00 + outer loop + vertex -1.839056e-02 -7.860501e-03 1.000000e-01 + vertex -1.872470e-02 -7.027496e-03 1.000000e-01 + vertex -1.872470e-02 -7.027496e-03 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 -4.135585e-01 -0.000000e+00 + outer loop + vertex -1.801938e-02 -8.677675e-03 1.000000e-01 + vertex -1.839056e-02 -7.860501e-03 1.000000e-01 + vertex -1.839056e-02 -7.860501e-03 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex -1.801938e-02 -8.677675e-03 1.000000e-01 + vertex -1.839056e-02 -7.860501e-03 8.000000e-02 + vertex -1.801938e-02 -8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 -4.539905e-01 -0.000000e+00 + outer loop + vertex -1.761191e-02 -9.477373e-03 1.000000e-01 + vertex -1.801938e-02 -8.677675e-03 1.000000e-01 + vertex -1.801938e-02 -8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex -1.761191e-02 -9.477373e-03 1.000000e-01 + vertex -1.801938e-02 -8.677675e-03 8.000000e-02 + vertex -1.761191e-02 -9.477373e-03 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 -4.935082e-01 -0.000000e+00 + outer loop + vertex -1.716898e-02 -1.025799e-02 1.000000e-01 + vertex -1.761191e-02 -9.477373e-03 1.000000e-01 + vertex -1.761191e-02 -9.477373e-03 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex -1.716898e-02 -1.025799e-02 1.000000e-01 + vertex -1.761191e-02 -9.477373e-03 8.000000e-02 + vertex -1.716898e-02 -1.025799e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 -5.320321e-01 -0.000000e+00 + outer loop + vertex -1.669147e-02 -1.101794e-02 1.000000e-01 + vertex -1.716898e-02 -1.025799e-02 1.000000e-01 + vertex -1.716898e-02 -1.025799e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex -1.669147e-02 -1.101794e-02 1.000000e-01 + vertex -1.716898e-02 -1.025799e-02 8.000000e-02 + vertex -1.669147e-02 -1.101794e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 -5.694845e-01 -0.000000e+00 + outer loop + vertex -1.618034e-02 -1.175571e-02 1.000000e-01 + vertex -1.669147e-02 -1.101794e-02 1.000000e-01 + vertex -1.669147e-02 -1.101794e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex -1.618034e-02 -1.175571e-02 1.000000e-01 + vertex -1.669147e-02 -1.101794e-02 8.000000e-02 + vertex -1.618034e-02 -1.175571e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 -6.057900e-01 -0.000000e+00 + outer loop + vertex -1.563663e-02 -1.246980e-02 1.000000e-01 + vertex -1.618034e-02 -1.175571e-02 1.000000e-01 + vertex -1.618034e-02 -1.175571e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex -1.563663e-02 -1.246980e-02 1.000000e-01 + vertex -1.618034e-02 -1.175571e-02 8.000000e-02 + vertex -1.563663e-02 -1.246980e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 -6.408756e-01 -0.000000e+00 + outer loop + vertex -1.506143e-02 -1.315877e-02 1.000000e-01 + vertex -1.563663e-02 -1.246980e-02 1.000000e-01 + vertex -1.563663e-02 -1.246980e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex -1.506143e-02 -1.315877e-02 1.000000e-01 + vertex -1.563663e-02 -1.246980e-02 8.000000e-02 + vertex -1.506143e-02 -1.315877e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 -6.746705e-01 -0.000000e+00 + outer loop + vertex -1.445590e-02 -1.382125e-02 1.000000e-01 + vertex -1.506143e-02 -1.315877e-02 1.000000e-01 + vertex -1.506143e-02 -1.315877e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex -1.445590e-02 -1.382125e-02 1.000000e-01 + vertex -1.506143e-02 -1.315877e-02 8.000000e-02 + vertex -1.445590e-02 -1.382125e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 -7.071068e-01 -0.000000e+00 + outer loop + vertex -1.382125e-02 -1.445590e-02 1.000000e-01 + vertex -1.445590e-02 -1.382125e-02 1.000000e-01 + vertex -1.445590e-02 -1.382125e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex -1.382125e-02 -1.445590e-02 1.000000e-01 + vertex -1.445590e-02 -1.382125e-02 8.000000e-02 + vertex -1.382125e-02 -1.445590e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 -7.381190e-01 -0.000000e+00 + outer loop + vertex -1.315877e-02 -1.506143e-02 1.000000e-01 + vertex -1.382125e-02 -1.445590e-02 1.000000e-01 + vertex -1.382125e-02 -1.445590e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex -1.315877e-02 -1.506143e-02 1.000000e-01 + vertex -1.382125e-02 -1.445590e-02 8.000000e-02 + vertex -1.315877e-02 -1.506143e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 -7.676447e-01 -0.000000e+00 + outer loop + vertex -1.246980e-02 -1.563663e-02 1.000000e-01 + vertex -1.315877e-02 -1.506143e-02 1.000000e-01 + vertex -1.315877e-02 -1.506143e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex -1.246980e-02 -1.563663e-02 1.000000e-01 + vertex -1.315877e-02 -1.506143e-02 8.000000e-02 + vertex -1.246980e-02 -1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 2.000000e-02 0.000000e+00 1.000000e-01 + vertex 1.997986e-02 8.972966e-04 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.997986e-02 8.972966e-04 1.000000e-01 + vertex 1.991949e-02 1.792786e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.991949e-02 1.792786e-03 1.000000e-01 + vertex 1.981900e-02 2.684665e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.981900e-02 2.684665e-03 1.000000e-01 + vertex 1.967859e-02 3.571138e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.967859e-02 3.571138e-03 1.000000e-01 + vertex 1.949856e-02 4.450419e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.949856e-02 4.450419e-03 1.000000e-01 + vertex 1.927926e-02 5.320737e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.927926e-02 5.320737e-03 1.000000e-01 + vertex 1.902113e-02 6.180340e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.902113e-02 6.180340e-03 1.000000e-01 + vertex 1.872470e-02 7.027496e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.872470e-02 7.027496e-03 1.000000e-01 + vertex 1.839056e-02 7.860501e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.839056e-02 7.860501e-03 1.000000e-01 + vertex 1.801938e-02 8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.801938e-02 8.677675e-03 1.000000e-01 + vertex 1.761191e-02 9.477373e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.761191e-02 9.477373e-03 1.000000e-01 + vertex 1.716898e-02 1.025799e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.716898e-02 1.025799e-02 1.000000e-01 + vertex 1.669147e-02 1.101794e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.669147e-02 1.101794e-02 1.000000e-01 + vertex 1.618034e-02 1.175571e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.618034e-02 1.175571e-02 1.000000e-01 + vertex 1.563663e-02 1.246980e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.563663e-02 1.246980e-02 1.000000e-01 + vertex 1.506143e-02 1.315877e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.382125e-02 1.445590e-02 1.000000e-01 + vertex 1.315877e-02 1.506143e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.315877e-02 1.506143e-02 1.000000e-01 + vertex 1.246980e-02 1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.246980e-02 1.563663e-02 1.000000e-01 + vertex 1.175571e-02 1.618034e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.175571e-02 1.618034e-02 1.000000e-01 + vertex 1.101794e-02 1.669147e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.101794e-02 1.669147e-02 1.000000e-01 + vertex 1.025799e-02 1.716898e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.025799e-02 1.716898e-02 1.000000e-01 + vertex 9.477373e-03 1.761191e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 9.477373e-03 1.761191e-02 1.000000e-01 + vertex 8.677675e-03 1.801938e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 8.677675e-03 1.801938e-02 1.000000e-01 + vertex 7.860501e-03 1.839056e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 7.860501e-03 1.839056e-02 1.000000e-01 + vertex 7.027496e-03 1.872470e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 7.027496e-03 1.872470e-02 1.000000e-01 + vertex 6.180340e-03 1.902113e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 6.180340e-03 1.902113e-02 1.000000e-01 + vertex 5.320737e-03 1.927926e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 5.320737e-03 1.927926e-02 1.000000e-01 + vertex 4.450419e-03 1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 4.450419e-03 1.949856e-02 1.000000e-01 + vertex 3.571138e-03 1.967859e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 3.571138e-03 1.967859e-02 1.000000e-01 + vertex 2.684665e-03 1.981900e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 2.684665e-03 1.981900e-02 1.000000e-01 + vertex 1.792786e-03 1.991949e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.792786e-03 1.991949e-02 1.000000e-01 + vertex 8.972966e-04 1.997986e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 8.972966e-04 1.997986e-02 1.000000e-01 + vertex 1.224647e-18 2.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.224647e-18 2.000000e-02 1.000000e-01 + vertex -8.972966e-04 1.997986e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -8.972966e-04 1.997986e-02 1.000000e-01 + vertex -1.792786e-03 1.991949e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.792786e-03 1.991949e-02 1.000000e-01 + vertex -2.684665e-03 1.981900e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -2.684665e-03 1.981900e-02 1.000000e-01 + vertex -3.571138e-03 1.967859e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -3.571138e-03 1.967859e-02 1.000000e-01 + vertex -4.450419e-03 1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -4.450419e-03 1.949856e-02 1.000000e-01 + vertex -5.320737e-03 1.927926e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -5.320737e-03 1.927926e-02 1.000000e-01 + vertex -6.180340e-03 1.902113e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -6.180340e-03 1.902113e-02 1.000000e-01 + vertex -7.027496e-03 1.872470e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -7.027496e-03 1.872470e-02 1.000000e-01 + vertex -7.860501e-03 1.839056e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -7.860501e-03 1.839056e-02 1.000000e-01 + vertex -8.677675e-03 1.801938e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -8.677675e-03 1.801938e-02 1.000000e-01 + vertex -9.477373e-03 1.761191e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -9.477373e-03 1.761191e-02 1.000000e-01 + vertex -1.025799e-02 1.716898e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.025799e-02 1.716898e-02 1.000000e-01 + vertex -1.101794e-02 1.669147e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.101794e-02 1.669147e-02 1.000000e-01 + vertex -1.175571e-02 1.618034e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.175571e-02 1.618034e-02 1.000000e-01 + vertex -1.246980e-02 1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.246980e-02 1.563663e-02 1.000000e-01 + vertex -1.315877e-02 1.506143e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.315877e-02 1.506143e-02 1.000000e-01 + vertex -1.382125e-02 1.445590e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.382125e-02 1.445590e-02 1.000000e-01 + vertex -1.445590e-02 1.382125e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.506143e-02 1.315877e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.506143e-02 1.315877e-02 1.000000e-01 + vertex -1.563663e-02 1.246980e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.563663e-02 1.246980e-02 1.000000e-01 + vertex -1.618034e-02 1.175571e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.618034e-02 1.175571e-02 1.000000e-01 + vertex -1.669147e-02 1.101794e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.669147e-02 1.101794e-02 1.000000e-01 + vertex -1.716898e-02 1.025799e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.716898e-02 1.025799e-02 1.000000e-01 + vertex -1.761191e-02 9.477373e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.761191e-02 9.477373e-03 1.000000e-01 + vertex -1.801938e-02 8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.801938e-02 8.677675e-03 1.000000e-01 + vertex -1.839056e-02 7.860501e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.839056e-02 7.860501e-03 1.000000e-01 + vertex -1.872470e-02 7.027496e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.872470e-02 7.027496e-03 1.000000e-01 + vertex -1.902113e-02 6.180340e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.902113e-02 6.180340e-03 1.000000e-01 + vertex -1.927926e-02 5.320737e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.927926e-02 5.320737e-03 1.000000e-01 + vertex -1.949856e-02 4.450419e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.949856e-02 4.450419e-03 1.000000e-01 + vertex -1.967859e-02 3.571138e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.967859e-02 3.571138e-03 1.000000e-01 + vertex -1.981900e-02 2.684665e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.981900e-02 2.684665e-03 1.000000e-01 + vertex -1.991949e-02 1.792786e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.991949e-02 1.792786e-03 1.000000e-01 + vertex -1.997986e-02 8.972966e-04 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.997986e-02 8.972966e-04 1.000000e-01 + vertex -2.000000e-02 2.449294e-18 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -2.000000e-02 2.449294e-18 1.000000e-01 + vertex -1.997986e-02 -8.972966e-04 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.997986e-02 -8.972966e-04 1.000000e-01 + vertex -1.991949e-02 -1.792786e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.991949e-02 -1.792786e-03 1.000000e-01 + vertex -1.981900e-02 -2.684665e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.981900e-02 -2.684665e-03 1.000000e-01 + vertex -1.967859e-02 -3.571138e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.967859e-02 -3.571138e-03 1.000000e-01 + vertex -1.949856e-02 -4.450419e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.949856e-02 -4.450419e-03 1.000000e-01 + vertex -1.927926e-02 -5.320737e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.927926e-02 -5.320737e-03 1.000000e-01 + vertex -1.902113e-02 -6.180340e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.902113e-02 -6.180340e-03 1.000000e-01 + vertex -1.872470e-02 -7.027496e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.872470e-02 -7.027496e-03 1.000000e-01 + vertex -1.839056e-02 -7.860501e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.839056e-02 -7.860501e-03 1.000000e-01 + vertex -1.801938e-02 -8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.801938e-02 -8.677675e-03 1.000000e-01 + vertex -1.761191e-02 -9.477373e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.761191e-02 -9.477373e-03 1.000000e-01 + vertex -1.716898e-02 -1.025799e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.716898e-02 -1.025799e-02 1.000000e-01 + vertex -1.669147e-02 -1.101794e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.669147e-02 -1.101794e-02 1.000000e-01 + vertex -1.618034e-02 -1.175571e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.618034e-02 -1.175571e-02 1.000000e-01 + vertex -1.563663e-02 -1.246980e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.563663e-02 -1.246980e-02 1.000000e-01 + vertex -1.506143e-02 -1.315877e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.506143e-02 -1.315877e-02 1.000000e-01 + vertex -1.445590e-02 -1.382125e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.445590e-02 -1.382125e-02 1.000000e-01 + vertex -1.382125e-02 -1.445590e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.382125e-02 -1.445590e-02 1.000000e-01 + vertex -1.315877e-02 -1.506143e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.315877e-02 -1.506143e-02 1.000000e-01 + vertex -1.246980e-02 -1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.246980e-02 -1.563663e-02 1.000000e-01 + vertex -1.175571e-02 -1.618034e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.175571e-02 -1.618034e-02 1.000000e-01 + vertex -1.101794e-02 -1.669147e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.101794e-02 -1.669147e-02 1.000000e-01 + vertex -1.025799e-02 -1.716898e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.025799e-02 -1.716898e-02 1.000000e-01 + vertex -9.477373e-03 -1.761191e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -9.477373e-03 -1.761191e-02 1.000000e-01 + vertex -8.677675e-03 -1.801938e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -8.677675e-03 -1.801938e-02 1.000000e-01 + vertex -7.860501e-03 -1.839056e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -7.860501e-03 -1.839056e-02 1.000000e-01 + vertex -7.027496e-03 -1.872470e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -7.027496e-03 -1.872470e-02 1.000000e-01 + vertex -6.180340e-03 -1.902113e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -6.180340e-03 -1.902113e-02 1.000000e-01 + vertex -5.320737e-03 -1.927926e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -5.320737e-03 -1.927926e-02 1.000000e-01 + vertex -4.450419e-03 -1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -4.450419e-03 -1.949856e-02 1.000000e-01 + vertex -3.571138e-03 -1.967859e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -3.571138e-03 -1.967859e-02 1.000000e-01 + vertex -2.684665e-03 -1.981900e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -2.684665e-03 -1.981900e-02 1.000000e-01 + vertex -1.792786e-03 -1.991949e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -1.792786e-03 -1.991949e-02 1.000000e-01 + vertex -8.972966e-04 -1.997986e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -8.972966e-04 -1.997986e-02 1.000000e-01 + vertex -3.673940e-18 -2.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex -3.673940e-18 -2.000000e-02 1.000000e-01 + vertex 8.972966e-04 -1.997986e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 8.972966e-04 -1.997986e-02 1.000000e-01 + vertex 1.792786e-03 -1.991949e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.792786e-03 -1.991949e-02 1.000000e-01 + vertex 2.684665e-03 -1.981900e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 2.684665e-03 -1.981900e-02 1.000000e-01 + vertex 3.571138e-03 -1.967859e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 3.571138e-03 -1.967859e-02 1.000000e-01 + vertex 4.450419e-03 -1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 4.450419e-03 -1.949856e-02 1.000000e-01 + vertex 5.320737e-03 -1.927926e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 5.320737e-03 -1.927926e-02 1.000000e-01 + vertex 6.180340e-03 -1.902113e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 6.180340e-03 -1.902113e-02 1.000000e-01 + vertex 7.027496e-03 -1.872470e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 7.027496e-03 -1.872470e-02 1.000000e-01 + vertex 7.860501e-03 -1.839056e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 7.860501e-03 -1.839056e-02 1.000000e-01 + vertex 8.677675e-03 -1.801938e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 8.677675e-03 -1.801938e-02 1.000000e-01 + vertex 9.477373e-03 -1.761191e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 9.477373e-03 -1.761191e-02 1.000000e-01 + vertex 1.025799e-02 -1.716898e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.025799e-02 -1.716898e-02 1.000000e-01 + vertex 1.101794e-02 -1.669147e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.101794e-02 -1.669147e-02 1.000000e-01 + vertex 1.175571e-02 -1.618034e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.175571e-02 -1.618034e-02 1.000000e-01 + vertex 1.246980e-02 -1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.246980e-02 -1.563663e-02 1.000000e-01 + vertex 1.315877e-02 -1.506143e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.315877e-02 -1.506143e-02 1.000000e-01 + vertex 1.382125e-02 -1.445590e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.382125e-02 -1.445590e-02 1.000000e-01 + vertex 1.445590e-02 -1.382125e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.445590e-02 -1.382125e-02 1.000000e-01 + vertex 1.506143e-02 -1.315877e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.506143e-02 -1.315877e-02 1.000000e-01 + vertex 1.563663e-02 -1.246980e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.563663e-02 -1.246980e-02 1.000000e-01 + vertex 1.618034e-02 -1.175571e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.618034e-02 -1.175571e-02 1.000000e-01 + vertex 1.669147e-02 -1.101794e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.669147e-02 -1.101794e-02 1.000000e-01 + vertex 1.716898e-02 -1.025799e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.716898e-02 -1.025799e-02 1.000000e-01 + vertex 1.761191e-02 -9.477373e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.761191e-02 -9.477373e-03 1.000000e-01 + vertex 1.801938e-02 -8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.801938e-02 -8.677675e-03 1.000000e-01 + vertex 1.839056e-02 -7.860501e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.839056e-02 -7.860501e-03 1.000000e-01 + vertex 1.872470e-02 -7.027496e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.872470e-02 -7.027496e-03 1.000000e-01 + vertex 1.902113e-02 -6.180340e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.902113e-02 -6.180340e-03 1.000000e-01 + vertex 1.927926e-02 -5.320737e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.927926e-02 -5.320737e-03 1.000000e-01 + vertex 1.949856e-02 -4.450419e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.949856e-02 -4.450419e-03 1.000000e-01 + vertex 1.967859e-02 -3.571138e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.967859e-02 -3.571138e-03 1.000000e-01 + vertex 1.981900e-02 -2.684665e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.981900e-02 -2.684665e-03 1.000000e-01 + vertex 1.991949e-02 -1.792786e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.991949e-02 -1.792786e-03 1.000000e-01 + vertex 1.997986e-02 -8.972966e-04 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.445590e-02 1.382125e-02 1.000000e-01 + vertex 1.997986e-02 -8.972966e-04 1.000000e-01 + vertex 2.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet +endsolid diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r2.stl b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r2.stl new file mode 100644 index 00000000..896ac83a --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r2.stl @@ -0,0 +1,6666 @@ +solid + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.436699e-02 1.391365e-02 8.000000e-02 + vertex 2.891179e-02 2.764251e-02 8.000000e-02 + vertex 3.012286e-02 2.631755e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.436699e-02 1.391365e-02 8.000000e-02 + vertex 3.012286e-02 2.631755e-02 8.000000e-02 + vertex 1.522892e-02 1.296457e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.572100e-02 3.678111e-02 8.000000e-02 + vertex 8.095667e-03 1.828825e-02 8.000000e-02 + vertex 6.907301e-03 1.876937e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.572100e-02 3.678111e-02 8.000000e-02 + vertex 1.735535e-02 3.603875e-02 8.000000e-02 + vertex 8.095667e-03 1.828825e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.907301e-03 -1.876937e-02 8.000000e-02 + vertex 1.405499e-02 -3.744939e-02 8.000000e-02 + vertex 1.236068e-02 -3.804226e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.907301e-03 -1.876937e-02 8.000000e-02 + vertex 1.572100e-02 -3.678111e-02 8.000000e-02 + vertex 1.405499e-02 -3.744939e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.678111e-02 -1.572100e-02 8.000000e-02 + vertex -1.853834e-02 -7.505340e-03 8.000000e-02 + vertex -1.801938e-02 -8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.678111e-02 -1.572100e-02 8.000000e-02 + vertex -1.801938e-02 -8.677675e-03 8.000000e-02 + vertex -3.603875e-02 -1.735535e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 6.907301e-03 -1.876937e-02 8.000000e-02 + vertex 8.095667e-03 -1.828825e-02 8.000000e-02 + vertex 1.572100e-02 -3.678111e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.436699e-02 -1.391365e-02 8.000000e-02 + vertex -1.344602e-02 -1.480556e-02 8.000000e-02 + vertex -2.764251e-02 -2.891179e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.898111e-02 -6.302164e-03 8.000000e-02 + vertex 3.804226e-02 -1.236068e-02 8.000000e-02 + vertex 3.744939e-02 -1.405499e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.898111e-02 -6.302164e-03 8.000000e-02 + vertex 3.855851e-02 -1.064147e-02 8.000000e-02 + vertex 3.804226e-02 -1.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.764251e-02 2.891179e-02 8.000000e-02 + vertex 2.891179e-02 2.764251e-02 8.000000e-02 + vertex 1.436699e-02 1.391365e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.898111e-02 -6.302164e-03 8.000000e-02 + vertex 3.744939e-02 -1.405499e-02 8.000000e-02 + vertex 1.853834e-02 -7.505340e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.891179e-02 -2.764251e-02 8.000000e-02 + vertex -1.436699e-02 -1.391365e-02 8.000000e-02 + vertex -2.764251e-02 -2.891179e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.344602e-02 1.480556e-02 8.000000e-02 + vertex 2.764251e-02 2.891179e-02 8.000000e-02 + vertex 1.436699e-02 1.391365e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.690552e-03 -1.917336e-02 8.000000e-02 + vertex 1.236068e-02 -3.804226e-02 8.000000e-02 + vertex 1.064147e-02 -3.855851e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.690552e-03 -1.917336e-02 8.000000e-02 + vertex 6.907301e-03 -1.876937e-02 8.000000e-02 + vertex 1.236068e-02 -3.804226e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.934590e-02 -5.073092e-03 8.000000e-02 + vertex 3.899712e-02 -8.900837e-03 8.000000e-02 + vertex 3.855851e-02 -1.064147e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.934590e-02 -5.073092e-03 8.000000e-02 + vertex 3.855851e-02 -1.064147e-02 8.000000e-02 + vertex 1.898111e-02 -6.302164e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.450419e-03 -1.949856e-02 8.000000e-02 + vertex 8.900837e-03 -3.899712e-02 8.000000e-02 + vertex 7.142276e-03 -3.935718e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.450419e-03 -1.949856e-02 8.000000e-02 + vertex 1.064147e-02 -3.855851e-02 8.000000e-02 + vertex 8.900837e-03 -3.899712e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.450419e-03 -1.949856e-02 8.000000e-02 + vertex 5.690552e-03 -1.917336e-02 8.000000e-02 + vertex 1.064147e-02 -3.855851e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.963118e-02 -3.823173e-03 8.000000e-02 + vertex 3.899712e-02 -8.900837e-03 8.000000e-02 + vertex 1.934590e-02 -5.073092e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.963118e-02 -3.823173e-03 8.000000e-02 + vertex 3.935718e-02 -7.142276e-03 8.000000e-02 + vertex 3.899712e-02 -8.900837e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.631755e-02 3.012286e-02 8.000000e-02 + vertex 1.344602e-02 1.480556e-02 8.000000e-02 + vertex 1.246980e-02 1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.631755e-02 3.012286e-02 8.000000e-02 + vertex 2.764251e-02 2.891179e-02 8.000000e-02 + vertex 1.344602e-02 1.480556e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.012286e-02 -2.631755e-02 8.000000e-02 + vertex -1.522892e-02 -1.296457e-02 8.000000e-02 + vertex -1.436699e-02 -1.391365e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.012286e-02 -2.631755e-02 8.000000e-02 + vertex -1.436699e-02 -1.391365e-02 8.000000e-02 + vertex -2.891179e-02 -2.764251e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.191998e-03 -1.974364e-02 8.000000e-02 + vertex 7.142276e-03 -3.935718e-02 8.000000e-02 + vertex 5.369331e-03 -3.963799e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.191998e-03 -1.974364e-02 8.000000e-02 + vertex 4.450419e-03 -1.949856e-02 8.000000e-02 + vertex 7.142276e-03 -3.935718e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.405499e-02 3.744939e-02 8.000000e-02 + vertex 1.572100e-02 3.678111e-02 8.000000e-02 + vertex 6.907301e-03 1.876937e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.983580e-02 -2.557543e-03 8.000000e-02 + vertex 3.963799e-02 -5.369331e-03 8.000000e-02 + vertex 3.935718e-02 -7.142276e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.983580e-02 -2.557543e-03 8.000000e-02 + vertex 3.983897e-02 -3.585572e-03 8.000000e-02 + vertex 3.963799e-02 -5.369331e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.983580e-02 -2.557543e-03 8.000000e-02 + vertex 3.935718e-02 -7.142276e-03 8.000000e-02 + vertex 1.963118e-02 -3.823173e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.744939e-02 -1.405499e-02 8.000000e-02 + vertex -1.898111e-02 -6.302164e-03 8.000000e-02 + vertex -1.853834e-02 -7.505340e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.744939e-02 -1.405499e-02 8.000000e-02 + vertex -1.853834e-02 -7.505340e-03 8.000000e-02 + vertex -3.678111e-02 -1.572100e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.920461e-03 -1.990758e-02 8.000000e-02 + vertex 3.585572e-03 -3.983897e-02 8.000000e-02 + vertex 1.794593e-03 -3.995972e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.920461e-03 -1.990758e-02 8.000000e-02 + vertex 5.369331e-03 -3.963799e-02 8.000000e-02 + vertex 3.585572e-03 -3.983897e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.920461e-03 -1.990758e-02 8.000000e-02 + vertex 3.191998e-03 -1.974364e-02 8.000000e-02 + vertex 5.369331e-03 -3.963799e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.493959e-02 3.127326e-02 8.000000e-02 + vertex 2.631755e-02 3.012286e-02 8.000000e-02 + vertex 1.246980e-02 1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.127326e-02 -2.493959e-02 8.000000e-02 + vertex -1.602827e-02 -1.196221e-02 8.000000e-02 + vertex -1.522892e-02 -1.296457e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.127326e-02 -2.493959e-02 8.000000e-02 + vertex -1.522892e-02 -1.296457e-02 8.000000e-02 + vertex -3.012286e-02 -2.631755e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.995891e-02 -1.281404e-03 8.000000e-02 + vertex 3.995972e-02 -1.794593e-03 8.000000e-02 + vertex 3.983897e-02 -3.585572e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.995891e-02 -1.281404e-03 8.000000e-02 + vertex 3.983897e-02 -3.585572e-03 8.000000e-02 + vertex 1.983580e-02 -2.557543e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.410316e-04 -1.998972e-02 8.000000e-02 + vertex 1.794593e-03 -3.995972e-02 8.000000e-02 + vertex -7.347881e-18 -4.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.410316e-04 -1.998972e-02 8.000000e-02 + vertex 1.920461e-03 -1.990758e-02 8.000000e-02 + vertex 1.794593e-03 -3.995972e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.000000e-02 0.000000e+00 8.000000e-02 + vertex 4.000000e-02 0.000000e+00 8.000000e-02 + vertex 3.995972e-02 -1.794593e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.000000e-02 0.000000e+00 8.000000e-02 + vertex 3.995972e-02 -1.794593e-03 8.000000e-02 + vertex 1.995891e-02 -1.281404e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.000000e-02 0.000000e+00 8.000000e-02 + vertex 3.995972e-02 1.794593e-03 8.000000e-02 + vertex 4.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.410316e-04 -1.998972e-02 8.000000e-02 + vertex -7.347881e-18 -4.000000e-02 8.000000e-02 + vertex -1.794593e-03 -3.995972e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.410316e-04 -1.998972e-02 8.000000e-02 + vertex 6.410316e-04 -1.998972e-02 8.000000e-02 + vertex -7.347881e-18 -4.000000e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.351141e-02 3.236068e-02 8.000000e-02 + vertex 1.246980e-02 1.563663e-02 8.000000e-02 + vertex 1.144233e-02 1.640345e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.351141e-02 3.236068e-02 8.000000e-02 + vertex 2.493959e-02 3.127326e-02 8.000000e-02 + vertex 1.246980e-02 1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.236068e-02 -2.351141e-02 8.000000e-02 + vertex -1.602827e-02 -1.196221e-02 8.000000e-02 + vertex -3.127326e-02 -2.493959e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.236068e-02 -2.351141e-02 8.000000e-02 + vertex -1.676176e-02 -1.091070e-02 8.000000e-02 + vertex -1.602827e-02 -1.196221e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.995891e-02 1.281404e-03 8.000000e-02 + vertex 3.995972e-02 1.794593e-03 8.000000e-02 + vertex 2.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.995891e-02 1.281404e-03 8.000000e-02 + vertex 3.983897e-02 3.585572e-03 8.000000e-02 + vertex 3.995972e-02 1.794593e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.920461e-03 -1.990758e-02 8.000000e-02 + vertex -1.794593e-03 -3.995972e-02 8.000000e-02 + vertex -3.585572e-03 -3.983897e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 8.900837e-03 3.899712e-02 8.000000e-02 + vertex 1.064147e-02 3.855851e-02 8.000000e-02 + vertex 4.450419e-03 1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.920461e-03 -1.990758e-02 8.000000e-02 + vertex -6.410316e-04 -1.998972e-02 8.000000e-02 + vertex -1.794593e-03 -3.995972e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.899712e-02 -8.900837e-03 8.000000e-02 + vertex -1.934590e-02 -5.073092e-03 8.000000e-02 + vertex -3.855851e-02 -1.064147e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.899712e-02 -8.900837e-03 8.000000e-02 + vertex -1.963118e-02 -3.823173e-03 8.000000e-02 + vertex -1.934590e-02 -5.073092e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.935718e-02 -7.142276e-03 8.000000e-02 + vertex -1.963118e-02 -3.823173e-03 8.000000e-02 + vertex -3.899712e-02 -8.900837e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.920461e-03 -1.990758e-02 8.000000e-02 + vertex -3.585572e-03 -3.983897e-02 8.000000e-02 + vertex -5.369331e-03 -3.963799e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.983580e-02 2.557543e-03 8.000000e-02 + vertex 3.963799e-02 5.369331e-03 8.000000e-02 + vertex 3.983897e-02 3.585572e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.983580e-02 2.557543e-03 8.000000e-02 + vertex 3.935718e-02 7.142276e-03 8.000000e-02 + vertex 3.963799e-02 5.369331e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.983580e-02 2.557543e-03 8.000000e-02 + vertex 3.983897e-02 3.585572e-03 8.000000e-02 + vertex 1.995891e-02 1.281404e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.935718e-02 -7.142276e-03 8.000000e-02 + vertex -1.983580e-02 -2.557543e-03 8.000000e-02 + vertex -1.963118e-02 -3.823173e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.142276e-03 3.935718e-02 8.000000e-02 + vertex 4.450419e-03 1.949856e-02 8.000000e-02 + vertex 3.191998e-03 1.974364e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.191998e-03 -1.974364e-02 8.000000e-02 + vertex -1.920461e-03 -1.990758e-02 8.000000e-02 + vertex -5.369331e-03 -3.963799e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.142276e-03 3.935718e-02 8.000000e-02 + vertex 8.900837e-03 3.899712e-02 8.000000e-02 + vertex 4.450419e-03 1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.369331e-03 3.963799e-02 8.000000e-02 + vertex 3.191998e-03 1.974364e-02 8.000000e-02 + vertex 1.920461e-03 1.990758e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.203588e-02 3.338293e-02 8.000000e-02 + vertex 1.144233e-02 1.640345e-02 8.000000e-02 + vertex 1.036785e-02 1.710286e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.369331e-03 3.963799e-02 8.000000e-02 + vertex 7.142276e-03 3.935718e-02 8.000000e-02 + vertex 3.191998e-03 1.974364e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.203588e-02 3.338293e-02 8.000000e-02 + vertex 2.351141e-02 3.236068e-02 8.000000e-02 + vertex 1.144233e-02 1.640345e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.191998e-03 -1.974364e-02 8.000000e-02 + vertex -5.369331e-03 -3.963799e-02 8.000000e-02 + vertex -7.142276e-03 -3.935718e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.963799e-02 -5.369331e-03 8.000000e-02 + vertex -1.983580e-02 -2.557543e-03 8.000000e-02 + vertex -3.935718e-02 -7.142276e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.338293e-02 -2.203588e-02 8.000000e-02 + vertex -1.676176e-02 -1.091070e-02 8.000000e-02 + vertex -3.236068e-02 -2.351141e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.236068e-02 3.804226e-02 8.000000e-02 + vertex 6.907301e-03 1.876937e-02 8.000000e-02 + vertex 5.690552e-03 1.917336e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.963118e-02 3.823173e-03 8.000000e-02 + vertex 3.899712e-02 8.900837e-03 8.000000e-02 + vertex 3.935718e-02 7.142276e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.963118e-02 3.823173e-03 8.000000e-02 + vertex 3.935718e-02 7.142276e-03 8.000000e-02 + vertex 1.983580e-02 2.557543e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.983897e-02 -3.585572e-03 8.000000e-02 + vertex -1.983580e-02 -2.557543e-03 8.000000e-02 + vertex -3.963799e-02 -5.369331e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.236068e-02 3.804226e-02 8.000000e-02 + vertex 1.405499e-02 3.744939e-02 8.000000e-02 + vertex 6.907301e-03 1.876937e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.983897e-02 -3.585572e-03 8.000000e-02 + vertex -1.995891e-02 -1.281404e-03 8.000000e-02 + vertex -1.983580e-02 -2.557543e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.450419e-03 -1.949856e-02 8.000000e-02 + vertex -3.191998e-03 -1.974364e-02 8.000000e-02 + vertex -7.142276e-03 -3.935718e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.804226e-02 -1.236068e-02 8.000000e-02 + vertex -1.898111e-02 -6.302164e-03 8.000000e-02 + vertex -3.744939e-02 -1.405499e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.585572e-03 3.983897e-02 8.000000e-02 + vertex 5.369331e-03 3.963799e-02 8.000000e-02 + vertex 1.920461e-03 1.990758e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.794593e-03 3.995972e-02 8.000000e-02 + vertex 1.920461e-03 1.990758e-02 8.000000e-02 + vertex 6.410316e-04 1.998972e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.450419e-03 -1.949856e-02 8.000000e-02 + vertex -8.900837e-03 -3.899712e-02 8.000000e-02 + vertex -1.064147e-02 -3.855851e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.450419e-03 -1.949856e-02 8.000000e-02 + vertex -7.142276e-03 -3.935718e-02 8.000000e-02 + vertex -8.900837e-03 -3.899712e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.794593e-03 3.995972e-02 8.000000e-02 + vertex 3.585572e-03 3.983897e-02 8.000000e-02 + vertex 1.920461e-03 1.990758e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.934590e-02 5.073092e-03 8.000000e-02 + vertex 3.855851e-02 1.064147e-02 8.000000e-02 + vertex 3.899712e-02 8.900837e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.995972e-02 -1.794593e-03 8.000000e-02 + vertex -1.995891e-02 -1.281404e-03 8.000000e-02 + vertex -3.983897e-02 -3.585572e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.934590e-02 5.073092e-03 8.000000e-02 + vertex 3.899712e-02 8.900837e-03 8.000000e-02 + vertex 1.963118e-02 3.823173e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.995972e-02 -1.794593e-03 8.000000e-02 + vertex -2.000000e-02 2.021286e-17 8.000000e-02 + vertex -1.995891e-02 -1.281404e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.449294e-18 4.000000e-02 8.000000e-02 + vertex 1.794593e-03 3.995972e-02 8.000000e-02 + vertex 6.410316e-04 1.998972e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.449294e-18 4.000000e-02 8.000000e-02 + vertex 6.410316e-04 1.998972e-02 8.000000e-02 + vertex -6.410316e-04 1.998972e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.690552e-03 -1.917336e-02 8.000000e-02 + vertex -4.450419e-03 -1.949856e-02 8.000000e-02 + vertex -1.064147e-02 -3.855851e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.000000e-02 4.898587e-18 8.000000e-02 + vertex -2.000000e-02 2.021286e-17 8.000000e-02 + vertex -3.995972e-02 -1.794593e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.051597e-02 3.433795e-02 8.000000e-02 + vertex 2.203588e-02 3.338293e-02 8.000000e-02 + vertex 1.036785e-02 1.710286e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.690552e-03 -1.917336e-02 8.000000e-02 + vertex -1.064147e-02 -3.855851e-02 8.000000e-02 + vertex -1.236068e-02 -3.804226e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.433795e-02 -2.051597e-02 8.000000e-02 + vertex -1.676176e-02 -1.091070e-02 8.000000e-02 + vertex -3.338293e-02 -2.203588e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.898111e-02 6.302164e-03 8.000000e-02 + vertex 3.804226e-02 1.236068e-02 8.000000e-02 + vertex 3.855851e-02 1.064147e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.898111e-02 6.302164e-03 8.000000e-02 + vertex 3.744939e-02 1.405499e-02 8.000000e-02 + vertex 3.804226e-02 1.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.433795e-02 -2.051597e-02 8.000000e-02 + vertex -1.742637e-02 -9.814351e-03 8.000000e-02 + vertex -1.676176e-02 -1.091070e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.898111e-02 6.302164e-03 8.000000e-02 + vertex 3.855851e-02 1.064147e-02 8.000000e-02 + vertex 1.934590e-02 5.073092e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.995972e-02 1.794593e-03 8.000000e-02 + vertex -1.995891e-02 1.281404e-03 8.000000e-02 + vertex -2.000000e-02 2.021286e-17 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.995972e-02 1.794593e-03 8.000000e-02 + vertex -2.000000e-02 2.021286e-17 8.000000e-02 + vertex -4.000000e-02 4.898587e-18 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.794593e-03 3.995972e-02 8.000000e-02 + vertex -6.410316e-04 1.998972e-02 8.000000e-02 + vertex -1.920461e-03 1.990758e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.907301e-03 -1.876937e-02 8.000000e-02 + vertex -5.690552e-03 -1.917336e-02 8.000000e-02 + vertex -1.236068e-02 -3.804226e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.794593e-03 3.995972e-02 8.000000e-02 + vertex 2.449294e-18 4.000000e-02 8.000000e-02 + vertex -6.410316e-04 1.998972e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.983897e-02 3.585572e-03 8.000000e-02 + vertex -1.995891e-02 1.281404e-03 8.000000e-02 + vertex -3.995972e-02 1.794593e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -6.907301e-03 -1.876937e-02 8.000000e-02 + vertex -1.405499e-02 -3.744939e-02 8.000000e-02 + vertex -1.572100e-02 -3.678111e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -6.907301e-03 -1.876937e-02 8.000000e-02 + vertex -1.236068e-02 -3.804226e-02 8.000000e-02 + vertex -1.405499e-02 -3.744939e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.983897e-02 3.585572e-03 8.000000e-02 + vertex -1.983580e-02 2.557543e-03 8.000000e-02 + vertex -1.995891e-02 1.281404e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.585572e-03 3.983897e-02 8.000000e-02 + vertex -1.794593e-03 3.995972e-02 8.000000e-02 + vertex -1.920461e-03 1.990758e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.853834e-02 7.505340e-03 8.000000e-02 + vertex 3.678111e-02 1.572100e-02 8.000000e-02 + vertex 3.744939e-02 1.405499e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.853834e-02 7.505340e-03 8.000000e-02 + vertex 3.744939e-02 1.405499e-02 8.000000e-02 + vertex 1.898111e-02 6.302164e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.436699e-02 -1.391365e-02 8.000000e-02 + vertex 2.891179e-02 -2.764251e-02 8.000000e-02 + vertex 2.764251e-02 -2.891179e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.436699e-02 -1.391365e-02 8.000000e-02 + vertex 3.012286e-02 -2.631755e-02 8.000000e-02 + vertex 2.891179e-02 -2.764251e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.963799e-02 5.369331e-03 8.000000e-02 + vertex -1.983580e-02 2.557543e-03 8.000000e-02 + vertex -3.983897e-02 3.585572e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.369331e-03 3.963799e-02 8.000000e-02 + vertex -1.920461e-03 1.990758e-02 8.000000e-02 + vertex -3.191998e-03 1.974364e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.095667e-03 -1.828825e-02 8.000000e-02 + vertex -6.907301e-03 -1.876937e-02 8.000000e-02 + vertex -1.572100e-02 -3.678111e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.369331e-03 3.963799e-02 8.000000e-02 + vertex -3.585572e-03 3.983897e-02 8.000000e-02 + vertex -1.920461e-03 1.990758e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -8.095667e-03 -1.828825e-02 8.000000e-02 + vertex -1.572100e-02 -3.678111e-02 8.000000e-02 + vertex -1.735535e-02 -3.603875e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.935718e-02 7.142276e-03 8.000000e-02 + vertex -1.963118e-02 3.823173e-03 8.000000e-02 + vertex -1.983580e-02 2.557543e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.935718e-02 7.142276e-03 8.000000e-02 + vertex -1.983580e-02 2.557543e-03 8.000000e-02 + vertex -3.963799e-02 5.369331e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.895475e-02 3.522382e-02 8.000000e-02 + vertex 1.036785e-02 1.710286e-02 8.000000e-02 + vertex 9.250766e-03 1.773199e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.344602e-02 -1.480556e-02 8.000000e-02 + vertex 2.764251e-02 -2.891179e-02 8.000000e-02 + vertex 2.631755e-02 -3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.142276e-03 3.935718e-02 8.000000e-02 + vertex -3.191998e-03 1.974364e-02 8.000000e-02 + vertex -4.450419e-03 1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.344602e-02 -1.480556e-02 8.000000e-02 + vertex 1.436699e-02 -1.391365e-02 8.000000e-02 + vertex 2.764251e-02 -2.891179e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.801938e-02 8.677675e-03 8.000000e-02 + vertex 3.603875e-02 1.735535e-02 8.000000e-02 + vertex 3.678111e-02 1.572100e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.142276e-03 3.935718e-02 8.000000e-02 + vertex -5.369331e-03 3.963799e-02 8.000000e-02 + vertex -3.191998e-03 1.974364e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.801938e-02 8.677675e-03 8.000000e-02 + vertex 3.522382e-02 1.895475e-02 8.000000e-02 + vertex 3.603875e-02 1.735535e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.895475e-02 3.522382e-02 8.000000e-02 + vertex 2.051597e-02 3.433795e-02 8.000000e-02 + vertex 1.036785e-02 1.710286e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.522382e-02 -1.895475e-02 8.000000e-02 + vertex -1.742637e-02 -9.814351e-03 8.000000e-02 + vertex -3.433795e-02 -2.051597e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.801938e-02 8.677675e-03 8.000000e-02 + vertex 3.678111e-02 1.572100e-02 8.000000e-02 + vertex 1.853834e-02 7.505340e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.522892e-02 -1.296457e-02 8.000000e-02 + vertex 3.127326e-02 -2.493959e-02 8.000000e-02 + vertex 3.012286e-02 -2.631755e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.522382e-02 -1.895475e-02 8.000000e-02 + vertex -1.801938e-02 -8.677675e-03 8.000000e-02 + vertex -1.742637e-02 -9.814351e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.522892e-02 -1.296457e-02 8.000000e-02 + vertex 3.012286e-02 -2.631755e-02 8.000000e-02 + vertex 1.436699e-02 -1.391365e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -8.900837e-03 3.899712e-02 8.000000e-02 + vertex -7.142276e-03 3.935718e-02 8.000000e-02 + vertex -4.450419e-03 1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.899712e-02 8.900837e-03 8.000000e-02 + vertex -1.963118e-02 3.823173e-03 8.000000e-02 + vertex -3.935718e-02 7.142276e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.250766e-03 -1.773199e-02 8.000000e-02 + vertex -8.095667e-03 -1.828825e-02 8.000000e-02 + vertex -1.735535e-02 -3.603875e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.899712e-02 8.900837e-03 8.000000e-02 + vertex -1.934590e-02 5.073092e-03 8.000000e-02 + vertex -1.963118e-02 3.823173e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.246980e-02 -1.563663e-02 8.000000e-02 + vertex 2.493959e-02 -3.127326e-02 8.000000e-02 + vertex 2.351141e-02 -3.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.246980e-02 -1.563663e-02 8.000000e-02 + vertex 2.631755e-02 -3.012286e-02 8.000000e-02 + vertex 2.493959e-02 -3.127326e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.855851e-02 1.064147e-02 8.000000e-02 + vertex -1.898111e-02 6.302164e-03 8.000000e-02 + vertex -1.934590e-02 5.073092e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.855851e-02 1.064147e-02 8.000000e-02 + vertex -1.934590e-02 5.073092e-03 8.000000e-02 + vertex -3.899712e-02 8.900837e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.246980e-02 -1.563663e-02 8.000000e-02 + vertex 1.344602e-02 -1.480556e-02 8.000000e-02 + vertex 2.631755e-02 -3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.064147e-02 3.855851e-02 8.000000e-02 + vertex -4.450419e-03 1.949856e-02 8.000000e-02 + vertex -5.690552e-03 1.917336e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -9.250766e-03 -1.773199e-02 8.000000e-02 + vertex -1.735535e-02 -3.603875e-02 8.000000e-02 + vertex -1.895475e-02 -3.522382e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.602827e-02 -1.196221e-02 8.000000e-02 + vertex 3.236068e-02 -2.351141e-02 8.000000e-02 + vertex 3.127326e-02 -2.493959e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.742637e-02 9.814351e-03 8.000000e-02 + vertex 3.433795e-02 2.051597e-02 8.000000e-02 + vertex 3.522382e-02 1.895475e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.064147e-02 3.855851e-02 8.000000e-02 + vertex -8.900837e-03 3.899712e-02 8.000000e-02 + vertex -4.450419e-03 1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.742637e-02 9.814351e-03 8.000000e-02 + vertex 3.522382e-02 1.895475e-02 8.000000e-02 + vertex 1.801938e-02 8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.602827e-02 -1.196221e-02 8.000000e-02 + vertex 3.127326e-02 -2.493959e-02 8.000000e-02 + vertex 1.522892e-02 -1.296457e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.804226e-02 1.236068e-02 8.000000e-02 + vertex -1.898111e-02 6.302164e-03 8.000000e-02 + vertex -3.855851e-02 1.064147e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.236068e-02 3.804226e-02 8.000000e-02 + vertex -1.064147e-02 3.855851e-02 8.000000e-02 + vertex -5.690552e-03 1.917336e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.236068e-02 3.804226e-02 8.000000e-02 + vertex -5.690552e-03 1.917336e-02 8.000000e-02 + vertex -6.907301e-03 1.876937e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.036785e-02 -1.710286e-02 8.000000e-02 + vertex -9.250766e-03 -1.773199e-02 8.000000e-02 + vertex -1.895475e-02 -3.522382e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.744939e-02 1.405499e-02 8.000000e-02 + vertex -1.853834e-02 7.505340e-03 8.000000e-02 + vertex -1.898111e-02 6.302164e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.744939e-02 1.405499e-02 8.000000e-02 + vertex -1.898111e-02 6.302164e-03 8.000000e-02 + vertex -3.804226e-02 1.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.144233e-02 -1.640345e-02 8.000000e-02 + vertex 2.351141e-02 -3.236068e-02 8.000000e-02 + vertex 2.203588e-02 -3.338293e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.036785e-02 -1.710286e-02 8.000000e-02 + vertex -2.051597e-02 -3.433795e-02 8.000000e-02 + vertex -2.203588e-02 -3.338293e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.036785e-02 -1.710286e-02 8.000000e-02 + vertex -1.895475e-02 -3.522382e-02 8.000000e-02 + vertex -2.051597e-02 -3.433795e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.144233e-02 -1.640345e-02 8.000000e-02 + vertex 1.246980e-02 -1.563663e-02 8.000000e-02 + vertex 2.351141e-02 -3.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.405499e-02 3.744939e-02 8.000000e-02 + vertex -1.236068e-02 3.804226e-02 8.000000e-02 + vertex -6.907301e-03 1.876937e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.676176e-02 -1.091070e-02 8.000000e-02 + vertex 3.338293e-02 -2.203588e-02 8.000000e-02 + vertex 3.236068e-02 -2.351141e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.676176e-02 -1.091070e-02 8.000000e-02 + vertex 3.433795e-02 -2.051597e-02 8.000000e-02 + vertex 3.338293e-02 -2.203588e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.678111e-02 1.572100e-02 8.000000e-02 + vertex -1.801938e-02 8.677675e-03 8.000000e-02 + vertex -1.853834e-02 7.505340e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.676176e-02 1.091070e-02 8.000000e-02 + vertex 3.338293e-02 2.203588e-02 8.000000e-02 + vertex 3.433795e-02 2.051597e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.678111e-02 1.572100e-02 8.000000e-02 + vertex -1.853834e-02 7.505340e-03 8.000000e-02 + vertex -3.744939e-02 1.405499e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.676176e-02 1.091070e-02 8.000000e-02 + vertex 3.236068e-02 2.351141e-02 8.000000e-02 + vertex 3.338293e-02 2.203588e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.572100e-02 3.678111e-02 8.000000e-02 + vertex -6.907301e-03 1.876937e-02 8.000000e-02 + vertex -8.095667e-03 1.828825e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.676176e-02 1.091070e-02 8.000000e-02 + vertex 3.433795e-02 2.051597e-02 8.000000e-02 + vertex 1.742637e-02 9.814351e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.676176e-02 -1.091070e-02 8.000000e-02 + vertex 3.236068e-02 -2.351141e-02 8.000000e-02 + vertex 1.602827e-02 -1.196221e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.572100e-02 3.678111e-02 8.000000e-02 + vertex -1.405499e-02 3.744939e-02 8.000000e-02 + vertex -6.907301e-03 1.876937e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.144233e-02 -1.640345e-02 8.000000e-02 + vertex -1.036785e-02 -1.710286e-02 8.000000e-02 + vertex -2.203588e-02 -3.338293e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.603875e-02 1.735535e-02 8.000000e-02 + vertex -1.801938e-02 8.677675e-03 8.000000e-02 + vertex -3.678111e-02 1.572100e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.735535e-02 3.603875e-02 8.000000e-02 + vertex -8.095667e-03 1.828825e-02 8.000000e-02 + vertex -9.250766e-03 1.773199e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.036785e-02 -1.710286e-02 8.000000e-02 + vertex 2.051597e-02 -3.433795e-02 8.000000e-02 + vertex 1.895475e-02 -3.522382e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.036785e-02 -1.710286e-02 8.000000e-02 + vertex 2.203588e-02 -3.338293e-02 8.000000e-02 + vertex 2.051597e-02 -3.433795e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.735535e-02 3.603875e-02 8.000000e-02 + vertex -1.572100e-02 3.678111e-02 8.000000e-02 + vertex -8.095667e-03 1.828825e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.036785e-02 -1.710286e-02 8.000000e-02 + vertex 1.144233e-02 -1.640345e-02 8.000000e-02 + vertex 2.203588e-02 -3.338293e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.522382e-02 1.895475e-02 8.000000e-02 + vertex -1.742637e-02 9.814351e-03 8.000000e-02 + vertex -1.801938e-02 8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.735535e-02 3.603875e-02 8.000000e-02 + vertex 9.250766e-03 1.773199e-02 8.000000e-02 + vertex 8.095667e-03 1.828825e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.522382e-02 1.895475e-02 8.000000e-02 + vertex -1.801938e-02 8.677675e-03 8.000000e-02 + vertex -3.603875e-02 1.735535e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.144233e-02 -1.640345e-02 8.000000e-02 + vertex -2.203588e-02 -3.338293e-02 8.000000e-02 + vertex -2.351141e-02 -3.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.895475e-02 3.522382e-02 8.000000e-02 + vertex -9.250766e-03 1.773199e-02 8.000000e-02 + vertex -1.036785e-02 1.710286e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.735535e-02 3.603875e-02 8.000000e-02 + vertex 1.895475e-02 3.522382e-02 8.000000e-02 + vertex 9.250766e-03 1.773199e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.742637e-02 -9.814351e-03 8.000000e-02 + vertex 3.522382e-02 -1.895475e-02 8.000000e-02 + vertex 3.433795e-02 -2.051597e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.603875e-02 -1.735535e-02 8.000000e-02 + vertex -1.801938e-02 -8.677675e-03 8.000000e-02 + vertex -3.522382e-02 -1.895475e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.602827e-02 1.196221e-02 8.000000e-02 + vertex 3.236068e-02 2.351141e-02 8.000000e-02 + vertex 1.676176e-02 1.091070e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.895475e-02 3.522382e-02 8.000000e-02 + vertex -1.735535e-02 3.603875e-02 8.000000e-02 + vertex -9.250766e-03 1.773199e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.742637e-02 -9.814351e-03 8.000000e-02 + vertex 3.433795e-02 -2.051597e-02 8.000000e-02 + vertex 1.676176e-02 -1.091070e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.602827e-02 1.196221e-02 8.000000e-02 + vertex 3.127326e-02 2.493959e-02 8.000000e-02 + vertex 3.236068e-02 2.351141e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.433795e-02 2.051597e-02 8.000000e-02 + vertex -1.676176e-02 1.091070e-02 8.000000e-02 + vertex -1.742637e-02 9.814351e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.433795e-02 2.051597e-02 8.000000e-02 + vertex -1.742637e-02 9.814351e-03 8.000000e-02 + vertex -3.522382e-02 1.895475e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.051597e-02 3.433795e-02 8.000000e-02 + vertex -1.895475e-02 3.522382e-02 8.000000e-02 + vertex -1.036785e-02 1.710286e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.338293e-02 2.203588e-02 8.000000e-02 + vertex -1.676176e-02 1.091070e-02 8.000000e-02 + vertex -3.433795e-02 2.051597e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.203588e-02 3.338293e-02 8.000000e-02 + vertex -1.036785e-02 1.710286e-02 8.000000e-02 + vertex -1.144233e-02 1.640345e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.246980e-02 -1.563663e-02 8.000000e-02 + vertex -1.144233e-02 -1.640345e-02 8.000000e-02 + vertex -2.351141e-02 -3.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.203588e-02 3.338293e-02 8.000000e-02 + vertex -2.051597e-02 3.433795e-02 8.000000e-02 + vertex -1.036785e-02 1.710286e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 9.250766e-03 -1.773199e-02 8.000000e-02 + vertex 1.895475e-02 -3.522382e-02 8.000000e-02 + vertex 1.735535e-02 -3.603875e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 9.250766e-03 -1.773199e-02 8.000000e-02 + vertex 1.036785e-02 -1.710286e-02 8.000000e-02 + vertex 1.895475e-02 -3.522382e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.236068e-02 2.351141e-02 8.000000e-02 + vertex -1.602827e-02 1.196221e-02 8.000000e-02 + vertex -1.676176e-02 1.091070e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.236068e-02 2.351141e-02 8.000000e-02 + vertex -1.676176e-02 1.091070e-02 8.000000e-02 + vertex -3.338293e-02 2.203588e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.351141e-02 3.236068e-02 8.000000e-02 + vertex -1.144233e-02 1.640345e-02 8.000000e-02 + vertex -1.246980e-02 1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.351141e-02 3.236068e-02 8.000000e-02 + vertex -2.203588e-02 3.338293e-02 8.000000e-02 + vertex -1.144233e-02 1.640345e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.801938e-02 -8.677675e-03 8.000000e-02 + vertex 3.603875e-02 -1.735535e-02 8.000000e-02 + vertex 3.522382e-02 -1.895475e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.801938e-02 -8.677675e-03 8.000000e-02 + vertex 3.678111e-02 -1.572100e-02 8.000000e-02 + vertex 3.603875e-02 -1.735535e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.493959e-02 3.127326e-02 8.000000e-02 + vertex -2.351141e-02 3.236068e-02 8.000000e-02 + vertex -1.246980e-02 1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.246980e-02 -1.563663e-02 8.000000e-02 + vertex -2.493959e-02 -3.127326e-02 8.000000e-02 + vertex -2.631755e-02 -3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.246980e-02 -1.563663e-02 8.000000e-02 + vertex -2.351141e-02 -3.236068e-02 8.000000e-02 + vertex -2.493959e-02 -3.127326e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.064147e-02 3.855851e-02 8.000000e-02 + vertex 5.690552e-03 1.917336e-02 8.000000e-02 + vertex 4.450419e-03 1.949856e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.127326e-02 2.493959e-02 8.000000e-02 + vertex -1.522892e-02 1.296457e-02 8.000000e-02 + vertex -1.602827e-02 1.196221e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.127326e-02 2.493959e-02 8.000000e-02 + vertex -1.602827e-02 1.196221e-02 8.000000e-02 + vertex -3.236068e-02 2.351141e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.012286e-02 2.631755e-02 8.000000e-02 + vertex -1.522892e-02 1.296457e-02 8.000000e-02 + vertex -3.127326e-02 2.493959e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.522892e-02 1.296457e-02 8.000000e-02 + vertex 3.012286e-02 2.631755e-02 8.000000e-02 + vertex 3.127326e-02 2.493959e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.801938e-02 -8.677675e-03 8.000000e-02 + vertex 3.522382e-02 -1.895475e-02 8.000000e-02 + vertex 1.742637e-02 -9.814351e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.012286e-02 2.631755e-02 8.000000e-02 + vertex -1.436699e-02 1.391365e-02 8.000000e-02 + vertex -1.522892e-02 1.296457e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.522892e-02 1.296457e-02 8.000000e-02 + vertex 3.127326e-02 2.493959e-02 8.000000e-02 + vertex 1.602827e-02 1.196221e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.064147e-02 3.855851e-02 8.000000e-02 + vertex 1.236068e-02 3.804226e-02 8.000000e-02 + vertex 5.690552e-03 1.917336e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.631755e-02 3.012286e-02 8.000000e-02 + vertex -1.246980e-02 1.563663e-02 8.000000e-02 + vertex -1.344602e-02 1.480556e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.631755e-02 3.012286e-02 8.000000e-02 + vertex -2.493959e-02 3.127326e-02 8.000000e-02 + vertex -1.246980e-02 1.563663e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.891179e-02 2.764251e-02 8.000000e-02 + vertex -1.436699e-02 1.391365e-02 8.000000e-02 + vertex -3.012286e-02 2.631755e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 8.095667e-03 -1.828825e-02 8.000000e-02 + vertex 9.250766e-03 -1.773199e-02 8.000000e-02 + vertex 1.735535e-02 -3.603875e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.764251e-02 2.891179e-02 8.000000e-02 + vertex -2.631755e-02 3.012286e-02 8.000000e-02 + vertex -1.344602e-02 1.480556e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.764251e-02 2.891179e-02 8.000000e-02 + vertex -1.344602e-02 1.480556e-02 8.000000e-02 + vertex -1.436699e-02 1.391365e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.764251e-02 2.891179e-02 8.000000e-02 + vertex -1.436699e-02 1.391365e-02 8.000000e-02 + vertex -2.891179e-02 2.764251e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.855851e-02 -1.064147e-02 8.000000e-02 + vertex -1.934590e-02 -5.073092e-03 8.000000e-02 + vertex -1.898111e-02 -6.302164e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.344602e-02 -1.480556e-02 8.000000e-02 + vertex -1.246980e-02 -1.563663e-02 8.000000e-02 + vertex -2.631755e-02 -3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.855851e-02 -1.064147e-02 8.000000e-02 + vertex -1.898111e-02 -6.302164e-03 8.000000e-02 + vertex -3.804226e-02 -1.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 8.095667e-03 -1.828825e-02 8.000000e-02 + vertex 1.735535e-02 -3.603875e-02 8.000000e-02 + vertex 1.572100e-02 -3.678111e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.853834e-02 -7.505340e-03 8.000000e-02 + vertex 3.744939e-02 -1.405499e-02 8.000000e-02 + vertex 3.678111e-02 -1.572100e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.764251e-02 -2.891179e-02 8.000000e-02 + vertex -1.344602e-02 -1.480556e-02 8.000000e-02 + vertex -2.631755e-02 -3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.853834e-02 -7.505340e-03 8.000000e-02 + vertex 3.678111e-02 -1.572100e-02 8.000000e-02 + vertex 1.801938e-02 -8.677675e-03 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 -7.956245e-01 -0.000000e+00 + outer loop + vertex -2.351141e-02 -3.236068e-02 1.000000e-01 + vertex -2.493959e-02 -3.127326e-02 1.000000e-01 + vertex -2.493959e-02 -3.127326e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex -2.351141e-02 -3.236068e-02 1.000000e-01 + vertex -2.493959e-02 -3.127326e-02 8.000000e-02 + vertex -2.351141e-02 -3.236068e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 -8.220021e-01 -0.000000e+00 + outer loop + vertex -2.203588e-02 -3.338293e-02 1.000000e-01 + vertex -2.351141e-02 -3.236068e-02 1.000000e-01 + vertex -2.351141e-02 -3.236068e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex -2.203588e-02 -3.338293e-02 1.000000e-01 + vertex -2.351141e-02 -3.236068e-02 8.000000e-02 + vertex -2.203588e-02 -3.338293e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 -8.467242e-01 -0.000000e+00 + outer loop + vertex -2.051597e-02 -3.433795e-02 1.000000e-01 + vertex -2.203588e-02 -3.338293e-02 1.000000e-01 + vertex -2.203588e-02 -3.338293e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex -2.051597e-02 -3.433795e-02 1.000000e-01 + vertex -2.203588e-02 -3.338293e-02 8.000000e-02 + vertex -2.051597e-02 -3.433795e-02 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex 3.995972e-02 1.794593e-03 1.000000e-01 + vertex 4.000000e-02 0.000000e+00 8.000000e-02 + vertex 3.995972e-02 1.794593e-03 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex 3.995972e-02 1.794593e-03 1.000000e-01 + vertex 4.000000e-02 0.000000e+00 1.000000e-01 + vertex 4.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 -8.697411e-01 -0.000000e+00 + outer loop + vertex -1.895475e-02 -3.522382e-02 1.000000e-01 + vertex -2.051597e-02 -3.433795e-02 1.000000e-01 + vertex -2.051597e-02 -3.433795e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex -1.895475e-02 -3.522382e-02 1.000000e-01 + vertex -2.051597e-02 -3.433795e-02 8.000000e-02 + vertex -1.895475e-02 -3.522382e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex 3.983897e-02 3.585572e-03 1.000000e-01 + vertex 3.995972e-02 1.794593e-03 8.000000e-02 + vertex 3.983897e-02 3.585572e-03 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex 3.983897e-02 3.585572e-03 1.000000e-01 + vertex 3.995972e-02 1.794593e-03 1.000000e-01 + vertex 3.995972e-02 1.794593e-03 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 -8.910065e-01 -0.000000e+00 + outer loop + vertex -1.735535e-02 -3.603875e-02 1.000000e-01 + vertex -1.895475e-02 -3.522382e-02 1.000000e-01 + vertex -1.895475e-02 -3.522382e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex -1.735535e-02 -3.603875e-02 1.000000e-01 + vertex -1.895475e-02 -3.522382e-02 8.000000e-02 + vertex -1.735535e-02 -3.603875e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex 3.963799e-02 5.369331e-03 1.000000e-01 + vertex 3.983897e-02 3.585572e-03 8.000000e-02 + vertex 3.963799e-02 5.369331e-03 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex 3.963799e-02 5.369331e-03 1.000000e-01 + vertex 3.983897e-02 3.585572e-03 1.000000e-01 + vertex 3.983897e-02 3.585572e-03 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 -9.104775e-01 -0.000000e+00 + outer loop + vertex -1.572100e-02 -3.678111e-02 1.000000e-01 + vertex -1.735535e-02 -3.603875e-02 1.000000e-01 + vertex -1.735535e-02 -3.603875e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex -1.572100e-02 -3.678111e-02 1.000000e-01 + vertex -1.735535e-02 -3.603875e-02 8.000000e-02 + vertex -1.572100e-02 -3.678111e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex 3.935718e-02 7.142276e-03 1.000000e-01 + vertex 3.963799e-02 5.369331e-03 1.000000e-01 + vertex 3.963799e-02 5.369331e-03 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex 3.935718e-02 7.142276e-03 1.000000e-01 + vertex 3.963799e-02 5.369331e-03 8.000000e-02 + vertex 3.935718e-02 7.142276e-03 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 -9.281150e-01 -0.000000e+00 + outer loop + vertex -1.405499e-02 -3.744939e-02 1.000000e-01 + vertex -1.572100e-02 -3.678111e-02 1.000000e-01 + vertex -1.572100e-02 -3.678111e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex -1.405499e-02 -3.744939e-02 1.000000e-01 + vertex -1.572100e-02 -3.678111e-02 8.000000e-02 + vertex -1.405499e-02 -3.744939e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex 3.899712e-02 8.900837e-03 1.000000e-01 + vertex 3.935718e-02 7.142276e-03 1.000000e-01 + vertex 3.935718e-02 7.142276e-03 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex 3.899712e-02 8.900837e-03 1.000000e-01 + vertex 3.935718e-02 7.142276e-03 8.000000e-02 + vertex 3.899712e-02 8.900837e-03 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 -9.438833e-01 -0.000000e+00 + outer loop + vertex -1.236068e-02 -3.804226e-02 1.000000e-01 + vertex -1.405499e-02 -3.744939e-02 1.000000e-01 + vertex -1.405499e-02 -3.744939e-02 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex -1.236068e-02 -3.804226e-02 1.000000e-01 + vertex -1.405499e-02 -3.744939e-02 8.000000e-02 + vertex -1.236068e-02 -3.804226e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex 3.855851e-02 1.064147e-02 1.000000e-01 + vertex 3.899712e-02 8.900837e-03 8.000000e-02 + vertex 3.855851e-02 1.064147e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex 3.855851e-02 1.064147e-02 1.000000e-01 + vertex 3.899712e-02 8.900837e-03 1.000000e-01 + vertex 3.899712e-02 8.900837e-03 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 -9.577508e-01 -0.000000e+00 + outer loop + vertex -1.064147e-02 -3.855851e-02 1.000000e-01 + vertex -1.236068e-02 -3.804226e-02 1.000000e-01 + vertex -1.236068e-02 -3.804226e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex 3.804226e-02 1.236068e-02 1.000000e-01 + vertex 3.855851e-02 1.064147e-02 8.000000e-02 + vertex 3.804226e-02 1.236068e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex -1.064147e-02 -3.855851e-02 1.000000e-01 + vertex -1.236068e-02 -3.804226e-02 8.000000e-02 + vertex -1.064147e-02 -3.855851e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex 3.804226e-02 1.236068e-02 1.000000e-01 + vertex 3.855851e-02 1.064147e-02 1.000000e-01 + vertex 3.855851e-02 1.064147e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 -9.696895e-01 -0.000000e+00 + outer loop + vertex -8.900837e-03 -3.899712e-02 1.000000e-01 + vertex -1.064147e-02 -3.855851e-02 1.000000e-01 + vertex -1.064147e-02 -3.855851e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex 3.744939e-02 1.405499e-02 1.000000e-01 + vertex 3.804226e-02 1.236068e-02 1.000000e-01 + vertex 3.804226e-02 1.236068e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex -8.900837e-03 -3.899712e-02 1.000000e-01 + vertex -1.064147e-02 -3.855851e-02 8.000000e-02 + vertex -8.900837e-03 -3.899712e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex 3.744939e-02 1.405499e-02 1.000000e-01 + vertex 3.804226e-02 1.236068e-02 8.000000e-02 + vertex 3.744939e-02 1.405499e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex -7.142276e-03 -3.935718e-02 1.000000e-01 + vertex -8.900837e-03 -3.899712e-02 8.000000e-02 + vertex -7.142276e-03 -3.935718e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 -9.796754e-01 -0.000000e+00 + outer loop + vertex -7.142276e-03 -3.935718e-02 1.000000e-01 + vertex -8.900837e-03 -3.899712e-02 1.000000e-01 + vertex -8.900837e-03 -3.899712e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex 3.678111e-02 1.572100e-02 1.000000e-01 + vertex 3.744939e-02 1.405499e-02 8.000000e-02 + vertex 3.678111e-02 1.572100e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex 3.678111e-02 1.572100e-02 1.000000e-01 + vertex 3.744939e-02 1.405499e-02 1.000000e-01 + vertex 3.744939e-02 1.405499e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex -5.369331e-03 -3.963799e-02 1.000000e-01 + vertex -7.142276e-03 -3.935718e-02 8.000000e-02 + vertex -5.369331e-03 -3.963799e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 -9.876883e-01 -0.000000e+00 + outer loop + vertex -5.369331e-03 -3.963799e-02 1.000000e-01 + vertex -7.142276e-03 -3.935718e-02 1.000000e-01 + vertex -7.142276e-03 -3.935718e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex 3.603875e-02 1.735535e-02 1.000000e-01 + vertex 3.678111e-02 1.572100e-02 8.000000e-02 + vertex 3.603875e-02 1.735535e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex 3.603875e-02 1.735535e-02 1.000000e-01 + vertex 3.678111e-02 1.572100e-02 1.000000e-01 + vertex 3.678111e-02 1.572100e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex -3.585572e-03 -3.983897e-02 1.000000e-01 + vertex -5.369331e-03 -3.963799e-02 8.000000e-02 + vertex -3.585572e-03 -3.983897e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 -9.937122e-01 -0.000000e+00 + outer loop + vertex -3.585572e-03 -3.983897e-02 1.000000e-01 + vertex -5.369331e-03 -3.963799e-02 1.000000e-01 + vertex -5.369331e-03 -3.963799e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex 3.522382e-02 1.895475e-02 1.000000e-01 + vertex 3.603875e-02 1.735535e-02 8.000000e-02 + vertex 3.522382e-02 1.895475e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex 3.522382e-02 1.895475e-02 1.000000e-01 + vertex 3.603875e-02 1.735535e-02 1.000000e-01 + vertex 3.603875e-02 1.735535e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex -1.794593e-03 -3.995972e-02 1.000000e-01 + vertex -3.585572e-03 -3.983897e-02 8.000000e-02 + vertex -1.794593e-03 -3.995972e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 -9.977349e-01 -0.000000e+00 + outer loop + vertex -1.794593e-03 -3.995972e-02 1.000000e-01 + vertex -3.585572e-03 -3.983897e-02 1.000000e-01 + vertex -3.585572e-03 -3.983897e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex 3.433795e-02 2.051597e-02 1.000000e-01 + vertex 3.522382e-02 1.895475e-02 8.000000e-02 + vertex 3.433795e-02 2.051597e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex 3.433795e-02 2.051597e-02 1.000000e-01 + vertex 3.522382e-02 1.895475e-02 1.000000e-01 + vertex 3.522382e-02 1.895475e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex -7.347881e-18 -4.000000e-02 1.000000e-01 + vertex -1.794593e-03 -3.995972e-02 8.000000e-02 + vertex -7.347881e-18 -4.000000e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 -9.997482e-01 -0.000000e+00 + outer loop + vertex -7.347881e-18 -4.000000e-02 1.000000e-01 + vertex -1.794593e-03 -3.995972e-02 1.000000e-01 + vertex -1.794593e-03 -3.995972e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex 3.338293e-02 2.203588e-02 1.000000e-01 + vertex 3.433795e-02 2.051597e-02 8.000000e-02 + vertex 3.338293e-02 2.203588e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex 3.338293e-02 2.203588e-02 1.000000e-01 + vertex 3.433795e-02 2.051597e-02 1.000000e-01 + vertex 3.433795e-02 2.051597e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex 1.794593e-03 -3.995972e-02 1.000000e-01 + vertex -7.347881e-18 -4.000000e-02 8.000000e-02 + vertex 1.794593e-03 -3.995972e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex 1.794593e-03 -3.995972e-02 1.000000e-01 + vertex -7.347881e-18 -4.000000e-02 1.000000e-01 + vertex -7.347881e-18 -4.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex 3.236068e-02 2.351141e-02 1.000000e-01 + vertex 3.338293e-02 2.203588e-02 8.000000e-02 + vertex 3.236068e-02 2.351141e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex 3.585572e-03 -3.983897e-02 1.000000e-01 + vertex 1.794593e-03 -3.995972e-02 1.000000e-01 + vertex 1.794593e-03 -3.995972e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex 3.236068e-02 2.351141e-02 1.000000e-01 + vertex 3.338293e-02 2.203588e-02 1.000000e-01 + vertex 3.338293e-02 2.203588e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex 3.585572e-03 -3.983897e-02 1.000000e-01 + vertex 1.794593e-03 -3.995972e-02 8.000000e-02 + vertex 3.585572e-03 -3.983897e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex 3.127326e-02 2.493959e-02 1.000000e-01 + vertex 3.236068e-02 2.351141e-02 8.000000e-02 + vertex 3.127326e-02 2.493959e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex 5.369331e-03 -3.963799e-02 1.000000e-01 + vertex 3.585572e-03 -3.983897e-02 8.000000e-02 + vertex 5.369331e-03 -3.963799e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex 3.127326e-02 2.493959e-02 1.000000e-01 + vertex 3.236068e-02 2.351141e-02 1.000000e-01 + vertex 3.236068e-02 2.351141e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex 5.369331e-03 -3.963799e-02 1.000000e-01 + vertex 3.585572e-03 -3.983897e-02 1.000000e-01 + vertex 3.585572e-03 -3.983897e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex 3.012286e-02 2.631755e-02 1.000000e-01 + vertex 3.127326e-02 2.493959e-02 8.000000e-02 + vertex 3.012286e-02 2.631755e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex 7.142276e-03 -3.935718e-02 1.000000e-01 + vertex 5.369331e-03 -3.963799e-02 8.000000e-02 + vertex 7.142276e-03 -3.935718e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex 3.012286e-02 2.631755e-02 1.000000e-01 + vertex 3.127326e-02 2.493959e-02 1.000000e-01 + vertex 3.127326e-02 2.493959e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex 7.142276e-03 -3.935718e-02 1.000000e-01 + vertex 5.369331e-03 -3.963799e-02 1.000000e-01 + vertex 5.369331e-03 -3.963799e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex 8.900837e-03 -3.899712e-02 1.000000e-01 + vertex 7.142276e-03 -3.935718e-02 8.000000e-02 + vertex 8.900837e-03 -3.899712e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex 2.891179e-02 2.764251e-02 1.000000e-01 + vertex 3.012286e-02 2.631755e-02 8.000000e-02 + vertex 2.891179e-02 2.764251e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex 8.900837e-03 -3.899712e-02 1.000000e-01 + vertex 7.142276e-03 -3.935718e-02 1.000000e-01 + vertex 7.142276e-03 -3.935718e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex 2.891179e-02 2.764251e-02 1.000000e-01 + vertex 3.012286e-02 2.631755e-02 1.000000e-01 + vertex 3.012286e-02 2.631755e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex 1.064147e-02 -3.855851e-02 1.000000e-01 + vertex 8.900837e-03 -3.899712e-02 8.000000e-02 + vertex 1.064147e-02 -3.855851e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex 2.764251e-02 2.891179e-02 1.000000e-01 + vertex 2.891179e-02 2.764251e-02 8.000000e-02 + vertex 2.764251e-02 2.891179e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex 1.064147e-02 -3.855851e-02 1.000000e-01 + vertex 8.900837e-03 -3.899712e-02 1.000000e-01 + vertex 8.900837e-03 -3.899712e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex 2.764251e-02 2.891179e-02 1.000000e-01 + vertex 2.891179e-02 2.764251e-02 1.000000e-01 + vertex 2.891179e-02 2.764251e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex 1.236068e-02 -3.804226e-02 1.000000e-01 + vertex 1.064147e-02 -3.855851e-02 8.000000e-02 + vertex 1.236068e-02 -3.804226e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex 2.631755e-02 3.012286e-02 1.000000e-01 + vertex 2.764251e-02 2.891179e-02 8.000000e-02 + vertex 2.631755e-02 3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex 1.236068e-02 -3.804226e-02 1.000000e-01 + vertex 1.064147e-02 -3.855851e-02 1.000000e-01 + vertex 1.064147e-02 -3.855851e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex 2.631755e-02 3.012286e-02 1.000000e-01 + vertex 2.764251e-02 2.891179e-02 1.000000e-01 + vertex 2.764251e-02 2.891179e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex 1.405499e-02 -3.744939e-02 1.000000e-01 + vertex 1.236068e-02 -3.804226e-02 8.000000e-02 + vertex 1.405499e-02 -3.744939e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex 1.405499e-02 -3.744939e-02 1.000000e-01 + vertex 1.236068e-02 -3.804226e-02 1.000000e-01 + vertex 1.236068e-02 -3.804226e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex 2.493959e-02 3.127326e-02 1.000000e-01 + vertex 2.631755e-02 3.012286e-02 8.000000e-02 + vertex 2.493959e-02 3.127326e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex 2.493959e-02 3.127326e-02 1.000000e-01 + vertex 2.631755e-02 3.012286e-02 1.000000e-01 + vertex 2.631755e-02 3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex 1.572100e-02 -3.678111e-02 1.000000e-01 + vertex 1.405499e-02 -3.744939e-02 8.000000e-02 + vertex 1.572100e-02 -3.678111e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex 1.572100e-02 -3.678111e-02 1.000000e-01 + vertex 1.405499e-02 -3.744939e-02 1.000000e-01 + vertex 1.405499e-02 -3.744939e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex 2.351141e-02 3.236068e-02 1.000000e-01 + vertex 2.493959e-02 3.127326e-02 8.000000e-02 + vertex 2.351141e-02 3.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex 2.351141e-02 3.236068e-02 1.000000e-01 + vertex 2.493959e-02 3.127326e-02 1.000000e-01 + vertex 2.493959e-02 3.127326e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex 1.735535e-02 -3.603875e-02 1.000000e-01 + vertex 1.572100e-02 -3.678111e-02 8.000000e-02 + vertex 1.735535e-02 -3.603875e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex 1.735535e-02 -3.603875e-02 1.000000e-01 + vertex 1.572100e-02 -3.678111e-02 1.000000e-01 + vertex 1.572100e-02 -3.678111e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex 2.203588e-02 3.338293e-02 1.000000e-01 + vertex 2.351141e-02 3.236068e-02 8.000000e-02 + vertex 2.203588e-02 3.338293e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex 2.203588e-02 3.338293e-02 1.000000e-01 + vertex 2.351141e-02 3.236068e-02 1.000000e-01 + vertex 2.351141e-02 3.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex 1.895475e-02 -3.522382e-02 1.000000e-01 + vertex 1.735535e-02 -3.603875e-02 8.000000e-02 + vertex 1.895475e-02 -3.522382e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex 1.895475e-02 -3.522382e-02 1.000000e-01 + vertex 1.735535e-02 -3.603875e-02 1.000000e-01 + vertex 1.735535e-02 -3.603875e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex 2.051597e-02 3.433795e-02 1.000000e-01 + vertex 2.203588e-02 3.338293e-02 8.000000e-02 + vertex 2.051597e-02 3.433795e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex 2.051597e-02 3.433795e-02 1.000000e-01 + vertex 2.203588e-02 3.338293e-02 1.000000e-01 + vertex 2.203588e-02 3.338293e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex 2.051597e-02 -3.433795e-02 1.000000e-01 + vertex 1.895475e-02 -3.522382e-02 8.000000e-02 + vertex 2.051597e-02 -3.433795e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex 2.051597e-02 -3.433795e-02 1.000000e-01 + vertex 1.895475e-02 -3.522382e-02 1.000000e-01 + vertex 1.895475e-02 -3.522382e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex 1.895475e-02 3.522382e-02 1.000000e-01 + vertex 2.051597e-02 3.433795e-02 8.000000e-02 + vertex 1.895475e-02 3.522382e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex 2.203588e-02 -3.338293e-02 1.000000e-01 + vertex 2.051597e-02 -3.433795e-02 8.000000e-02 + vertex 2.203588e-02 -3.338293e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex 1.895475e-02 3.522382e-02 1.000000e-01 + vertex 2.051597e-02 3.433795e-02 1.000000e-01 + vertex 2.051597e-02 3.433795e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex 2.203588e-02 -3.338293e-02 1.000000e-01 + vertex 2.051597e-02 -3.433795e-02 1.000000e-01 + vertex 2.051597e-02 -3.433795e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex 1.735535e-02 3.603875e-02 1.000000e-01 + vertex 1.895475e-02 3.522382e-02 8.000000e-02 + vertex 1.735535e-02 3.603875e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex 2.351141e-02 -3.236068e-02 1.000000e-01 + vertex 2.203588e-02 -3.338293e-02 8.000000e-02 + vertex 2.351141e-02 -3.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex 1.735535e-02 3.603875e-02 1.000000e-01 + vertex 1.895475e-02 3.522382e-02 1.000000e-01 + vertex 1.895475e-02 3.522382e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex 2.351141e-02 -3.236068e-02 1.000000e-01 + vertex 2.203588e-02 -3.338293e-02 1.000000e-01 + vertex 2.203588e-02 -3.338293e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex 1.572100e-02 3.678111e-02 1.000000e-01 + vertex 1.735535e-02 3.603875e-02 8.000000e-02 + vertex 1.572100e-02 3.678111e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex 2.493959e-02 -3.127326e-02 1.000000e-01 + vertex 2.351141e-02 -3.236068e-02 8.000000e-02 + vertex 2.493959e-02 -3.127326e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex 1.572100e-02 3.678111e-02 1.000000e-01 + vertex 1.735535e-02 3.603875e-02 1.000000e-01 + vertex 1.735535e-02 3.603875e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex 2.493959e-02 -3.127326e-02 1.000000e-01 + vertex 2.351141e-02 -3.236068e-02 1.000000e-01 + vertex 2.351141e-02 -3.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex 2.631755e-02 -3.012286e-02 1.000000e-01 + vertex 2.493959e-02 -3.127326e-02 8.000000e-02 + vertex 2.631755e-02 -3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex 1.405499e-02 3.744939e-02 1.000000e-01 + vertex 1.572100e-02 3.678111e-02 8.000000e-02 + vertex 1.405499e-02 3.744939e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex 2.631755e-02 -3.012286e-02 1.000000e-01 + vertex 2.493959e-02 -3.127326e-02 1.000000e-01 + vertex 2.493959e-02 -3.127326e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex 1.405499e-02 3.744939e-02 1.000000e-01 + vertex 1.572100e-02 3.678111e-02 1.000000e-01 + vertex 1.572100e-02 3.678111e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex 2.764251e-02 -2.891179e-02 1.000000e-01 + vertex 2.631755e-02 -3.012286e-02 8.000000e-02 + vertex 2.764251e-02 -2.891179e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex 1.236068e-02 3.804226e-02 1.000000e-01 + vertex 1.405499e-02 3.744939e-02 8.000000e-02 + vertex 1.236068e-02 3.804226e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex 2.764251e-02 -2.891179e-02 1.000000e-01 + vertex 2.631755e-02 -3.012286e-02 1.000000e-01 + vertex 2.631755e-02 -3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex 1.236068e-02 3.804226e-02 1.000000e-01 + vertex 1.405499e-02 3.744939e-02 1.000000e-01 + vertex 1.405499e-02 3.744939e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex 2.891179e-02 -2.764251e-02 1.000000e-01 + vertex 2.764251e-02 -2.891179e-02 8.000000e-02 + vertex 2.891179e-02 -2.764251e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex 2.891179e-02 -2.764251e-02 1.000000e-01 + vertex 2.764251e-02 -2.891179e-02 1.000000e-01 + vertex 2.764251e-02 -2.891179e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex 1.064147e-02 3.855851e-02 1.000000e-01 + vertex 1.236068e-02 3.804226e-02 8.000000e-02 + vertex 1.064147e-02 3.855851e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex 1.064147e-02 3.855851e-02 1.000000e-01 + vertex 1.236068e-02 3.804226e-02 1.000000e-01 + vertex 1.236068e-02 3.804226e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex 3.012286e-02 -2.631755e-02 1.000000e-01 + vertex 2.891179e-02 -2.764251e-02 8.000000e-02 + vertex 3.012286e-02 -2.631755e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex 3.012286e-02 -2.631755e-02 1.000000e-01 + vertex 2.891179e-02 -2.764251e-02 1.000000e-01 + vertex 2.891179e-02 -2.764251e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex 8.900837e-03 3.899712e-02 1.000000e-01 + vertex 1.064147e-02 3.855851e-02 1.000000e-01 + vertex 1.064147e-02 3.855851e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex 8.900837e-03 3.899712e-02 1.000000e-01 + vertex 1.064147e-02 3.855851e-02 8.000000e-02 + vertex 8.900837e-03 3.899712e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex 3.127326e-02 -2.493959e-02 1.000000e-01 + vertex 3.012286e-02 -2.631755e-02 8.000000e-02 + vertex 3.127326e-02 -2.493959e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex 3.127326e-02 -2.493959e-02 1.000000e-01 + vertex 3.012286e-02 -2.631755e-02 1.000000e-01 + vertex 3.012286e-02 -2.631755e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex 7.142276e-03 3.935718e-02 1.000000e-01 + vertex 8.900837e-03 3.899712e-02 1.000000e-01 + vertex 8.900837e-03 3.899712e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex 7.142276e-03 3.935718e-02 1.000000e-01 + vertex 8.900837e-03 3.899712e-02 8.000000e-02 + vertex 7.142276e-03 3.935718e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex 3.236068e-02 -2.351141e-02 1.000000e-01 + vertex 3.127326e-02 -2.493959e-02 8.000000e-02 + vertex 3.236068e-02 -2.351141e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex 3.236068e-02 -2.351141e-02 1.000000e-01 + vertex 3.127326e-02 -2.493959e-02 1.000000e-01 + vertex 3.127326e-02 -2.493959e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex 5.369331e-03 3.963799e-02 1.000000e-01 + vertex 7.142276e-03 3.935718e-02 1.000000e-01 + vertex 7.142276e-03 3.935718e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex 5.369331e-03 3.963799e-02 1.000000e-01 + vertex 7.142276e-03 3.935718e-02 8.000000e-02 + vertex 5.369331e-03 3.963799e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex 3.338293e-02 -2.203588e-02 1.000000e-01 + vertex 3.236068e-02 -2.351141e-02 8.000000e-02 + vertex 3.338293e-02 -2.203588e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex 3.338293e-02 -2.203588e-02 1.000000e-01 + vertex 3.236068e-02 -2.351141e-02 1.000000e-01 + vertex 3.236068e-02 -2.351141e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex 3.585572e-03 3.983897e-02 1.000000e-01 + vertex 5.369331e-03 3.963799e-02 1.000000e-01 + vertex 5.369331e-03 3.963799e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex 3.585572e-03 3.983897e-02 1.000000e-01 + vertex 5.369331e-03 3.963799e-02 8.000000e-02 + vertex 3.585572e-03 3.983897e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex 3.433795e-02 -2.051597e-02 1.000000e-01 + vertex 3.338293e-02 -2.203588e-02 8.000000e-02 + vertex 3.433795e-02 -2.051597e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex 3.433795e-02 -2.051597e-02 1.000000e-01 + vertex 3.338293e-02 -2.203588e-02 1.000000e-01 + vertex 3.338293e-02 -2.203588e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex 1.794593e-03 3.995972e-02 1.000000e-01 + vertex 3.585572e-03 3.983897e-02 1.000000e-01 + vertex 3.585572e-03 3.983897e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex 1.794593e-03 3.995972e-02 1.000000e-01 + vertex 3.585572e-03 3.983897e-02 8.000000e-02 + vertex 1.794593e-03 3.995972e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex 3.522382e-02 -1.895475e-02 1.000000e-01 + vertex 3.433795e-02 -2.051597e-02 8.000000e-02 + vertex 3.522382e-02 -1.895475e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex 3.522382e-02 -1.895475e-02 1.000000e-01 + vertex 3.433795e-02 -2.051597e-02 1.000000e-01 + vertex 3.433795e-02 -2.051597e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex 2.449294e-18 4.000000e-02 1.000000e-01 + vertex 1.794593e-03 3.995972e-02 1.000000e-01 + vertex 1.794593e-03 3.995972e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex 2.449294e-18 4.000000e-02 1.000000e-01 + vertex 1.794593e-03 3.995972e-02 8.000000e-02 + vertex 2.449294e-18 4.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex 3.603875e-02 -1.735535e-02 1.000000e-01 + vertex 3.522382e-02 -1.895475e-02 1.000000e-01 + vertex 3.522382e-02 -1.895475e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex 3.603875e-02 -1.735535e-02 1.000000e-01 + vertex 3.522382e-02 -1.895475e-02 8.000000e-02 + vertex 3.603875e-02 -1.735535e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex 3.678111e-02 -1.572100e-02 1.000000e-01 + vertex 3.603875e-02 -1.735535e-02 1.000000e-01 + vertex 3.603875e-02 -1.735535e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex -1.794593e-03 3.995972e-02 1.000000e-01 + vertex 2.449294e-18 4.000000e-02 1.000000e-01 + vertex 2.449294e-18 4.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex 3.678111e-02 -1.572100e-02 1.000000e-01 + vertex 3.603875e-02 -1.735535e-02 8.000000e-02 + vertex 3.678111e-02 -1.572100e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex -1.794593e-03 3.995972e-02 1.000000e-01 + vertex 2.449294e-18 4.000000e-02 8.000000e-02 + vertex -1.794593e-03 3.995972e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex 3.744939e-02 -1.405499e-02 1.000000e-01 + vertex 3.678111e-02 -1.572100e-02 1.000000e-01 + vertex 3.678111e-02 -1.572100e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex -3.585572e-03 3.983897e-02 1.000000e-01 + vertex -1.794593e-03 3.995972e-02 1.000000e-01 + vertex -1.794593e-03 3.995972e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex 3.744939e-02 -1.405499e-02 1.000000e-01 + vertex 3.678111e-02 -1.572100e-02 8.000000e-02 + vertex 3.744939e-02 -1.405499e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex -3.585572e-03 3.983897e-02 1.000000e-01 + vertex -1.794593e-03 3.995972e-02 8.000000e-02 + vertex -3.585572e-03 3.983897e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex 3.804226e-02 -1.236068e-02 1.000000e-01 + vertex 3.744939e-02 -1.405499e-02 1.000000e-01 + vertex 3.744939e-02 -1.405499e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex 3.804226e-02 -1.236068e-02 1.000000e-01 + vertex 3.744939e-02 -1.405499e-02 8.000000e-02 + vertex 3.804226e-02 -1.236068e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex -5.369331e-03 3.963799e-02 1.000000e-01 + vertex -3.585572e-03 3.983897e-02 1.000000e-01 + vertex -3.585572e-03 3.983897e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex -5.369331e-03 3.963799e-02 1.000000e-01 + vertex -3.585572e-03 3.983897e-02 8.000000e-02 + vertex -5.369331e-03 3.963799e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex 3.855851e-02 -1.064147e-02 1.000000e-01 + vertex 3.804226e-02 -1.236068e-02 1.000000e-01 + vertex 3.804226e-02 -1.236068e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex 3.855851e-02 -1.064147e-02 1.000000e-01 + vertex 3.804226e-02 -1.236068e-02 8.000000e-02 + vertex 3.855851e-02 -1.064147e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex -7.142276e-03 3.935718e-02 1.000000e-01 + vertex -5.369331e-03 3.963799e-02 8.000000e-02 + vertex -7.142276e-03 3.935718e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex -7.142276e-03 3.935718e-02 1.000000e-01 + vertex -5.369331e-03 3.963799e-02 1.000000e-01 + vertex -5.369331e-03 3.963799e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex 3.899712e-02 -8.900837e-03 1.000000e-01 + vertex 3.855851e-02 -1.064147e-02 1.000000e-01 + vertex 3.855851e-02 -1.064147e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex 3.899712e-02 -8.900837e-03 1.000000e-01 + vertex 3.855851e-02 -1.064147e-02 8.000000e-02 + vertex 3.899712e-02 -8.900837e-03 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex -8.900837e-03 3.899712e-02 1.000000e-01 + vertex -7.142276e-03 3.935718e-02 8.000000e-02 + vertex -8.900837e-03 3.899712e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex -8.900837e-03 3.899712e-02 1.000000e-01 + vertex -7.142276e-03 3.935718e-02 1.000000e-01 + vertex -7.142276e-03 3.935718e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex 3.935718e-02 -7.142276e-03 1.000000e-01 + vertex 3.899712e-02 -8.900837e-03 1.000000e-01 + vertex 3.899712e-02 -8.900837e-03 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex 3.935718e-02 -7.142276e-03 1.000000e-01 + vertex 3.899712e-02 -8.900837e-03 8.000000e-02 + vertex 3.935718e-02 -7.142276e-03 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex -1.064147e-02 3.855851e-02 1.000000e-01 + vertex -8.900837e-03 3.899712e-02 8.000000e-02 + vertex -1.064147e-02 3.855851e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex -1.064147e-02 3.855851e-02 1.000000e-01 + vertex -8.900837e-03 3.899712e-02 1.000000e-01 + vertex -8.900837e-03 3.899712e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex 3.963799e-02 -5.369331e-03 1.000000e-01 + vertex 3.935718e-02 -7.142276e-03 1.000000e-01 + vertex 3.935718e-02 -7.142276e-03 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex 3.963799e-02 -5.369331e-03 1.000000e-01 + vertex 3.935718e-02 -7.142276e-03 8.000000e-02 + vertex 3.963799e-02 -5.369331e-03 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex -1.236068e-02 3.804226e-02 1.000000e-01 + vertex -1.064147e-02 3.855851e-02 8.000000e-02 + vertex -1.236068e-02 3.804226e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex -1.236068e-02 3.804226e-02 1.000000e-01 + vertex -1.064147e-02 3.855851e-02 1.000000e-01 + vertex -1.064147e-02 3.855851e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex 3.983897e-02 -3.585572e-03 1.000000e-01 + vertex 3.963799e-02 -5.369331e-03 1.000000e-01 + vertex 3.963799e-02 -5.369331e-03 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex 3.983897e-02 -3.585572e-03 1.000000e-01 + vertex 3.963799e-02 -5.369331e-03 8.000000e-02 + vertex 3.983897e-02 -3.585572e-03 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex -1.405499e-02 3.744939e-02 1.000000e-01 + vertex -1.236068e-02 3.804226e-02 8.000000e-02 + vertex -1.405499e-02 3.744939e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex 3.995972e-02 -1.794593e-03 1.000000e-01 + vertex 3.983897e-02 -3.585572e-03 1.000000e-01 + vertex 3.983897e-02 -3.585572e-03 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex -1.405499e-02 3.744939e-02 1.000000e-01 + vertex -1.236068e-02 3.804226e-02 1.000000e-01 + vertex -1.236068e-02 3.804226e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex 3.995972e-02 -1.794593e-03 1.000000e-01 + vertex 3.983897e-02 -3.585572e-03 8.000000e-02 + vertex 3.995972e-02 -1.794593e-03 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex 4.000000e-02 0.000000e+00 1.000000e-01 + vertex 3.995972e-02 -1.794593e-03 8.000000e-02 + vertex 4.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex 4.000000e-02 0.000000e+00 1.000000e-01 + vertex 3.995972e-02 -1.794593e-03 1.000000e-01 + vertex 3.995972e-02 -1.794593e-03 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex -1.572100e-02 3.678111e-02 1.000000e-01 + vertex -1.405499e-02 3.744939e-02 8.000000e-02 + vertex -1.572100e-02 3.678111e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex -1.572100e-02 3.678111e-02 1.000000e-01 + vertex -1.405499e-02 3.744939e-02 1.000000e-01 + vertex -1.405499e-02 3.744939e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex -1.735535e-02 3.603875e-02 1.000000e-01 + vertex -1.572100e-02 3.678111e-02 8.000000e-02 + vertex -1.735535e-02 3.603875e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex -1.735535e-02 3.603875e-02 1.000000e-01 + vertex -1.572100e-02 3.678111e-02 1.000000e-01 + vertex -1.572100e-02 3.678111e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex -1.895475e-02 3.522382e-02 1.000000e-01 + vertex -1.735535e-02 3.603875e-02 8.000000e-02 + vertex -1.895475e-02 3.522382e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex -1.895475e-02 3.522382e-02 1.000000e-01 + vertex -1.735535e-02 3.603875e-02 1.000000e-01 + vertex -1.735535e-02 3.603875e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex -2.051597e-02 3.433795e-02 1.000000e-01 + vertex -1.895475e-02 3.522382e-02 8.000000e-02 + vertex -2.051597e-02 3.433795e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex -2.051597e-02 3.433795e-02 1.000000e-01 + vertex -1.895475e-02 3.522382e-02 1.000000e-01 + vertex -1.895475e-02 3.522382e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex -2.203588e-02 3.338293e-02 1.000000e-01 + vertex -2.051597e-02 3.433795e-02 8.000000e-02 + vertex -2.203588e-02 3.338293e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex -2.203588e-02 3.338293e-02 1.000000e-01 + vertex -2.051597e-02 3.433795e-02 1.000000e-01 + vertex -2.051597e-02 3.433795e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex -2.351141e-02 3.236068e-02 1.000000e-01 + vertex -2.203588e-02 3.338293e-02 8.000000e-02 + vertex -2.351141e-02 3.236068e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex -2.351141e-02 3.236068e-02 1.000000e-01 + vertex -2.203588e-02 3.338293e-02 1.000000e-01 + vertex -2.203588e-02 3.338293e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex -2.493959e-02 3.127326e-02 1.000000e-01 + vertex -2.351141e-02 3.236068e-02 8.000000e-02 + vertex -2.493959e-02 3.127326e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex -2.493959e-02 3.127326e-02 1.000000e-01 + vertex -2.351141e-02 3.236068e-02 1.000000e-01 + vertex -2.351141e-02 3.236068e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex -2.631755e-02 3.012286e-02 1.000000e-01 + vertex -2.493959e-02 3.127326e-02 8.000000e-02 + vertex -2.631755e-02 3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex -2.631755e-02 3.012286e-02 1.000000e-01 + vertex -2.493959e-02 3.127326e-02 1.000000e-01 + vertex -2.493959e-02 3.127326e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex -2.764251e-02 2.891179e-02 1.000000e-01 + vertex -2.631755e-02 3.012286e-02 8.000000e-02 + vertex -2.764251e-02 2.891179e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex -2.764251e-02 2.891179e-02 1.000000e-01 + vertex -2.631755e-02 3.012286e-02 1.000000e-01 + vertex -2.631755e-02 3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex -2.891179e-02 2.764251e-02 1.000000e-01 + vertex -2.764251e-02 2.891179e-02 8.000000e-02 + vertex -2.891179e-02 2.764251e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex -2.891179e-02 2.764251e-02 1.000000e-01 + vertex -2.764251e-02 2.891179e-02 1.000000e-01 + vertex -2.764251e-02 2.891179e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex -3.012286e-02 2.631755e-02 1.000000e-01 + vertex -2.891179e-02 2.764251e-02 8.000000e-02 + vertex -3.012286e-02 2.631755e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex -3.012286e-02 2.631755e-02 1.000000e-01 + vertex -2.891179e-02 2.764251e-02 1.000000e-01 + vertex -2.891179e-02 2.764251e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex -3.127326e-02 2.493959e-02 1.000000e-01 + vertex -3.012286e-02 2.631755e-02 1.000000e-01 + vertex -3.012286e-02 2.631755e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex -3.127326e-02 2.493959e-02 1.000000e-01 + vertex -3.012286e-02 2.631755e-02 8.000000e-02 + vertex -3.127326e-02 2.493959e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex -3.236068e-02 2.351141e-02 1.000000e-01 + vertex -3.127326e-02 2.493959e-02 1.000000e-01 + vertex -3.127326e-02 2.493959e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex -3.236068e-02 2.351141e-02 1.000000e-01 + vertex -3.127326e-02 2.493959e-02 8.000000e-02 + vertex -3.236068e-02 2.351141e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex -3.338293e-02 2.203588e-02 1.000000e-01 + vertex -3.236068e-02 2.351141e-02 1.000000e-01 + vertex -3.236068e-02 2.351141e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex -3.338293e-02 2.203588e-02 1.000000e-01 + vertex -3.236068e-02 2.351141e-02 8.000000e-02 + vertex -3.338293e-02 2.203588e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex -3.433795e-02 2.051597e-02 1.000000e-01 + vertex -3.338293e-02 2.203588e-02 1.000000e-01 + vertex -3.338293e-02 2.203588e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex -3.433795e-02 2.051597e-02 1.000000e-01 + vertex -3.338293e-02 2.203588e-02 8.000000e-02 + vertex -3.433795e-02 2.051597e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex -3.522382e-02 1.895475e-02 1.000000e-01 + vertex -3.433795e-02 2.051597e-02 1.000000e-01 + vertex -3.433795e-02 2.051597e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex -3.522382e-02 1.895475e-02 1.000000e-01 + vertex -3.433795e-02 2.051597e-02 8.000000e-02 + vertex -3.522382e-02 1.895475e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex -3.603875e-02 1.735535e-02 1.000000e-01 + vertex -3.522382e-02 1.895475e-02 1.000000e-01 + vertex -3.522382e-02 1.895475e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex -3.603875e-02 1.735535e-02 1.000000e-01 + vertex -3.522382e-02 1.895475e-02 8.000000e-02 + vertex -3.603875e-02 1.735535e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex -3.678111e-02 1.572100e-02 1.000000e-01 + vertex -3.603875e-02 1.735535e-02 1.000000e-01 + vertex -3.603875e-02 1.735535e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex -3.678111e-02 1.572100e-02 1.000000e-01 + vertex -3.603875e-02 1.735535e-02 8.000000e-02 + vertex -3.678111e-02 1.572100e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex -3.744939e-02 1.405499e-02 1.000000e-01 + vertex -3.678111e-02 1.572100e-02 1.000000e-01 + vertex -3.678111e-02 1.572100e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex -3.744939e-02 1.405499e-02 1.000000e-01 + vertex -3.678111e-02 1.572100e-02 8.000000e-02 + vertex -3.744939e-02 1.405499e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex -3.804226e-02 1.236068e-02 1.000000e-01 + vertex -3.744939e-02 1.405499e-02 1.000000e-01 + vertex -3.744939e-02 1.405499e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex -3.804226e-02 1.236068e-02 1.000000e-01 + vertex -3.744939e-02 1.405499e-02 8.000000e-02 + vertex -3.804226e-02 1.236068e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex -3.855851e-02 1.064147e-02 1.000000e-01 + vertex -3.804226e-02 1.236068e-02 1.000000e-01 + vertex -3.804226e-02 1.236068e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex -3.855851e-02 1.064147e-02 1.000000e-01 + vertex -3.804226e-02 1.236068e-02 8.000000e-02 + vertex -3.855851e-02 1.064147e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex -3.899712e-02 8.900837e-03 1.000000e-01 + vertex -3.855851e-02 1.064147e-02 1.000000e-01 + vertex -3.855851e-02 1.064147e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex -3.899712e-02 8.900837e-03 1.000000e-01 + vertex -3.855851e-02 1.064147e-02 8.000000e-02 + vertex -3.899712e-02 8.900837e-03 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex -3.935718e-02 7.142276e-03 1.000000e-01 + vertex -3.899712e-02 8.900837e-03 1.000000e-01 + vertex -3.899712e-02 8.900837e-03 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex -3.935718e-02 7.142276e-03 1.000000e-01 + vertex -3.899712e-02 8.900837e-03 8.000000e-02 + vertex -3.935718e-02 7.142276e-03 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex -3.963799e-02 5.369331e-03 1.000000e-01 + vertex -3.935718e-02 7.142276e-03 1.000000e-01 + vertex -3.935718e-02 7.142276e-03 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex -3.963799e-02 5.369331e-03 1.000000e-01 + vertex -3.935718e-02 7.142276e-03 8.000000e-02 + vertex -3.963799e-02 5.369331e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex -3.983897e-02 3.585572e-03 1.000000e-01 + vertex -3.963799e-02 5.369331e-03 1.000000e-01 + vertex -3.963799e-02 5.369331e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex -3.983897e-02 3.585572e-03 1.000000e-01 + vertex -3.963799e-02 5.369331e-03 8.000000e-02 + vertex -3.983897e-02 3.585572e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex -3.995972e-02 1.794593e-03 1.000000e-01 + vertex -3.983897e-02 3.585572e-03 1.000000e-01 + vertex -3.983897e-02 3.585572e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex -3.995972e-02 1.794593e-03 1.000000e-01 + vertex -3.983897e-02 3.585572e-03 8.000000e-02 + vertex -3.995972e-02 1.794593e-03 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex -4.000000e-02 4.898587e-18 1.000000e-01 + vertex -3.995972e-02 1.794593e-03 1.000000e-01 + vertex -3.995972e-02 1.794593e-03 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex -4.000000e-02 4.898587e-18 1.000000e-01 + vertex -3.995972e-02 1.794593e-03 8.000000e-02 + vertex -4.000000e-02 4.898587e-18 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 -2.243806e-02 -0.000000e+00 + outer loop + vertex -3.995972e-02 -1.794593e-03 1.000000e-01 + vertex -4.000000e-02 4.898587e-18 1.000000e-01 + vertex -4.000000e-02 4.898587e-18 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex -3.995972e-02 -1.794593e-03 1.000000e-01 + vertex -4.000000e-02 4.898587e-18 8.000000e-02 + vertex -3.995972e-02 -1.794593e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex -3.983897e-02 -3.585572e-03 1.000000e-01 + vertex -3.995972e-02 -1.794593e-03 8.000000e-02 + vertex -3.983897e-02 -3.585572e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 -6.726901e-02 -0.000000e+00 + outer loop + vertex -3.983897e-02 -3.585572e-03 1.000000e-01 + vertex -3.995972e-02 -1.794593e-03 1.000000e-01 + vertex -3.995972e-02 -1.794593e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex -3.963799e-02 -5.369331e-03 1.000000e-01 + vertex -3.983897e-02 -3.585572e-03 8.000000e-02 + vertex -3.963799e-02 -5.369331e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 -1.119645e-01 -0.000000e+00 + outer loop + vertex -3.963799e-02 -5.369331e-03 1.000000e-01 + vertex -3.983897e-02 -3.585572e-03 1.000000e-01 + vertex -3.983897e-02 -3.585572e-03 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 -1.564345e-01 -0.000000e+00 + outer loop + vertex -3.935718e-02 -7.142276e-03 1.000000e-01 + vertex -3.963799e-02 -5.369331e-03 1.000000e-01 + vertex -3.963799e-02 -5.369331e-03 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex -3.935718e-02 -7.142276e-03 1.000000e-01 + vertex -3.963799e-02 -5.369331e-03 8.000000e-02 + vertex -3.935718e-02 -7.142276e-03 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex -3.899712e-02 -8.900837e-03 1.000000e-01 + vertex -3.935718e-02 -7.142276e-03 8.000000e-02 + vertex -3.899712e-02 -8.900837e-03 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 -2.005894e-01 -0.000000e+00 + outer loop + vertex -3.899712e-02 -8.900837e-03 1.000000e-01 + vertex -3.935718e-02 -7.142276e-03 1.000000e-01 + vertex -3.935718e-02 -7.142276e-03 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex -3.855851e-02 -1.064147e-02 1.000000e-01 + vertex -3.899712e-02 -8.900837e-03 8.000000e-02 + vertex -3.855851e-02 -1.064147e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 -2.443404e-01 -0.000000e+00 + outer loop + vertex -3.855851e-02 -1.064147e-02 1.000000e-01 + vertex -3.899712e-02 -8.900837e-03 1.000000e-01 + vertex -3.899712e-02 -8.900837e-03 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex -3.804226e-02 -1.236068e-02 1.000000e-01 + vertex -3.855851e-02 -1.064147e-02 8.000000e-02 + vertex -3.804226e-02 -1.236068e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 -2.875993e-01 -0.000000e+00 + outer loop + vertex -3.804226e-02 -1.236068e-02 1.000000e-01 + vertex -3.855851e-02 -1.064147e-02 1.000000e-01 + vertex -3.855851e-02 -1.064147e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex -3.744939e-02 -1.405499e-02 1.000000e-01 + vertex -3.804226e-02 -1.236068e-02 8.000000e-02 + vertex -3.744939e-02 -1.405499e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 -3.302791e-01 -0.000000e+00 + outer loop + vertex -3.744939e-02 -1.405499e-02 1.000000e-01 + vertex -3.804226e-02 -1.236068e-02 1.000000e-01 + vertex -3.804226e-02 -1.236068e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex -3.678111e-02 -1.572100e-02 1.000000e-01 + vertex -3.744939e-02 -1.405499e-02 8.000000e-02 + vertex -3.678111e-02 -1.572100e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 -3.722937e-01 -0.000000e+00 + outer loop + vertex -3.678111e-02 -1.572100e-02 1.000000e-01 + vertex -3.744939e-02 -1.405499e-02 1.000000e-01 + vertex -3.744939e-02 -1.405499e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 -4.135585e-01 -0.000000e+00 + outer loop + vertex -3.603875e-02 -1.735535e-02 1.000000e-01 + vertex -3.678111e-02 -1.572100e-02 1.000000e-01 + vertex -3.678111e-02 -1.572100e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex -3.603875e-02 -1.735535e-02 1.000000e-01 + vertex -3.678111e-02 -1.572100e-02 8.000000e-02 + vertex -3.603875e-02 -1.735535e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 -4.539905e-01 -0.000000e+00 + outer loop + vertex -3.522382e-02 -1.895475e-02 1.000000e-01 + vertex -3.603875e-02 -1.735535e-02 1.000000e-01 + vertex -3.603875e-02 -1.735535e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex -3.522382e-02 -1.895475e-02 1.000000e-01 + vertex -3.603875e-02 -1.735535e-02 8.000000e-02 + vertex -3.522382e-02 -1.895475e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 -4.935082e-01 -0.000000e+00 + outer loop + vertex -3.433795e-02 -2.051597e-02 1.000000e-01 + vertex -3.522382e-02 -1.895475e-02 1.000000e-01 + vertex -3.522382e-02 -1.895475e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex -3.433795e-02 -2.051597e-02 1.000000e-01 + vertex -3.522382e-02 -1.895475e-02 8.000000e-02 + vertex -3.433795e-02 -2.051597e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 -5.320321e-01 -0.000000e+00 + outer loop + vertex -3.338293e-02 -2.203588e-02 1.000000e-01 + vertex -3.433795e-02 -2.051597e-02 1.000000e-01 + vertex -3.433795e-02 -2.051597e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex -3.338293e-02 -2.203588e-02 1.000000e-01 + vertex -3.433795e-02 -2.051597e-02 8.000000e-02 + vertex -3.338293e-02 -2.203588e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 -5.694845e-01 -0.000000e+00 + outer loop + vertex -3.236068e-02 -2.351141e-02 1.000000e-01 + vertex -3.338293e-02 -2.203588e-02 1.000000e-01 + vertex -3.338293e-02 -2.203588e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex -3.236068e-02 -2.351141e-02 1.000000e-01 + vertex -3.338293e-02 -2.203588e-02 8.000000e-02 + vertex -3.236068e-02 -2.351141e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 -6.057900e-01 -0.000000e+00 + outer loop + vertex -3.127326e-02 -2.493959e-02 1.000000e-01 + vertex -3.236068e-02 -2.351141e-02 1.000000e-01 + vertex -3.236068e-02 -2.351141e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex -3.127326e-02 -2.493959e-02 1.000000e-01 + vertex -3.236068e-02 -2.351141e-02 8.000000e-02 + vertex -3.127326e-02 -2.493959e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 -6.408756e-01 -0.000000e+00 + outer loop + vertex -3.012286e-02 -2.631755e-02 1.000000e-01 + vertex -3.127326e-02 -2.493959e-02 1.000000e-01 + vertex -3.127326e-02 -2.493959e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex -3.012286e-02 -2.631755e-02 1.000000e-01 + vertex -3.127326e-02 -2.493959e-02 8.000000e-02 + vertex -3.012286e-02 -2.631755e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 -6.746705e-01 -0.000000e+00 + outer loop + vertex -2.891179e-02 -2.764251e-02 1.000000e-01 + vertex -3.012286e-02 -2.631755e-02 1.000000e-01 + vertex -3.012286e-02 -2.631755e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex -2.891179e-02 -2.764251e-02 1.000000e-01 + vertex -3.012286e-02 -2.631755e-02 8.000000e-02 + vertex -2.891179e-02 -2.764251e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 -7.071068e-01 -0.000000e+00 + outer loop + vertex -2.764251e-02 -2.891179e-02 1.000000e-01 + vertex -2.891179e-02 -2.764251e-02 1.000000e-01 + vertex -2.891179e-02 -2.764251e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex -2.764251e-02 -2.891179e-02 1.000000e-01 + vertex -2.891179e-02 -2.764251e-02 8.000000e-02 + vertex -2.764251e-02 -2.891179e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 -7.381190e-01 -0.000000e+00 + outer loop + vertex -2.631755e-02 -3.012286e-02 1.000000e-01 + vertex -2.764251e-02 -2.891179e-02 1.000000e-01 + vertex -2.764251e-02 -2.891179e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex -2.631755e-02 -3.012286e-02 1.000000e-01 + vertex -2.764251e-02 -2.891179e-02 8.000000e-02 + vertex -2.631755e-02 -3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 -7.676447e-01 -0.000000e+00 + outer loop + vertex -2.493959e-02 -3.127326e-02 1.000000e-01 + vertex -2.631755e-02 -3.012286e-02 1.000000e-01 + vertex -2.631755e-02 -3.012286e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex -2.493959e-02 -3.127326e-02 1.000000e-01 + vertex -2.631755e-02 -3.012286e-02 8.000000e-02 + vertex -2.493959e-02 -3.127326e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.191998e-03 -1.974364e-02 1.000000e-01 + vertex -7.142276e-03 -3.935718e-02 1.000000e-01 + vertex -5.369331e-03 -3.963799e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.191998e-03 -1.974364e-02 1.000000e-01 + vertex -4.450419e-03 -1.949856e-02 1.000000e-01 + vertex -7.142276e-03 -3.935718e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.744939e-02 -1.405499e-02 1.000000e-01 + vertex 1.898111e-02 -6.302164e-03 1.000000e-01 + vertex 1.853834e-02 -7.505340e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.744939e-02 -1.405499e-02 1.000000e-01 + vertex 1.853834e-02 -7.505340e-03 1.000000e-01 + vertex 3.678111e-02 -1.572100e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.983580e-02 -2.557543e-03 1.000000e-01 + vertex -3.983897e-02 -3.585572e-03 1.000000e-01 + vertex -3.963799e-02 -5.369331e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.983580e-02 -2.557543e-03 1.000000e-01 + vertex -3.935718e-02 -7.142276e-03 1.000000e-01 + vertex -1.963118e-02 -3.823173e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.983580e-02 -2.557543e-03 1.000000e-01 + vertex -3.963799e-02 -5.369331e-03 1.000000e-01 + vertex -3.935718e-02 -7.142276e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.405499e-02 3.744939e-02 1.000000e-01 + vertex -1.572100e-02 3.678111e-02 1.000000e-01 + vertex -6.907301e-03 1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.920461e-03 -1.990758e-02 1.000000e-01 + vertex -5.369331e-03 -3.963799e-02 1.000000e-01 + vertex -3.585572e-03 -3.983897e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.920461e-03 -1.990758e-02 1.000000e-01 + vertex -3.585572e-03 -3.983897e-02 1.000000e-01 + vertex -1.794593e-03 -3.995972e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.127326e-02 -2.493959e-02 1.000000e-01 + vertex 1.602827e-02 -1.196221e-02 1.000000e-01 + vertex 1.522892e-02 -1.296457e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.920461e-03 -1.990758e-02 1.000000e-01 + vertex -3.191998e-03 -1.974364e-02 1.000000e-01 + vertex -5.369331e-03 -3.963799e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.127326e-02 -2.493959e-02 1.000000e-01 + vertex 1.522892e-02 -1.296457e-02 1.000000e-01 + vertex 3.012286e-02 -2.631755e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.995891e-02 -1.281404e-03 1.000000e-01 + vertex -3.983897e-02 -3.585572e-03 1.000000e-01 + vertex -1.983580e-02 -2.557543e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.493959e-02 3.127326e-02 1.000000e-01 + vertex -2.631755e-02 3.012286e-02 1.000000e-01 + vertex -1.246980e-02 1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.995891e-02 -1.281404e-03 1.000000e-01 + vertex -3.995972e-02 -1.794593e-03 1.000000e-01 + vertex -3.983897e-02 -3.585572e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.410316e-04 -1.998972e-02 1.000000e-01 + vertex -1.794593e-03 -3.995972e-02 1.000000e-01 + vertex -7.347881e-18 -4.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.410316e-04 -1.998972e-02 1.000000e-01 + vertex -1.920461e-03 -1.990758e-02 1.000000e-01 + vertex -1.794593e-03 -3.995972e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.000000e-02 2.021286e-17 1.000000e-01 + vertex -3.995972e-02 1.794593e-03 1.000000e-01 + vertex -4.000000e-02 4.898587e-18 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.000000e-02 2.021286e-17 1.000000e-01 + vertex -4.000000e-02 4.898587e-18 1.000000e-01 + vertex -3.995972e-02 -1.794593e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.000000e-02 2.021286e-17 1.000000e-01 + vertex -3.995972e-02 -1.794593e-03 1.000000e-01 + vertex -1.995891e-02 -1.281404e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.410316e-04 -1.998972e-02 1.000000e-01 + vertex -7.347881e-18 -4.000000e-02 1.000000e-01 + vertex 1.794593e-03 -3.995972e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.236068e-02 -2.351141e-02 1.000000e-01 + vertex 1.676176e-02 -1.091070e-02 1.000000e-01 + vertex 1.602827e-02 -1.196221e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.410316e-04 -1.998972e-02 1.000000e-01 + vertex -6.410316e-04 -1.998972e-02 1.000000e-01 + vertex -7.347881e-18 -4.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.236068e-02 -2.351141e-02 1.000000e-01 + vertex 1.602827e-02 -1.196221e-02 1.000000e-01 + vertex 3.127326e-02 -2.493959e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.899712e-02 -8.900837e-03 1.000000e-01 + vertex 1.963118e-02 -3.823173e-03 1.000000e-01 + vertex 1.934590e-02 -5.073092e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.351141e-02 3.236068e-02 1.000000e-01 + vertex -2.493959e-02 3.127326e-02 1.000000e-01 + vertex -1.246980e-02 1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.351141e-02 3.236068e-02 1.000000e-01 + vertex -1.246980e-02 1.563663e-02 1.000000e-01 + vertex -1.144233e-02 1.640345e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.995891e-02 1.281404e-03 1.000000e-01 + vertex -3.983897e-02 3.585572e-03 1.000000e-01 + vertex -3.995972e-02 1.794593e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.899712e-02 -8.900837e-03 1.000000e-01 + vertex 1.934590e-02 -5.073092e-03 1.000000e-01 + vertex 3.855851e-02 -1.064147e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.995891e-02 1.281404e-03 1.000000e-01 + vertex -3.995972e-02 1.794593e-03 1.000000e-01 + vertex -2.000000e-02 2.021286e-17 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -8.900837e-03 3.899712e-02 1.000000e-01 + vertex -1.064147e-02 3.855851e-02 1.000000e-01 + vertex -4.450419e-03 1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.935718e-02 -7.142276e-03 1.000000e-01 + vertex 1.963118e-02 -3.823173e-03 1.000000e-01 + vertex 3.899712e-02 -8.900837e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.935718e-02 -7.142276e-03 1.000000e-01 + vertex 1.983580e-02 -2.557543e-03 1.000000e-01 + vertex 1.963118e-02 -3.823173e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.920461e-03 -1.990758e-02 1.000000e-01 + vertex 1.794593e-03 -3.995972e-02 1.000000e-01 + vertex 3.585572e-03 -3.983897e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.920461e-03 -1.990758e-02 1.000000e-01 + vertex 3.585572e-03 -3.983897e-02 1.000000e-01 + vertex 5.369331e-03 -3.963799e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.920461e-03 -1.990758e-02 1.000000e-01 + vertex 6.410316e-04 -1.998972e-02 1.000000e-01 + vertex 1.794593e-03 -3.995972e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.983580e-02 2.557543e-03 1.000000e-01 + vertex -3.935718e-02 7.142276e-03 1.000000e-01 + vertex -3.963799e-02 5.369331e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.983580e-02 2.557543e-03 1.000000e-01 + vertex -3.963799e-02 5.369331e-03 1.000000e-01 + vertex -3.983897e-02 3.585572e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.142276e-03 3.935718e-02 1.000000e-01 + vertex -4.450419e-03 1.949856e-02 1.000000e-01 + vertex -3.191998e-03 1.974364e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.142276e-03 3.935718e-02 1.000000e-01 + vertex -8.900837e-03 3.899712e-02 1.000000e-01 + vertex -4.450419e-03 1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.963799e-02 -5.369331e-03 1.000000e-01 + vertex 1.983580e-02 -2.557543e-03 1.000000e-01 + vertex 3.935718e-02 -7.142276e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.983580e-02 2.557543e-03 1.000000e-01 + vertex -3.983897e-02 3.585572e-03 1.000000e-01 + vertex -1.995891e-02 1.281404e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.369331e-03 3.963799e-02 1.000000e-01 + vertex -7.142276e-03 3.935718e-02 1.000000e-01 + vertex -3.191998e-03 1.974364e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.191998e-03 -1.974364e-02 1.000000e-01 + vertex 5.369331e-03 -3.963799e-02 1.000000e-01 + vertex 7.142276e-03 -3.935718e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.369331e-03 3.963799e-02 1.000000e-01 + vertex -3.191998e-03 1.974364e-02 1.000000e-01 + vertex -1.920461e-03 1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.338293e-02 -2.203588e-02 1.000000e-01 + vertex 1.676176e-02 -1.091070e-02 1.000000e-01 + vertex 3.236068e-02 -2.351141e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.983897e-02 -3.585572e-03 1.000000e-01 + vertex 1.983580e-02 -2.557543e-03 1.000000e-01 + vertex 3.963799e-02 -5.369331e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.191998e-03 -1.974364e-02 1.000000e-01 + vertex 1.920461e-03 -1.990758e-02 1.000000e-01 + vertex 5.369331e-03 -3.963799e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.983897e-02 -3.585572e-03 1.000000e-01 + vertex 1.995891e-02 -1.281404e-03 1.000000e-01 + vertex 1.983580e-02 -2.557543e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.203588e-02 3.338293e-02 1.000000e-01 + vertex -2.351141e-02 3.236068e-02 1.000000e-01 + vertex -1.144233e-02 1.640345e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.203588e-02 3.338293e-02 1.000000e-01 + vertex -1.144233e-02 1.640345e-02 1.000000e-01 + vertex -1.036785e-02 1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.963118e-02 3.823173e-03 1.000000e-01 + vertex -3.935718e-02 7.142276e-03 1.000000e-01 + vertex -1.983580e-02 2.557543e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.585572e-03 3.983897e-02 1.000000e-01 + vertex -5.369331e-03 3.963799e-02 1.000000e-01 + vertex -1.920461e-03 1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.963118e-02 3.823173e-03 1.000000e-01 + vertex -3.899712e-02 8.900837e-03 1.000000e-01 + vertex -3.935718e-02 7.142276e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.995972e-02 -1.794593e-03 1.000000e-01 + vertex 1.995891e-02 -1.281404e-03 1.000000e-01 + vertex 3.983897e-02 -3.585572e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.995972e-02 -1.794593e-03 1.000000e-01 + vertex 2.000000e-02 0.000000e+00 1.000000e-01 + vertex 1.995891e-02 -1.281404e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.804226e-02 -1.236068e-02 1.000000e-01 + vertex 1.898111e-02 -6.302164e-03 1.000000e-01 + vertex 3.744939e-02 -1.405499e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.236068e-02 3.804226e-02 1.000000e-01 + vertex -1.405499e-02 3.744939e-02 1.000000e-01 + vertex -6.907301e-03 1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.450419e-03 -1.949856e-02 1.000000e-01 + vertex 7.142276e-03 -3.935718e-02 1.000000e-01 + vertex 8.900837e-03 -3.899712e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.450419e-03 -1.949856e-02 1.000000e-01 + vertex 8.900837e-03 -3.899712e-02 1.000000e-01 + vertex 1.064147e-02 -3.855851e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.236068e-02 3.804226e-02 1.000000e-01 + vertex -6.907301e-03 1.876937e-02 1.000000e-01 + vertex -5.690552e-03 1.917336e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.450419e-03 -1.949856e-02 1.000000e-01 + vertex 3.191998e-03 -1.974364e-02 1.000000e-01 + vertex 7.142276e-03 -3.935718e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.794593e-03 3.995972e-02 1.000000e-01 + vertex -3.585572e-03 3.983897e-02 1.000000e-01 + vertex -1.920461e-03 1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.794593e-03 3.995972e-02 1.000000e-01 + vertex -1.920461e-03 1.990758e-02 1.000000e-01 + vertex -6.410316e-04 1.998972e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.934590e-02 5.073092e-03 1.000000e-01 + vertex -3.855851e-02 1.064147e-02 1.000000e-01 + vertex -3.899712e-02 8.900837e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.934590e-02 5.073092e-03 1.000000e-01 + vertex -3.899712e-02 8.900837e-03 1.000000e-01 + vertex -1.963118e-02 3.823173e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.449294e-18 4.000000e-02 1.000000e-01 + vertex -1.794593e-03 3.995972e-02 1.000000e-01 + vertex -6.410316e-04 1.998972e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.449294e-18 4.000000e-02 1.000000e-01 + vertex -6.410316e-04 1.998972e-02 1.000000e-01 + vertex 6.410316e-04 1.998972e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.000000e-02 0.000000e+00 1.000000e-01 + vertex 2.000000e-02 0.000000e+00 1.000000e-01 + vertex 3.995972e-02 -1.794593e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.690552e-03 -1.917336e-02 1.000000e-01 + vertex 1.064147e-02 -3.855851e-02 1.000000e-01 + vertex 1.236068e-02 -3.804226e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.995972e-02 1.794593e-03 1.000000e-01 + vertex 1.995891e-02 1.281404e-03 1.000000e-01 + vertex 2.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.690552e-03 -1.917336e-02 1.000000e-01 + vertex 4.450419e-03 -1.949856e-02 1.000000e-01 + vertex 1.064147e-02 -3.855851e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.433795e-02 -2.051597e-02 1.000000e-01 + vertex 1.676176e-02 -1.091070e-02 1.000000e-01 + vertex 3.338293e-02 -2.203588e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.433795e-02 -2.051597e-02 1.000000e-01 + vertex 1.742637e-02 -9.814351e-03 1.000000e-01 + vertex 1.676176e-02 -1.091070e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.995972e-02 1.794593e-03 1.000000e-01 + vertex 2.000000e-02 0.000000e+00 1.000000e-01 + vertex 4.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.898111e-02 6.302164e-03 1.000000e-01 + vertex -3.855851e-02 1.064147e-02 1.000000e-01 + vertex -1.934590e-02 5.073092e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.794593e-03 3.995972e-02 1.000000e-01 + vertex 2.449294e-18 4.000000e-02 1.000000e-01 + vertex 6.410316e-04 1.998972e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.051597e-02 3.433795e-02 1.000000e-01 + vertex -2.203588e-02 3.338293e-02 1.000000e-01 + vertex -1.036785e-02 1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.898111e-02 6.302164e-03 1.000000e-01 + vertex -3.744939e-02 1.405499e-02 1.000000e-01 + vertex -3.804226e-02 1.236068e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.898111e-02 6.302164e-03 1.000000e-01 + vertex -3.804226e-02 1.236068e-02 1.000000e-01 + vertex -3.855851e-02 1.064147e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.794593e-03 3.995972e-02 1.000000e-01 + vertex 6.410316e-04 1.998972e-02 1.000000e-01 + vertex 1.920461e-03 1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.983897e-02 3.585572e-03 1.000000e-01 + vertex 1.983580e-02 2.557543e-03 1.000000e-01 + vertex 1.995891e-02 1.281404e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.983897e-02 3.585572e-03 1.000000e-01 + vertex 1.995891e-02 1.281404e-03 1.000000e-01 + vertex 3.995972e-02 1.794593e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.585572e-03 3.983897e-02 1.000000e-01 + vertex 1.794593e-03 3.995972e-02 1.000000e-01 + vertex 1.920461e-03 1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.907301e-03 -1.876937e-02 1.000000e-01 + vertex 5.690552e-03 -1.917336e-02 1.000000e-01 + vertex 1.236068e-02 -3.804226e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.907301e-03 -1.876937e-02 1.000000e-01 + vertex 1.236068e-02 -3.804226e-02 1.000000e-01 + vertex 1.405499e-02 -3.744939e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.907301e-03 -1.876937e-02 1.000000e-01 + vertex 1.405499e-02 -3.744939e-02 1.000000e-01 + vertex 1.572100e-02 -3.678111e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.369331e-03 3.963799e-02 1.000000e-01 + vertex 3.585572e-03 3.983897e-02 1.000000e-01 + vertex 1.920461e-03 1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.853834e-02 7.505340e-03 1.000000e-01 + vertex -3.744939e-02 1.405499e-02 1.000000e-01 + vertex -1.898111e-02 6.302164e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.369331e-03 3.963799e-02 1.000000e-01 + vertex 1.920461e-03 1.990758e-02 1.000000e-01 + vertex 3.191998e-03 1.974364e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.853834e-02 7.505340e-03 1.000000e-01 + vertex -3.678111e-02 1.572100e-02 1.000000e-01 + vertex -3.744939e-02 1.405499e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.963799e-02 5.369331e-03 1.000000e-01 + vertex 1.983580e-02 2.557543e-03 1.000000e-01 + vertex 3.983897e-02 3.585572e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.935718e-02 7.142276e-03 1.000000e-01 + vertex 1.983580e-02 2.557543e-03 1.000000e-01 + vertex 3.963799e-02 5.369331e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.935718e-02 7.142276e-03 1.000000e-01 + vertex 1.963118e-02 3.823173e-03 1.000000e-01 + vertex 1.983580e-02 2.557543e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.436699e-02 -1.391365e-02 1.000000e-01 + vertex -3.012286e-02 -2.631755e-02 1.000000e-01 + vertex -2.891179e-02 -2.764251e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.436699e-02 -1.391365e-02 1.000000e-01 + vertex -2.891179e-02 -2.764251e-02 1.000000e-01 + vertex -2.764251e-02 -2.891179e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.142276e-03 3.935718e-02 1.000000e-01 + vertex 5.369331e-03 3.963799e-02 1.000000e-01 + vertex 3.191998e-03 1.974364e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.095667e-03 -1.828825e-02 1.000000e-01 + vertex 1.572100e-02 -3.678111e-02 1.000000e-01 + vertex 1.735535e-02 -3.603875e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.142276e-03 3.935718e-02 1.000000e-01 + vertex 3.191998e-03 1.974364e-02 1.000000e-01 + vertex 4.450419e-03 1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.899712e-02 8.900837e-03 1.000000e-01 + vertex 1.963118e-02 3.823173e-03 1.000000e-01 + vertex 3.935718e-02 7.142276e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.095667e-03 -1.828825e-02 1.000000e-01 + vertex 6.907301e-03 -1.876937e-02 1.000000e-01 + vertex 1.572100e-02 -3.678111e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.899712e-02 8.900837e-03 1.000000e-01 + vertex 1.934590e-02 5.073092e-03 1.000000e-01 + vertex 1.963118e-02 3.823173e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.801938e-02 8.677675e-03 1.000000e-01 + vertex -3.678111e-02 1.572100e-02 1.000000e-01 + vertex -1.853834e-02 7.505340e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.344602e-02 -1.480556e-02 1.000000e-01 + vertex -1.436699e-02 -1.391365e-02 1.000000e-01 + vertex -2.764251e-02 -2.891179e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.344602e-02 -1.480556e-02 1.000000e-01 + vertex -2.764251e-02 -2.891179e-02 1.000000e-01 + vertex -2.631755e-02 -3.012286e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.801938e-02 8.677675e-03 1.000000e-01 + vertex -3.522382e-02 1.895475e-02 1.000000e-01 + vertex -3.603875e-02 1.735535e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.801938e-02 8.677675e-03 1.000000e-01 + vertex -3.603875e-02 1.735535e-02 1.000000e-01 + vertex -3.678111e-02 1.572100e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.522382e-02 -1.895475e-02 1.000000e-01 + vertex 1.742637e-02 -9.814351e-03 1.000000e-01 + vertex 3.433795e-02 -2.051597e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.522382e-02 -1.895475e-02 1.000000e-01 + vertex 1.801938e-02 -8.677675e-03 1.000000e-01 + vertex 1.742637e-02 -9.814351e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.895475e-02 3.522382e-02 1.000000e-01 + vertex -2.051597e-02 3.433795e-02 1.000000e-01 + vertex -1.036785e-02 1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.900837e-03 3.899712e-02 1.000000e-01 + vertex 7.142276e-03 3.935718e-02 1.000000e-01 + vertex 4.450419e-03 1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.895475e-02 3.522382e-02 1.000000e-01 + vertex -1.036785e-02 1.710286e-02 1.000000e-01 + vertex -9.250766e-03 1.773199e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.522892e-02 -1.296457e-02 1.000000e-01 + vertex -3.012286e-02 -2.631755e-02 1.000000e-01 + vertex -1.436699e-02 -1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.064147e-02 3.855851e-02 1.000000e-01 + vertex 4.450419e-03 1.949856e-02 1.000000e-01 + vertex 5.690552e-03 1.917336e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.064147e-02 3.855851e-02 1.000000e-01 + vertex 8.900837e-03 3.899712e-02 1.000000e-01 + vertex 4.450419e-03 1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.522892e-02 -1.296457e-02 1.000000e-01 + vertex -3.127326e-02 -2.493959e-02 1.000000e-01 + vertex -3.012286e-02 -2.631755e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.855851e-02 1.064147e-02 1.000000e-01 + vertex 1.898111e-02 6.302164e-03 1.000000e-01 + vertex 1.934590e-02 5.073092e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.250766e-03 -1.773199e-02 1.000000e-01 + vertex 1.735535e-02 -3.603875e-02 1.000000e-01 + vertex 1.895475e-02 -3.522382e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.855851e-02 1.064147e-02 1.000000e-01 + vertex 1.934590e-02 5.073092e-03 1.000000e-01 + vertex 3.899712e-02 8.900837e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.246980e-02 -1.563663e-02 1.000000e-01 + vertex -1.344602e-02 -1.480556e-02 1.000000e-01 + vertex -2.631755e-02 -3.012286e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.246980e-02 -1.563663e-02 1.000000e-01 + vertex -2.631755e-02 -3.012286e-02 1.000000e-01 + vertex -2.493959e-02 -3.127326e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.246980e-02 -1.563663e-02 1.000000e-01 + vertex -2.493959e-02 -3.127326e-02 1.000000e-01 + vertex -2.351141e-02 -3.236068e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.250766e-03 -1.773199e-02 1.000000e-01 + vertex 8.095667e-03 -1.828825e-02 1.000000e-01 + vertex 1.735535e-02 -3.603875e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.236068e-02 3.804226e-02 1.000000e-01 + vertex 5.690552e-03 1.917336e-02 1.000000e-01 + vertex 6.907301e-03 1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.236068e-02 3.804226e-02 1.000000e-01 + vertex 1.064147e-02 3.855851e-02 1.000000e-01 + vertex 5.690552e-03 1.917336e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.742637e-02 9.814351e-03 1.000000e-01 + vertex -3.433795e-02 2.051597e-02 1.000000e-01 + vertex -3.522382e-02 1.895475e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.602827e-02 -1.196221e-02 1.000000e-01 + vertex -3.127326e-02 -2.493959e-02 1.000000e-01 + vertex -1.522892e-02 -1.296457e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.742637e-02 9.814351e-03 1.000000e-01 + vertex -3.522382e-02 1.895475e-02 1.000000e-01 + vertex -1.801938e-02 8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.804226e-02 1.236068e-02 1.000000e-01 + vertex 1.898111e-02 6.302164e-03 1.000000e-01 + vertex 3.855851e-02 1.064147e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.405499e-02 3.744939e-02 1.000000e-01 + vertex 1.236068e-02 3.804226e-02 1.000000e-01 + vertex 6.907301e-03 1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.744939e-02 1.405499e-02 1.000000e-01 + vertex 1.853834e-02 7.505340e-03 1.000000e-01 + vertex 1.898111e-02 6.302164e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.602827e-02 -1.196221e-02 1.000000e-01 + vertex -3.236068e-02 -2.351141e-02 1.000000e-01 + vertex -3.127326e-02 -2.493959e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.744939e-02 1.405499e-02 1.000000e-01 + vertex 1.898111e-02 6.302164e-03 1.000000e-01 + vertex 3.804226e-02 1.236068e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.572100e-02 3.678111e-02 1.000000e-01 + vertex 1.405499e-02 3.744939e-02 1.000000e-01 + vertex 6.907301e-03 1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.036785e-02 -1.710286e-02 1.000000e-01 + vertex 1.895475e-02 -3.522382e-02 1.000000e-01 + vertex 2.051597e-02 -3.433795e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.572100e-02 3.678111e-02 1.000000e-01 + vertex 6.907301e-03 1.876937e-02 1.000000e-01 + vertex 8.095667e-03 1.828825e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.036785e-02 -1.710286e-02 1.000000e-01 + vertex 2.051597e-02 -3.433795e-02 1.000000e-01 + vertex 2.203588e-02 -3.338293e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.678111e-02 1.572100e-02 1.000000e-01 + vertex 1.801938e-02 8.677675e-03 1.000000e-01 + vertex 1.853834e-02 7.505340e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.036785e-02 -1.710286e-02 1.000000e-01 + vertex 9.250766e-03 -1.773199e-02 1.000000e-01 + vertex 1.895475e-02 -3.522382e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.144233e-02 -1.640345e-02 1.000000e-01 + vertex -1.246980e-02 -1.563663e-02 1.000000e-01 + vertex -2.351141e-02 -3.236068e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.144233e-02 -1.640345e-02 1.000000e-01 + vertex -2.351141e-02 -3.236068e-02 1.000000e-01 + vertex -2.203588e-02 -3.338293e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.678111e-02 1.572100e-02 1.000000e-01 + vertex 1.853834e-02 7.505340e-03 1.000000e-01 + vertex 3.744939e-02 1.405499e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.735535e-02 3.603875e-02 1.000000e-01 + vertex 1.572100e-02 3.678111e-02 1.000000e-01 + vertex 8.095667e-03 1.828825e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.735535e-02 3.603875e-02 1.000000e-01 + vertex 8.095667e-03 1.828825e-02 1.000000e-01 + vertex 9.250766e-03 1.773199e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.676176e-02 1.091070e-02 1.000000e-01 + vertex -3.236068e-02 2.351141e-02 1.000000e-01 + vertex -3.338293e-02 2.203588e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.676176e-02 1.091070e-02 1.000000e-01 + vertex -3.338293e-02 2.203588e-02 1.000000e-01 + vertex -3.433795e-02 2.051597e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.676176e-02 1.091070e-02 1.000000e-01 + vertex -3.433795e-02 2.051597e-02 1.000000e-01 + vertex -1.742637e-02 9.814351e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.676176e-02 -1.091070e-02 1.000000e-01 + vertex -3.236068e-02 -2.351141e-02 1.000000e-01 + vertex -1.602827e-02 -1.196221e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.603875e-02 1.735535e-02 1.000000e-01 + vertex 1.801938e-02 8.677675e-03 1.000000e-01 + vertex 3.678111e-02 1.572100e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.895475e-02 3.522382e-02 1.000000e-01 + vertex 1.735535e-02 3.603875e-02 1.000000e-01 + vertex 9.250766e-03 1.773199e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.895475e-02 3.522382e-02 1.000000e-01 + vertex 9.250766e-03 1.773199e-02 1.000000e-01 + vertex 1.036785e-02 1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.522382e-02 1.895475e-02 1.000000e-01 + vertex 1.742637e-02 9.814351e-03 1.000000e-01 + vertex 1.801938e-02 8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.676176e-02 -1.091070e-02 1.000000e-01 + vertex -3.433795e-02 -2.051597e-02 1.000000e-01 + vertex -3.338293e-02 -2.203588e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.676176e-02 -1.091070e-02 1.000000e-01 + vertex -3.338293e-02 -2.203588e-02 1.000000e-01 + vertex -3.236068e-02 -2.351141e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.522382e-02 1.895475e-02 1.000000e-01 + vertex 1.801938e-02 8.677675e-03 1.000000e-01 + vertex 3.603875e-02 1.735535e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.433795e-02 2.051597e-02 1.000000e-01 + vertex 1.676176e-02 1.091070e-02 1.000000e-01 + vertex 1.742637e-02 9.814351e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.144233e-02 -1.640345e-02 1.000000e-01 + vertex 1.036785e-02 -1.710286e-02 1.000000e-01 + vertex 2.203588e-02 -3.338293e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.433795e-02 2.051597e-02 1.000000e-01 + vertex 1.742637e-02 9.814351e-03 1.000000e-01 + vertex 3.522382e-02 1.895475e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.051597e-02 3.433795e-02 1.000000e-01 + vertex 1.895475e-02 3.522382e-02 1.000000e-01 + vertex 1.036785e-02 1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.144233e-02 -1.640345e-02 1.000000e-01 + vertex 2.203588e-02 -3.338293e-02 1.000000e-01 + vertex 2.351141e-02 -3.236068e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.036785e-02 -1.710286e-02 1.000000e-01 + vertex -1.144233e-02 -1.640345e-02 1.000000e-01 + vertex -2.203588e-02 -3.338293e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.036785e-02 -1.710286e-02 1.000000e-01 + vertex -2.203588e-02 -3.338293e-02 1.000000e-01 + vertex -2.051597e-02 -3.433795e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.036785e-02 -1.710286e-02 1.000000e-01 + vertex -2.051597e-02 -3.433795e-02 1.000000e-01 + vertex -1.895475e-02 -3.522382e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.602827e-02 1.196221e-02 1.000000e-01 + vertex -3.236068e-02 2.351141e-02 1.000000e-01 + vertex -1.676176e-02 1.091070e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.735535e-02 3.603875e-02 1.000000e-01 + vertex -1.895475e-02 3.522382e-02 1.000000e-01 + vertex -9.250766e-03 1.773199e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.338293e-02 2.203588e-02 1.000000e-01 + vertex 1.676176e-02 1.091070e-02 1.000000e-01 + vertex 3.433795e-02 2.051597e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.602827e-02 1.196221e-02 1.000000e-01 + vertex -3.127326e-02 2.493959e-02 1.000000e-01 + vertex -3.236068e-02 2.351141e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.203588e-02 3.338293e-02 1.000000e-01 + vertex 1.036785e-02 1.710286e-02 1.000000e-01 + vertex 1.144233e-02 1.640345e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.735535e-02 3.603875e-02 1.000000e-01 + vertex -9.250766e-03 1.773199e-02 1.000000e-01 + vertex -8.095667e-03 1.828825e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.742637e-02 -9.814351e-03 1.000000e-01 + vertex -3.433795e-02 -2.051597e-02 1.000000e-01 + vertex -1.676176e-02 -1.091070e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.203588e-02 3.338293e-02 1.000000e-01 + vertex 2.051597e-02 3.433795e-02 1.000000e-01 + vertex 1.036785e-02 1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.236068e-02 2.351141e-02 1.000000e-01 + vertex 1.602827e-02 1.196221e-02 1.000000e-01 + vertex 1.676176e-02 1.091070e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.603875e-02 -1.735535e-02 1.000000e-01 + vertex 1.801938e-02 -8.677675e-03 1.000000e-01 + vertex 3.522382e-02 -1.895475e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.236068e-02 2.351141e-02 1.000000e-01 + vertex 1.676176e-02 1.091070e-02 1.000000e-01 + vertex 3.338293e-02 2.203588e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.351141e-02 3.236068e-02 1.000000e-01 + vertex 1.144233e-02 1.640345e-02 1.000000e-01 + vertex 1.246980e-02 1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.351141e-02 3.236068e-02 1.000000e-01 + vertex 2.203588e-02 3.338293e-02 1.000000e-01 + vertex 1.144233e-02 1.640345e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.742637e-02 -9.814351e-03 1.000000e-01 + vertex -3.522382e-02 -1.895475e-02 1.000000e-01 + vertex -3.433795e-02 -2.051597e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.127326e-02 2.493959e-02 1.000000e-01 + vertex 1.522892e-02 1.296457e-02 1.000000e-01 + vertex 1.602827e-02 1.196221e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.127326e-02 2.493959e-02 1.000000e-01 + vertex 1.602827e-02 1.196221e-02 1.000000e-01 + vertex 3.236068e-02 2.351141e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.493959e-02 3.127326e-02 1.000000e-01 + vertex 2.351141e-02 3.236068e-02 1.000000e-01 + vertex 1.246980e-02 1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.631755e-02 3.012286e-02 1.000000e-01 + vertex 1.246980e-02 1.563663e-02 1.000000e-01 + vertex 1.344602e-02 1.480556e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.631755e-02 3.012286e-02 1.000000e-01 + vertex 2.493959e-02 3.127326e-02 1.000000e-01 + vertex 1.246980e-02 1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -9.250766e-03 -1.773199e-02 1.000000e-01 + vertex -1.036785e-02 -1.710286e-02 1.000000e-01 + vertex -1.895475e-02 -3.522382e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.012286e-02 2.631755e-02 1.000000e-01 + vertex 1.436699e-02 1.391365e-02 1.000000e-01 + vertex 1.522892e-02 1.296457e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -9.250766e-03 -1.773199e-02 1.000000e-01 + vertex -1.895475e-02 -3.522382e-02 1.000000e-01 + vertex -1.735535e-02 -3.603875e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.012286e-02 2.631755e-02 1.000000e-01 + vertex 1.522892e-02 1.296457e-02 1.000000e-01 + vertex 3.127326e-02 2.493959e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.246980e-02 -1.563663e-02 1.000000e-01 + vertex 2.351141e-02 -3.236068e-02 1.000000e-01 + vertex 2.493959e-02 -3.127326e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.764251e-02 2.891179e-02 1.000000e-01 + vertex 2.631755e-02 3.012286e-02 1.000000e-01 + vertex 1.344602e-02 1.480556e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.246980e-02 -1.563663e-02 1.000000e-01 + vertex 2.493959e-02 -3.127326e-02 1.000000e-01 + vertex 2.631755e-02 -3.012286e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.855851e-02 -1.064147e-02 1.000000e-01 + vertex 1.934590e-02 -5.073092e-03 1.000000e-01 + vertex 1.898111e-02 -6.302164e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.764251e-02 2.891179e-02 1.000000e-01 + vertex 1.344602e-02 1.480556e-02 1.000000e-01 + vertex 1.436699e-02 1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.246980e-02 -1.563663e-02 1.000000e-01 + vertex 1.144233e-02 -1.640345e-02 1.000000e-01 + vertex 2.351141e-02 -3.236068e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.891179e-02 2.764251e-02 1.000000e-01 + vertex 1.436699e-02 1.391365e-02 1.000000e-01 + vertex 3.012286e-02 2.631755e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.891179e-02 2.764251e-02 1.000000e-01 + vertex 2.764251e-02 2.891179e-02 1.000000e-01 + vertex 1.436699e-02 1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.855851e-02 -1.064147e-02 1.000000e-01 + vertex 1.898111e-02 -6.302164e-03 1.000000e-01 + vertex 3.804226e-02 -1.236068e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.522892e-02 1.296457e-02 1.000000e-01 + vertex -3.012286e-02 2.631755e-02 1.000000e-01 + vertex -3.127326e-02 2.493959e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.801938e-02 -8.677675e-03 1.000000e-01 + vertex -3.522382e-02 -1.895475e-02 1.000000e-01 + vertex -1.742637e-02 -9.814351e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.522892e-02 1.296457e-02 1.000000e-01 + vertex -3.127326e-02 2.493959e-02 1.000000e-01 + vertex -1.602827e-02 1.196221e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.801938e-02 -8.677675e-03 1.000000e-01 + vertex -3.678111e-02 -1.572100e-02 1.000000e-01 + vertex -3.603875e-02 -1.735535e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.801938e-02 -8.677675e-03 1.000000e-01 + vertex -3.603875e-02 -1.735535e-02 1.000000e-01 + vertex -3.522382e-02 -1.895475e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.064147e-02 3.855851e-02 1.000000e-01 + vertex -5.690552e-03 1.917336e-02 1.000000e-01 + vertex -4.450419e-03 1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.064147e-02 3.855851e-02 1.000000e-01 + vertex -1.236068e-02 3.804226e-02 1.000000e-01 + vertex -5.690552e-03 1.917336e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.344602e-02 -1.480556e-02 1.000000e-01 + vertex 1.246980e-02 -1.563663e-02 1.000000e-01 + vertex 2.631755e-02 -3.012286e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -8.095667e-03 -1.828825e-02 1.000000e-01 + vertex -9.250766e-03 -1.773199e-02 1.000000e-01 + vertex -1.735535e-02 -3.603875e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -8.095667e-03 -1.828825e-02 1.000000e-01 + vertex -1.735535e-02 -3.603875e-02 1.000000e-01 + vertex -1.572100e-02 -3.678111e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.764251e-02 -2.891179e-02 1.000000e-01 + vertex 1.344602e-02 -1.480556e-02 1.000000e-01 + vertex 2.631755e-02 -3.012286e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.436699e-02 1.391365e-02 1.000000e-01 + vertex -2.891179e-02 2.764251e-02 1.000000e-01 + vertex -3.012286e-02 2.631755e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.436699e-02 1.391365e-02 1.000000e-01 + vertex -3.012286e-02 2.631755e-02 1.000000e-01 + vertex -1.522892e-02 1.296457e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.853834e-02 -7.505340e-03 1.000000e-01 + vertex -3.744939e-02 -1.405499e-02 1.000000e-01 + vertex -3.678111e-02 -1.572100e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.853834e-02 -7.505340e-03 1.000000e-01 + vertex -3.678111e-02 -1.572100e-02 1.000000e-01 + vertex -1.801938e-02 -8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.678111e-02 -1.572100e-02 1.000000e-01 + vertex 1.801938e-02 -8.677675e-03 1.000000e-01 + vertex 3.603875e-02 -1.735535e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.678111e-02 -1.572100e-02 1.000000e-01 + vertex 1.853834e-02 -7.505340e-03 1.000000e-01 + vertex 1.801938e-02 -8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.572100e-02 3.678111e-02 1.000000e-01 + vertex -1.735535e-02 3.603875e-02 1.000000e-01 + vertex -8.095667e-03 1.828825e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.572100e-02 3.678111e-02 1.000000e-01 + vertex -8.095667e-03 1.828825e-02 1.000000e-01 + vertex -6.907301e-03 1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.907301e-03 -1.876937e-02 1.000000e-01 + vertex -8.095667e-03 -1.828825e-02 1.000000e-01 + vertex -1.572100e-02 -3.678111e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.907301e-03 -1.876937e-02 1.000000e-01 + vertex -1.572100e-02 -3.678111e-02 1.000000e-01 + vertex -1.405499e-02 -3.744939e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.907301e-03 -1.876937e-02 1.000000e-01 + vertex -1.405499e-02 -3.744939e-02 1.000000e-01 + vertex -1.236068e-02 -3.804226e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.898111e-02 -6.302164e-03 1.000000e-01 + vertex -3.744939e-02 -1.405499e-02 1.000000e-01 + vertex -1.853834e-02 -7.505340e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.436699e-02 -1.391365e-02 1.000000e-01 + vertex 1.344602e-02 -1.480556e-02 1.000000e-01 + vertex 2.764251e-02 -2.891179e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.891179e-02 -2.764251e-02 1.000000e-01 + vertex 1.436699e-02 -1.391365e-02 1.000000e-01 + vertex 2.764251e-02 -2.891179e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.764251e-02 2.891179e-02 1.000000e-01 + vertex -2.891179e-02 2.764251e-02 1.000000e-01 + vertex -1.436699e-02 1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.898111e-02 -6.302164e-03 1.000000e-01 + vertex -3.855851e-02 -1.064147e-02 1.000000e-01 + vertex -3.804226e-02 -1.236068e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.898111e-02 -6.302164e-03 1.000000e-01 + vertex -3.804226e-02 -1.236068e-02 1.000000e-01 + vertex -3.744939e-02 -1.405499e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.344602e-02 1.480556e-02 1.000000e-01 + vertex -2.764251e-02 2.891179e-02 1.000000e-01 + vertex -1.436699e-02 1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.690552e-03 -1.917336e-02 1.000000e-01 + vertex -6.907301e-03 -1.876937e-02 1.000000e-01 + vertex -1.236068e-02 -3.804226e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.690552e-03 -1.917336e-02 1.000000e-01 + vertex -1.236068e-02 -3.804226e-02 1.000000e-01 + vertex -1.064147e-02 -3.855851e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.934590e-02 -5.073092e-03 1.000000e-01 + vertex -3.855851e-02 -1.064147e-02 1.000000e-01 + vertex -1.898111e-02 -6.302164e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.934590e-02 -5.073092e-03 1.000000e-01 + vertex -3.899712e-02 -8.900837e-03 1.000000e-01 + vertex -3.855851e-02 -1.064147e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.450419e-03 -1.949856e-02 1.000000e-01 + vertex -8.900837e-03 -3.899712e-02 1.000000e-01 + vertex -7.142276e-03 -3.935718e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.450419e-03 -1.949856e-02 1.000000e-01 + vertex -5.690552e-03 -1.917336e-02 1.000000e-01 + vertex -1.064147e-02 -3.855851e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.450419e-03 -1.949856e-02 1.000000e-01 + vertex -1.064147e-02 -3.855851e-02 1.000000e-01 + vertex -8.900837e-03 -3.899712e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.012286e-02 -2.631755e-02 1.000000e-01 + vertex 1.522892e-02 -1.296457e-02 1.000000e-01 + vertex 1.436699e-02 -1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.012286e-02 -2.631755e-02 1.000000e-01 + vertex 1.436699e-02 -1.391365e-02 1.000000e-01 + vertex 2.891179e-02 -2.764251e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.963118e-02 -3.823173e-03 1.000000e-01 + vertex -3.899712e-02 -8.900837e-03 1.000000e-01 + vertex -1.934590e-02 -5.073092e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.631755e-02 3.012286e-02 1.000000e-01 + vertex -2.764251e-02 2.891179e-02 1.000000e-01 + vertex -1.344602e-02 1.480556e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.631755e-02 3.012286e-02 1.000000e-01 + vertex -1.344602e-02 1.480556e-02 1.000000e-01 + vertex -1.246980e-02 1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.963118e-02 -3.823173e-03 1.000000e-01 + vertex -3.935718e-02 -7.142276e-03 1.000000e-01 + vertex -3.899712e-02 -8.900837e-03 1.000000e-01 + endloop + endfacet + facet normal -9.384684e-01 3.453651e-01 0.000000e+00 + outer loop + vertex 1.898111e-02 -6.302164e-03 8.000000e-02 + vertex 1.853834e-02 -7.505340e-03 8.000000e-02 + vertex 1.853834e-02 -7.505340e-03 1.000000e-01 + endloop + endfacet + facet normal -9.384684e-01 3.453651e-01 0.000000e+00 + outer loop + vertex 1.898111e-02 -6.302164e-03 8.000000e-02 + vertex 1.853834e-02 -7.505340e-03 1.000000e-01 + vertex 1.898111e-02 -6.302164e-03 1.000000e-01 + endloop + endfacet + facet normal -9.586679e-01 2.845276e-01 0.000000e+00 + outer loop + vertex 1.934590e-02 -5.073092e-03 8.000000e-02 + vertex 1.898111e-02 -6.302164e-03 8.000000e-02 + vertex 1.898111e-02 -6.302164e-03 1.000000e-01 + endloop + endfacet + facet normal -9.586679e-01 2.845276e-01 0.000000e+00 + outer loop + vertex 1.934590e-02 -5.073092e-03 8.000000e-02 + vertex 1.898111e-02 -6.302164e-03 1.000000e-01 + vertex 1.934590e-02 -5.073092e-03 1.000000e-01 + endloop + endfacet + facet normal -9.749279e-01 2.225209e-01 0.000000e+00 + outer loop + vertex 1.963118e-02 -3.823173e-03 8.000000e-02 + vertex 1.934590e-02 -5.073092e-03 8.000000e-02 + vertex 1.934590e-02 -5.073092e-03 1.000000e-01 + endloop + endfacet + facet normal -9.749279e-01 2.225209e-01 0.000000e+00 + outer loop + vertex 1.963118e-02 -3.823173e-03 8.000000e-02 + vertex 1.934590e-02 -5.073092e-03 1.000000e-01 + vertex 1.963118e-02 -3.823173e-03 1.000000e-01 + endloop + endfacet + facet normal -9.994862e-01 -3.205158e-02 0.000000e+00 + outer loop + vertex 1.995891e-02 1.281404e-03 8.000000e-02 + vertex 2.000000e-02 0.000000e+00 1.000000e-01 + vertex 1.995891e-02 1.281404e-03 1.000000e-01 + endloop + endfacet + facet normal -9.994862e-01 -3.205158e-02 0.000000e+00 + outer loop + vertex 1.995891e-02 1.281404e-03 8.000000e-02 + vertex 2.000000e-02 0.000000e+00 8.000000e-02 + vertex 2.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal -9.871818e-01 1.595999e-01 0.000000e+00 + outer loop + vertex 1.983580e-02 -2.557543e-03 8.000000e-02 + vertex 1.963118e-02 -3.823173e-03 8.000000e-02 + vertex 1.963118e-02 -3.823173e-03 1.000000e-01 + endloop + endfacet + facet normal -9.871818e-01 1.595999e-01 0.000000e+00 + outer loop + vertex 1.983580e-02 -2.557543e-03 8.000000e-02 + vertex 1.963118e-02 -3.823173e-03 1.000000e-01 + vertex 1.983580e-02 -2.557543e-03 1.000000e-01 + endloop + endfacet + facet normal -9.953791e-01 -9.602303e-02 0.000000e+00 + outer loop + vertex 1.983580e-02 2.557543e-03 8.000000e-02 + vertex 1.995891e-02 1.281404e-03 1.000000e-01 + vertex 1.983580e-02 2.557543e-03 1.000000e-01 + endloop + endfacet + facet normal -9.953791e-01 -9.602303e-02 0.000000e+00 + outer loop + vertex 1.983580e-02 2.557543e-03 8.000000e-02 + vertex 1.995891e-02 1.281404e-03 8.000000e-02 + vertex 1.995891e-02 1.281404e-03 1.000000e-01 + endloop + endfacet + facet normal -9.953791e-01 9.602303e-02 0.000000e+00 + outer loop + vertex 1.995891e-02 -1.281404e-03 8.000000e-02 + vertex 1.983580e-02 -2.557543e-03 8.000000e-02 + vertex 1.983580e-02 -2.557543e-03 1.000000e-01 + endloop + endfacet + facet normal -9.953791e-01 9.602303e-02 0.000000e+00 + outer loop + vertex 1.995891e-02 -1.281404e-03 8.000000e-02 + vertex 1.983580e-02 -2.557543e-03 1.000000e-01 + vertex 1.995891e-02 -1.281404e-03 1.000000e-01 + endloop + endfacet + facet normal -9.994862e-01 3.205158e-02 0.000000e+00 + outer loop + vertex 2.000000e-02 0.000000e+00 8.000000e-02 + vertex 1.995891e-02 -1.281404e-03 8.000000e-02 + vertex 1.995891e-02 -1.281404e-03 1.000000e-01 + endloop + endfacet + facet normal -9.871818e-01 -1.595999e-01 0.000000e+00 + outer loop + vertex 1.963118e-02 3.823173e-03 8.000000e-02 + vertex 1.983580e-02 2.557543e-03 1.000000e-01 + vertex 1.963118e-02 3.823173e-03 1.000000e-01 + endloop + endfacet + facet normal -9.994862e-01 3.205158e-02 0.000000e+00 + outer loop + vertex 2.000000e-02 0.000000e+00 8.000000e-02 + vertex 1.995891e-02 -1.281404e-03 1.000000e-01 + vertex 2.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal -9.871818e-01 -1.595999e-01 0.000000e+00 + outer loop + vertex 1.963118e-02 3.823173e-03 8.000000e-02 + vertex 1.983580e-02 2.557543e-03 8.000000e-02 + vertex 1.983580e-02 2.557543e-03 1.000000e-01 + endloop + endfacet + facet normal -9.749279e-01 -2.225209e-01 0.000000e+00 + outer loop + vertex 1.934590e-02 5.073092e-03 8.000000e-02 + vertex 1.963118e-02 3.823173e-03 1.000000e-01 + vertex 1.934590e-02 5.073092e-03 1.000000e-01 + endloop + endfacet + facet normal -9.749279e-01 -2.225209e-01 0.000000e+00 + outer loop + vertex 1.934590e-02 5.073092e-03 8.000000e-02 + vertex 1.963118e-02 3.823173e-03 8.000000e-02 + vertex 1.963118e-02 3.823173e-03 1.000000e-01 + endloop + endfacet + facet normal -9.586679e-01 -2.845276e-01 0.000000e+00 + outer loop + vertex 1.898111e-02 6.302164e-03 8.000000e-02 + vertex 1.934590e-02 5.073092e-03 1.000000e-01 + vertex 1.898111e-02 6.302164e-03 1.000000e-01 + endloop + endfacet + facet normal -9.586679e-01 -2.845276e-01 0.000000e+00 + outer loop + vertex 1.898111e-02 6.302164e-03 8.000000e-02 + vertex 1.934590e-02 5.073092e-03 8.000000e-02 + vertex 1.934590e-02 5.073092e-03 1.000000e-01 + endloop + endfacet + facet normal -9.384684e-01 -3.453651e-01 0.000000e+00 + outer loop + vertex 1.853834e-02 7.505340e-03 8.000000e-02 + vertex 1.898111e-02 6.302164e-03 1.000000e-01 + vertex 1.853834e-02 7.505340e-03 1.000000e-01 + endloop + endfacet + facet normal -9.384684e-01 -3.453651e-01 0.000000e+00 + outer loop + vertex 1.853834e-02 7.505340e-03 8.000000e-02 + vertex 1.898111e-02 6.302164e-03 8.000000e-02 + vertex 1.898111e-02 6.302164e-03 1.000000e-01 + endloop + endfacet + facet normal -9.144126e-01 -4.047833e-01 0.000000e+00 + outer loop + vertex 1.801938e-02 8.677675e-03 8.000000e-02 + vertex 1.853834e-02 7.505340e-03 1.000000e-01 + vertex 1.801938e-02 8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal -9.144126e-01 -4.047833e-01 0.000000e+00 + outer loop + vertex 1.801938e-02 8.677675e-03 8.000000e-02 + vertex 1.853834e-02 7.505340e-03 8.000000e-02 + vertex 1.853834e-02 7.505340e-03 1.000000e-01 + endloop + endfacet + facet normal -8.865993e-01 -4.625383e-01 0.000000e+00 + outer loop + vertex 1.742637e-02 9.814351e-03 8.000000e-02 + vertex 1.801938e-02 8.677675e-03 1.000000e-01 + vertex 1.742637e-02 9.814351e-03 1.000000e-01 + endloop + endfacet + facet normal -8.865993e-01 -4.625383e-01 0.000000e+00 + outer loop + vertex 1.742637e-02 9.814351e-03 8.000000e-02 + vertex 1.801938e-02 8.677675e-03 8.000000e-02 + vertex 1.801938e-02 8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal -8.551428e-01 -5.183926e-01 0.000000e+00 + outer loop + vertex 1.676176e-02 1.091070e-02 8.000000e-02 + vertex 1.742637e-02 9.814351e-03 1.000000e-01 + vertex 1.676176e-02 1.091070e-02 1.000000e-01 + endloop + endfacet + facet normal -8.551428e-01 -5.183926e-01 0.000000e+00 + outer loop + vertex 1.676176e-02 1.091070e-02 8.000000e-02 + vertex 1.742637e-02 9.814351e-03 8.000000e-02 + vertex 1.742637e-02 9.814351e-03 1.000000e-01 + endloop + endfacet + facet normal -8.201723e-01 -5.721167e-01 0.000000e+00 + outer loop + vertex 1.602827e-02 1.196221e-02 8.000000e-02 + vertex 1.676176e-02 1.091070e-02 1.000000e-01 + vertex 1.602827e-02 1.196221e-02 1.000000e-01 + endloop + endfacet + facet normal -8.201723e-01 -5.721167e-01 0.000000e+00 + outer loop + vertex 1.602827e-02 1.196221e-02 8.000000e-02 + vertex 1.676176e-02 1.091070e-02 8.000000e-02 + vertex 1.676176e-02 1.091070e-02 1.000000e-01 + endloop + endfacet + facet normal -7.818315e-01 -6.234898e-01 0.000000e+00 + outer loop + vertex 1.522892e-02 1.296457e-02 8.000000e-02 + vertex 1.602827e-02 1.196221e-02 1.000000e-01 + vertex 1.522892e-02 1.296457e-02 1.000000e-01 + endloop + endfacet + facet normal -7.818315e-01 -6.234898e-01 0.000000e+00 + outer loop + vertex 1.522892e-02 1.296457e-02 8.000000e-02 + vertex 1.602827e-02 1.196221e-02 8.000000e-02 + vertex 1.602827e-02 1.196221e-02 1.000000e-01 + endloop + endfacet + facet normal -7.402780e-01 -6.723009e-01 0.000000e+00 + outer loop + vertex 1.436699e-02 1.391365e-02 8.000000e-02 + vertex 1.522892e-02 1.296457e-02 1.000000e-01 + vertex 1.436699e-02 1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal -7.402780e-01 -6.723009e-01 0.000000e+00 + outer loop + vertex 1.436699e-02 1.391365e-02 8.000000e-02 + vertex 1.522892e-02 1.296457e-02 8.000000e-02 + vertex 1.522892e-02 1.296457e-02 1.000000e-01 + endloop + endfacet + facet normal -6.956826e-01 -7.183494e-01 0.000000e+00 + outer loop + vertex 1.344602e-02 1.480556e-02 8.000000e-02 + vertex 1.436699e-02 1.391365e-02 1.000000e-01 + vertex 1.344602e-02 1.480556e-02 1.000000e-01 + endloop + endfacet + facet normal -6.956826e-01 -7.183494e-01 0.000000e+00 + outer loop + vertex 1.344602e-02 1.480556e-02 8.000000e-02 + vertex 1.436699e-02 1.391365e-02 8.000000e-02 + vertex 1.436699e-02 1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal -6.482284e-01 -7.614460e-01 0.000000e+00 + outer loop + vertex 1.246980e-02 1.563663e-02 8.000000e-02 + vertex 1.344602e-02 1.480556e-02 1.000000e-01 + vertex 1.246980e-02 1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal -6.482284e-01 -7.614460e-01 0.000000e+00 + outer loop + vertex 1.246980e-02 1.563663e-02 8.000000e-02 + vertex 1.344602e-02 1.480556e-02 8.000000e-02 + vertex 1.344602e-02 1.480556e-02 1.000000e-01 + endloop + endfacet + facet normal -5.981105e-01 -8.014136e-01 0.000000e+00 + outer loop + vertex 1.144233e-02 1.640345e-02 8.000000e-02 + vertex 1.246980e-02 1.563663e-02 1.000000e-01 + vertex 1.144233e-02 1.640345e-02 1.000000e-01 + endloop + endfacet + facet normal -5.981105e-01 -8.014136e-01 0.000000e+00 + outer loop + vertex 1.144233e-02 1.640345e-02 8.000000e-02 + vertex 1.246980e-02 1.563663e-02 8.000000e-02 + vertex 1.246980e-02 1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal -5.455349e-01 -8.380881e-01 0.000000e+00 + outer loop + vertex 1.036785e-02 1.710286e-02 8.000000e-02 + vertex 1.144233e-02 1.640345e-02 1.000000e-01 + vertex 1.036785e-02 1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal -5.455349e-01 -8.380881e-01 0.000000e+00 + outer loop + vertex 1.036785e-02 1.710286e-02 8.000000e-02 + vertex 1.144233e-02 1.640345e-02 8.000000e-02 + vertex 1.144233e-02 1.640345e-02 1.000000e-01 + endloop + endfacet + facet normal -4.907176e-01 -8.713187e-01 0.000000e+00 + outer loop + vertex 9.250766e-03 1.773199e-02 8.000000e-02 + vertex 1.036785e-02 1.710286e-02 1.000000e-01 + vertex 9.250766e-03 1.773199e-02 1.000000e-01 + endloop + endfacet + facet normal -4.907176e-01 -8.713187e-01 0.000000e+00 + outer loop + vertex 9.250766e-03 1.773199e-02 8.000000e-02 + vertex 1.036785e-02 1.710286e-02 8.000000e-02 + vertex 1.036785e-02 1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal -4.338837e-01 -9.009689e-01 0.000000e+00 + outer loop + vertex 8.095667e-03 1.828825e-02 8.000000e-02 + vertex 9.250766e-03 1.773199e-02 1.000000e-01 + vertex 8.095667e-03 1.828825e-02 1.000000e-01 + endloop + endfacet + facet normal -4.338837e-01 -9.009689e-01 0.000000e+00 + outer loop + vertex 8.095667e-03 1.828825e-02 8.000000e-02 + vertex 9.250766e-03 1.773199e-02 8.000000e-02 + vertex 9.250766e-03 1.773199e-02 1.000000e-01 + endloop + endfacet + facet normal -3.752670e-01 -9.269168e-01 0.000000e+00 + outer loop + vertex 6.907301e-03 1.876937e-02 8.000000e-02 + vertex 8.095667e-03 1.828825e-02 1.000000e-01 + vertex 6.907301e-03 1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal -3.752670e-01 -9.269168e-01 0.000000e+00 + outer loop + vertex 6.907301e-03 1.876937e-02 8.000000e-02 + vertex 8.095667e-03 1.828825e-02 8.000000e-02 + vertex 8.095667e-03 1.828825e-02 1.000000e-01 + endloop + endfacet + facet normal -3.151082e-01 -9.490557e-01 0.000000e+00 + outer loop + vertex 5.690552e-03 1.917336e-02 8.000000e-02 + vertex 6.907301e-03 1.876937e-02 1.000000e-01 + vertex 5.690552e-03 1.917336e-02 1.000000e-01 + endloop + endfacet + facet normal -3.151082e-01 -9.490557e-01 0.000000e+00 + outer loop + vertex 5.690552e-03 1.917336e-02 8.000000e-02 + vertex 6.907301e-03 1.876937e-02 8.000000e-02 + vertex 6.907301e-03 1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal -2.536546e-01 -9.672949e-01 0.000000e+00 + outer loop + vertex 4.450419e-03 1.949856e-02 8.000000e-02 + vertex 5.690552e-03 1.917336e-02 1.000000e-01 + vertex 4.450419e-03 1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal -2.536546e-01 -9.672949e-01 0.000000e+00 + outer loop + vertex 4.450419e-03 1.949856e-02 8.000000e-02 + vertex 5.690552e-03 1.917336e-02 8.000000e-02 + vertex 5.690552e-03 1.917336e-02 1.000000e-01 + endloop + endfacet + facet normal -1.911586e-01 -9.815592e-01 0.000000e+00 + outer loop + vertex 3.191998e-03 1.974364e-02 8.000000e-02 + vertex 4.450419e-03 1.949856e-02 1.000000e-01 + vertex 3.191998e-03 1.974364e-02 1.000000e-01 + endloop + endfacet + facet normal -1.911586e-01 -9.815592e-01 0.000000e+00 + outer loop + vertex 3.191998e-03 1.974364e-02 8.000000e-02 + vertex 4.450419e-03 1.949856e-02 8.000000e-02 + vertex 4.450419e-03 1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal -1.278772e-01 -9.917900e-01 0.000000e+00 + outer loop + vertex 1.920461e-03 1.990758e-02 8.000000e-02 + vertex 3.191998e-03 1.974364e-02 1.000000e-01 + vertex 1.920461e-03 1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal -1.278772e-01 -9.917900e-01 0.000000e+00 + outer loop + vertex 1.920461e-03 1.990758e-02 8.000000e-02 + vertex 3.191998e-03 1.974364e-02 8.000000e-02 + vertex 3.191998e-03 1.974364e-02 1.000000e-01 + endloop + endfacet + facet normal -6.407022e-02 -9.979454e-01 0.000000e+00 + outer loop + vertex 6.410316e-04 1.998972e-02 8.000000e-02 + vertex 1.920461e-03 1.990758e-02 1.000000e-01 + vertex 6.410316e-04 1.998972e-02 1.000000e-01 + endloop + endfacet + facet normal -6.407022e-02 -9.979454e-01 0.000000e+00 + outer loop + vertex 6.410316e-04 1.998972e-02 8.000000e-02 + vertex 1.920461e-03 1.990758e-02 8.000000e-02 + vertex 1.920461e-03 1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 -1.000000e+00 0.000000e+00 + outer loop + vertex -6.410316e-04 1.998972e-02 8.000000e-02 + vertex 6.410316e-04 1.998972e-02 8.000000e-02 + vertex 6.410316e-04 1.998972e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 -1.000000e+00 0.000000e+00 + outer loop + vertex -6.410316e-04 1.998972e-02 8.000000e-02 + vertex 6.410316e-04 1.998972e-02 1.000000e-01 + vertex -6.410316e-04 1.998972e-02 1.000000e-01 + endloop + endfacet + facet normal 6.407022e-02 -9.979454e-01 0.000000e+00 + outer loop + vertex -1.920461e-03 1.990758e-02 8.000000e-02 + vertex -6.410316e-04 1.998972e-02 8.000000e-02 + vertex -6.410316e-04 1.998972e-02 1.000000e-01 + endloop + endfacet + facet normal 6.407022e-02 -9.979454e-01 0.000000e+00 + outer loop + vertex -1.920461e-03 1.990758e-02 8.000000e-02 + vertex -6.410316e-04 1.998972e-02 1.000000e-01 + vertex -1.920461e-03 1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal 1.278772e-01 -9.917900e-01 0.000000e+00 + outer loop + vertex -3.191998e-03 1.974364e-02 8.000000e-02 + vertex -1.920461e-03 1.990758e-02 8.000000e-02 + vertex -1.920461e-03 1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal 1.278772e-01 -9.917900e-01 0.000000e+00 + outer loop + vertex -3.191998e-03 1.974364e-02 8.000000e-02 + vertex -1.920461e-03 1.990758e-02 1.000000e-01 + vertex -3.191998e-03 1.974364e-02 1.000000e-01 + endloop + endfacet + facet normal 1.911586e-01 -9.815592e-01 0.000000e+00 + outer loop + vertex -4.450419e-03 1.949856e-02 8.000000e-02 + vertex -3.191998e-03 1.974364e-02 8.000000e-02 + vertex -3.191998e-03 1.974364e-02 1.000000e-01 + endloop + endfacet + facet normal 1.911586e-01 -9.815592e-01 0.000000e+00 + outer loop + vertex -4.450419e-03 1.949856e-02 8.000000e-02 + vertex -3.191998e-03 1.974364e-02 1.000000e-01 + vertex -4.450419e-03 1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal 2.536546e-01 -9.672949e-01 0.000000e+00 + outer loop + vertex -5.690552e-03 1.917336e-02 8.000000e-02 + vertex -4.450419e-03 1.949856e-02 8.000000e-02 + vertex -4.450419e-03 1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal 2.536546e-01 -9.672949e-01 0.000000e+00 + outer loop + vertex -5.690552e-03 1.917336e-02 8.000000e-02 + vertex -4.450419e-03 1.949856e-02 1.000000e-01 + vertex -5.690552e-03 1.917336e-02 1.000000e-01 + endloop + endfacet + facet normal 3.151082e-01 -9.490557e-01 0.000000e+00 + outer loop + vertex -6.907301e-03 1.876937e-02 8.000000e-02 + vertex -5.690552e-03 1.917336e-02 8.000000e-02 + vertex -5.690552e-03 1.917336e-02 1.000000e-01 + endloop + endfacet + facet normal 3.151082e-01 -9.490557e-01 0.000000e+00 + outer loop + vertex -6.907301e-03 1.876937e-02 8.000000e-02 + vertex -5.690552e-03 1.917336e-02 1.000000e-01 + vertex -6.907301e-03 1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal 3.752670e-01 -9.269168e-01 0.000000e+00 + outer loop + vertex -8.095667e-03 1.828825e-02 8.000000e-02 + vertex -6.907301e-03 1.876937e-02 8.000000e-02 + vertex -6.907301e-03 1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal 3.752670e-01 -9.269168e-01 0.000000e+00 + outer loop + vertex -8.095667e-03 1.828825e-02 8.000000e-02 + vertex -6.907301e-03 1.876937e-02 1.000000e-01 + vertex -8.095667e-03 1.828825e-02 1.000000e-01 + endloop + endfacet + facet normal 4.338837e-01 -9.009689e-01 0.000000e+00 + outer loop + vertex -9.250766e-03 1.773199e-02 8.000000e-02 + vertex -8.095667e-03 1.828825e-02 8.000000e-02 + vertex -8.095667e-03 1.828825e-02 1.000000e-01 + endloop + endfacet + facet normal 4.338837e-01 -9.009689e-01 0.000000e+00 + outer loop + vertex -9.250766e-03 1.773199e-02 8.000000e-02 + vertex -8.095667e-03 1.828825e-02 1.000000e-01 + vertex -9.250766e-03 1.773199e-02 1.000000e-01 + endloop + endfacet + facet normal 4.907176e-01 -8.713187e-01 0.000000e+00 + outer loop + vertex -1.036785e-02 1.710286e-02 8.000000e-02 + vertex -9.250766e-03 1.773199e-02 1.000000e-01 + vertex -1.036785e-02 1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal 4.907176e-01 -8.713187e-01 0.000000e+00 + outer loop + vertex -1.036785e-02 1.710286e-02 8.000000e-02 + vertex -9.250766e-03 1.773199e-02 8.000000e-02 + vertex -9.250766e-03 1.773199e-02 1.000000e-01 + endloop + endfacet + facet normal 5.455349e-01 -8.380881e-01 0.000000e+00 + outer loop + vertex -1.144233e-02 1.640345e-02 8.000000e-02 + vertex -1.036785e-02 1.710286e-02 1.000000e-01 + vertex -1.144233e-02 1.640345e-02 1.000000e-01 + endloop + endfacet + facet normal 5.455349e-01 -8.380881e-01 0.000000e+00 + outer loop + vertex -1.144233e-02 1.640345e-02 8.000000e-02 + vertex -1.036785e-02 1.710286e-02 8.000000e-02 + vertex -1.036785e-02 1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal 5.981105e-01 -8.014136e-01 0.000000e+00 + outer loop + vertex -1.246980e-02 1.563663e-02 8.000000e-02 + vertex -1.144233e-02 1.640345e-02 1.000000e-01 + vertex -1.246980e-02 1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal 5.981105e-01 -8.014136e-01 0.000000e+00 + outer loop + vertex -1.246980e-02 1.563663e-02 8.000000e-02 + vertex -1.144233e-02 1.640345e-02 8.000000e-02 + vertex -1.144233e-02 1.640345e-02 1.000000e-01 + endloop + endfacet + facet normal 6.482284e-01 -7.614460e-01 0.000000e+00 + outer loop + vertex -1.344602e-02 1.480556e-02 8.000000e-02 + vertex -1.246980e-02 1.563663e-02 1.000000e-01 + vertex -1.344602e-02 1.480556e-02 1.000000e-01 + endloop + endfacet + facet normal 6.482284e-01 -7.614460e-01 0.000000e+00 + outer loop + vertex -1.344602e-02 1.480556e-02 8.000000e-02 + vertex -1.246980e-02 1.563663e-02 8.000000e-02 + vertex -1.246980e-02 1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal 6.956826e-01 -7.183494e-01 0.000000e+00 + outer loop + vertex -1.436699e-02 1.391365e-02 8.000000e-02 + vertex -1.344602e-02 1.480556e-02 1.000000e-01 + vertex -1.436699e-02 1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal 6.956826e-01 -7.183494e-01 0.000000e+00 + outer loop + vertex -1.436699e-02 1.391365e-02 8.000000e-02 + vertex -1.344602e-02 1.480556e-02 8.000000e-02 + vertex -1.344602e-02 1.480556e-02 1.000000e-01 + endloop + endfacet + facet normal 7.402780e-01 -6.723009e-01 0.000000e+00 + outer loop + vertex -1.522892e-02 1.296457e-02 8.000000e-02 + vertex -1.436699e-02 1.391365e-02 1.000000e-01 + vertex -1.522892e-02 1.296457e-02 1.000000e-01 + endloop + endfacet + facet normal 7.402780e-01 -6.723009e-01 0.000000e+00 + outer loop + vertex -1.522892e-02 1.296457e-02 8.000000e-02 + vertex -1.436699e-02 1.391365e-02 8.000000e-02 + vertex -1.436699e-02 1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal 7.818315e-01 -6.234898e-01 0.000000e+00 + outer loop + vertex -1.602827e-02 1.196221e-02 8.000000e-02 + vertex -1.522892e-02 1.296457e-02 1.000000e-01 + vertex -1.602827e-02 1.196221e-02 1.000000e-01 + endloop + endfacet + facet normal 7.818315e-01 -6.234898e-01 0.000000e+00 + outer loop + vertex -1.602827e-02 1.196221e-02 8.000000e-02 + vertex -1.522892e-02 1.296457e-02 8.000000e-02 + vertex -1.522892e-02 1.296457e-02 1.000000e-01 + endloop + endfacet + facet normal 8.201723e-01 -5.721167e-01 0.000000e+00 + outer loop + vertex -1.676176e-02 1.091070e-02 8.000000e-02 + vertex -1.602827e-02 1.196221e-02 1.000000e-01 + vertex -1.676176e-02 1.091070e-02 1.000000e-01 + endloop + endfacet + facet normal 8.201723e-01 -5.721167e-01 0.000000e+00 + outer loop + vertex -1.676176e-02 1.091070e-02 8.000000e-02 + vertex -1.602827e-02 1.196221e-02 8.000000e-02 + vertex -1.602827e-02 1.196221e-02 1.000000e-01 + endloop + endfacet + facet normal 8.551428e-01 -5.183926e-01 0.000000e+00 + outer loop + vertex -1.742637e-02 9.814351e-03 8.000000e-02 + vertex -1.676176e-02 1.091070e-02 1.000000e-01 + vertex -1.742637e-02 9.814351e-03 1.000000e-01 + endloop + endfacet + facet normal 8.551428e-01 -5.183926e-01 0.000000e+00 + outer loop + vertex -1.742637e-02 9.814351e-03 8.000000e-02 + vertex -1.676176e-02 1.091070e-02 8.000000e-02 + vertex -1.676176e-02 1.091070e-02 1.000000e-01 + endloop + endfacet + facet normal 8.865993e-01 -4.625383e-01 0.000000e+00 + outer loop + vertex -1.801938e-02 8.677675e-03 8.000000e-02 + vertex -1.742637e-02 9.814351e-03 1.000000e-01 + vertex -1.801938e-02 8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal 8.865993e-01 -4.625383e-01 0.000000e+00 + outer loop + vertex -1.801938e-02 8.677675e-03 8.000000e-02 + vertex -1.742637e-02 9.814351e-03 8.000000e-02 + vertex -1.742637e-02 9.814351e-03 1.000000e-01 + endloop + endfacet + facet normal 9.144126e-01 -4.047833e-01 0.000000e+00 + outer loop + vertex -1.853834e-02 7.505340e-03 8.000000e-02 + vertex -1.801938e-02 8.677675e-03 1.000000e-01 + vertex -1.853834e-02 7.505340e-03 1.000000e-01 + endloop + endfacet + facet normal 9.144126e-01 -4.047833e-01 0.000000e+00 + outer loop + vertex -1.853834e-02 7.505340e-03 8.000000e-02 + vertex -1.801938e-02 8.677675e-03 8.000000e-02 + vertex -1.801938e-02 8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal 9.384684e-01 -3.453651e-01 0.000000e+00 + outer loop + vertex -1.898111e-02 6.302164e-03 8.000000e-02 + vertex -1.853834e-02 7.505340e-03 1.000000e-01 + vertex -1.898111e-02 6.302164e-03 1.000000e-01 + endloop + endfacet + facet normal 9.384684e-01 -3.453651e-01 0.000000e+00 + outer loop + vertex -1.898111e-02 6.302164e-03 8.000000e-02 + vertex -1.853834e-02 7.505340e-03 8.000000e-02 + vertex -1.853834e-02 7.505340e-03 1.000000e-01 + endloop + endfacet + facet normal 9.586679e-01 -2.845276e-01 0.000000e+00 + outer loop + vertex -1.934590e-02 5.073092e-03 8.000000e-02 + vertex -1.898111e-02 6.302164e-03 1.000000e-01 + vertex -1.934590e-02 5.073092e-03 1.000000e-01 + endloop + endfacet + facet normal 9.586679e-01 -2.845276e-01 0.000000e+00 + outer loop + vertex -1.934590e-02 5.073092e-03 8.000000e-02 + vertex -1.898111e-02 6.302164e-03 8.000000e-02 + vertex -1.898111e-02 6.302164e-03 1.000000e-01 + endloop + endfacet + facet normal 9.749279e-01 -2.225209e-01 0.000000e+00 + outer loop + vertex -1.963118e-02 3.823173e-03 8.000000e-02 + vertex -1.934590e-02 5.073092e-03 1.000000e-01 + vertex -1.963118e-02 3.823173e-03 1.000000e-01 + endloop + endfacet + facet normal 9.749279e-01 -2.225209e-01 0.000000e+00 + outer loop + vertex -1.963118e-02 3.823173e-03 8.000000e-02 + vertex -1.934590e-02 5.073092e-03 8.000000e-02 + vertex -1.934590e-02 5.073092e-03 1.000000e-01 + endloop + endfacet + facet normal 9.871818e-01 -1.595999e-01 0.000000e+00 + outer loop + vertex -1.983580e-02 2.557543e-03 8.000000e-02 + vertex -1.963118e-02 3.823173e-03 1.000000e-01 + vertex -1.983580e-02 2.557543e-03 1.000000e-01 + endloop + endfacet + facet normal 9.871818e-01 -1.595999e-01 0.000000e+00 + outer loop + vertex -1.983580e-02 2.557543e-03 8.000000e-02 + vertex -1.963118e-02 3.823173e-03 8.000000e-02 + vertex -1.963118e-02 3.823173e-03 1.000000e-01 + endloop + endfacet + facet normal 9.953791e-01 -9.602303e-02 0.000000e+00 + outer loop + vertex -1.995891e-02 1.281404e-03 8.000000e-02 + vertex -1.983580e-02 2.557543e-03 1.000000e-01 + vertex -1.995891e-02 1.281404e-03 1.000000e-01 + endloop + endfacet + facet normal 9.953791e-01 -9.602303e-02 0.000000e+00 + outer loop + vertex -1.995891e-02 1.281404e-03 8.000000e-02 + vertex -1.983580e-02 2.557543e-03 8.000000e-02 + vertex -1.983580e-02 2.557543e-03 1.000000e-01 + endloop + endfacet + facet normal 9.994862e-01 -3.205158e-02 0.000000e+00 + outer loop + vertex -2.000000e-02 2.021286e-17 8.000000e-02 + vertex -1.995891e-02 1.281404e-03 1.000000e-01 + vertex -2.000000e-02 2.021286e-17 1.000000e-01 + endloop + endfacet + facet normal 9.994862e-01 -3.205158e-02 0.000000e+00 + outer loop + vertex -2.000000e-02 2.021286e-17 8.000000e-02 + vertex -1.995891e-02 1.281404e-03 8.000000e-02 + vertex -1.995891e-02 1.281404e-03 1.000000e-01 + endloop + endfacet + facet normal 9.994862e-01 3.205158e-02 -0.000000e+00 + outer loop + vertex -1.995891e-02 -1.281404e-03 8.000000e-02 + vertex -2.000000e-02 2.021286e-17 8.000000e-02 + vertex -2.000000e-02 2.021286e-17 1.000000e-01 + endloop + endfacet + facet normal 9.994862e-01 3.205158e-02 0.000000e+00 + outer loop + vertex -1.995891e-02 -1.281404e-03 8.000000e-02 + vertex -2.000000e-02 2.021286e-17 1.000000e-01 + vertex -1.995891e-02 -1.281404e-03 1.000000e-01 + endloop + endfacet + facet normal 9.953791e-01 9.602303e-02 -0.000000e+00 + outer loop + vertex -1.983580e-02 -2.557543e-03 8.000000e-02 + vertex -1.995891e-02 -1.281404e-03 8.000000e-02 + vertex -1.995891e-02 -1.281404e-03 1.000000e-01 + endloop + endfacet + facet normal 9.953791e-01 9.602303e-02 0.000000e+00 + outer loop + vertex -1.983580e-02 -2.557543e-03 8.000000e-02 + vertex -1.995891e-02 -1.281404e-03 1.000000e-01 + vertex -1.983580e-02 -2.557543e-03 1.000000e-01 + endloop + endfacet + facet normal 9.871818e-01 1.595999e-01 -0.000000e+00 + outer loop + vertex -1.963118e-02 -3.823173e-03 8.000000e-02 + vertex -1.983580e-02 -2.557543e-03 8.000000e-02 + vertex -1.983580e-02 -2.557543e-03 1.000000e-01 + endloop + endfacet + facet normal 9.871818e-01 1.595999e-01 0.000000e+00 + outer loop + vertex -1.963118e-02 -3.823173e-03 8.000000e-02 + vertex -1.983580e-02 -2.557543e-03 1.000000e-01 + vertex -1.963118e-02 -3.823173e-03 1.000000e-01 + endloop + endfacet + facet normal 9.749279e-01 2.225209e-01 -0.000000e+00 + outer loop + vertex -1.934590e-02 -5.073092e-03 8.000000e-02 + vertex -1.963118e-02 -3.823173e-03 8.000000e-02 + vertex -1.963118e-02 -3.823173e-03 1.000000e-01 + endloop + endfacet + facet normal 9.749279e-01 2.225209e-01 0.000000e+00 + outer loop + vertex -1.934590e-02 -5.073092e-03 8.000000e-02 + vertex -1.963118e-02 -3.823173e-03 1.000000e-01 + vertex -1.934590e-02 -5.073092e-03 1.000000e-01 + endloop + endfacet + facet normal 9.586679e-01 2.845276e-01 -0.000000e+00 + outer loop + vertex -1.898111e-02 -6.302164e-03 8.000000e-02 + vertex -1.934590e-02 -5.073092e-03 8.000000e-02 + vertex -1.934590e-02 -5.073092e-03 1.000000e-01 + endloop + endfacet + facet normal 9.586679e-01 2.845276e-01 0.000000e+00 + outer loop + vertex -1.898111e-02 -6.302164e-03 8.000000e-02 + vertex -1.934590e-02 -5.073092e-03 1.000000e-01 + vertex -1.898111e-02 -6.302164e-03 1.000000e-01 + endloop + endfacet + facet normal 9.384684e-01 3.453651e-01 -0.000000e+00 + outer loop + vertex -1.853834e-02 -7.505340e-03 8.000000e-02 + vertex -1.898111e-02 -6.302164e-03 8.000000e-02 + vertex -1.898111e-02 -6.302164e-03 1.000000e-01 + endloop + endfacet + facet normal 9.384684e-01 3.453651e-01 0.000000e+00 + outer loop + vertex -1.853834e-02 -7.505340e-03 8.000000e-02 + vertex -1.898111e-02 -6.302164e-03 1.000000e-01 + vertex -1.853834e-02 -7.505340e-03 1.000000e-01 + endloop + endfacet + facet normal 9.144126e-01 4.047833e-01 -0.000000e+00 + outer loop + vertex -1.801938e-02 -8.677675e-03 8.000000e-02 + vertex -1.853834e-02 -7.505340e-03 8.000000e-02 + vertex -1.853834e-02 -7.505340e-03 1.000000e-01 + endloop + endfacet + facet normal 9.144126e-01 4.047833e-01 0.000000e+00 + outer loop + vertex -1.801938e-02 -8.677675e-03 8.000000e-02 + vertex -1.853834e-02 -7.505340e-03 1.000000e-01 + vertex -1.801938e-02 -8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal 8.865993e-01 4.625383e-01 -0.000000e+00 + outer loop + vertex -1.742637e-02 -9.814351e-03 8.000000e-02 + vertex -1.801938e-02 -8.677675e-03 8.000000e-02 + vertex -1.801938e-02 -8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal 8.865993e-01 4.625383e-01 0.000000e+00 + outer loop + vertex -1.742637e-02 -9.814351e-03 8.000000e-02 + vertex -1.801938e-02 -8.677675e-03 1.000000e-01 + vertex -1.742637e-02 -9.814351e-03 1.000000e-01 + endloop + endfacet + facet normal 8.551428e-01 5.183926e-01 -0.000000e+00 + outer loop + vertex -1.676176e-02 -1.091070e-02 8.000000e-02 + vertex -1.742637e-02 -9.814351e-03 8.000000e-02 + vertex -1.742637e-02 -9.814351e-03 1.000000e-01 + endloop + endfacet + facet normal 8.551428e-01 5.183926e-01 0.000000e+00 + outer loop + vertex -1.676176e-02 -1.091070e-02 8.000000e-02 + vertex -1.742637e-02 -9.814351e-03 1.000000e-01 + vertex -1.676176e-02 -1.091070e-02 1.000000e-01 + endloop + endfacet + facet normal 8.201723e-01 5.721167e-01 -0.000000e+00 + outer loop + vertex -1.602827e-02 -1.196221e-02 8.000000e-02 + vertex -1.676176e-02 -1.091070e-02 8.000000e-02 + vertex -1.676176e-02 -1.091070e-02 1.000000e-01 + endloop + endfacet + facet normal 8.201723e-01 5.721167e-01 0.000000e+00 + outer loop + vertex -1.602827e-02 -1.196221e-02 8.000000e-02 + vertex -1.676176e-02 -1.091070e-02 1.000000e-01 + vertex -1.602827e-02 -1.196221e-02 1.000000e-01 + endloop + endfacet + facet normal 7.818315e-01 6.234898e-01 -0.000000e+00 + outer loop + vertex -1.522892e-02 -1.296457e-02 8.000000e-02 + vertex -1.602827e-02 -1.196221e-02 8.000000e-02 + vertex -1.602827e-02 -1.196221e-02 1.000000e-01 + endloop + endfacet + facet normal 7.818315e-01 6.234898e-01 0.000000e+00 + outer loop + vertex -1.522892e-02 -1.296457e-02 8.000000e-02 + vertex -1.602827e-02 -1.196221e-02 1.000000e-01 + vertex -1.522892e-02 -1.296457e-02 1.000000e-01 + endloop + endfacet + facet normal 7.402780e-01 6.723009e-01 -0.000000e+00 + outer loop + vertex -1.436699e-02 -1.391365e-02 8.000000e-02 + vertex -1.522892e-02 -1.296457e-02 8.000000e-02 + vertex -1.522892e-02 -1.296457e-02 1.000000e-01 + endloop + endfacet + facet normal 7.402780e-01 6.723009e-01 0.000000e+00 + outer loop + vertex -1.436699e-02 -1.391365e-02 8.000000e-02 + vertex -1.522892e-02 -1.296457e-02 1.000000e-01 + vertex -1.436699e-02 -1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal 6.956826e-01 7.183494e-01 -0.000000e+00 + outer loop + vertex -1.344602e-02 -1.480556e-02 8.000000e-02 + vertex -1.436699e-02 -1.391365e-02 8.000000e-02 + vertex -1.436699e-02 -1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal 6.956826e-01 7.183494e-01 0.000000e+00 + outer loop + vertex -1.344602e-02 -1.480556e-02 8.000000e-02 + vertex -1.436699e-02 -1.391365e-02 1.000000e-01 + vertex -1.344602e-02 -1.480556e-02 1.000000e-01 + endloop + endfacet + facet normal 6.482284e-01 7.614460e-01 -0.000000e+00 + outer loop + vertex -1.246980e-02 -1.563663e-02 8.000000e-02 + vertex -1.344602e-02 -1.480556e-02 8.000000e-02 + vertex -1.344602e-02 -1.480556e-02 1.000000e-01 + endloop + endfacet + facet normal 6.482284e-01 7.614460e-01 0.000000e+00 + outer loop + vertex -1.246980e-02 -1.563663e-02 8.000000e-02 + vertex -1.344602e-02 -1.480556e-02 1.000000e-01 + vertex -1.246980e-02 -1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal 5.981105e-01 8.014136e-01 -0.000000e+00 + outer loop + vertex -1.144233e-02 -1.640345e-02 8.000000e-02 + vertex -1.246980e-02 -1.563663e-02 8.000000e-02 + vertex -1.246980e-02 -1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal 5.981105e-01 8.014136e-01 0.000000e+00 + outer loop + vertex -1.144233e-02 -1.640345e-02 8.000000e-02 + vertex -1.246980e-02 -1.563663e-02 1.000000e-01 + vertex -1.144233e-02 -1.640345e-02 1.000000e-01 + endloop + endfacet + facet normal 5.455349e-01 8.380881e-01 -0.000000e+00 + outer loop + vertex -1.036785e-02 -1.710286e-02 8.000000e-02 + vertex -1.144233e-02 -1.640345e-02 8.000000e-02 + vertex -1.144233e-02 -1.640345e-02 1.000000e-01 + endloop + endfacet + facet normal 5.455349e-01 8.380881e-01 0.000000e+00 + outer loop + vertex -1.036785e-02 -1.710286e-02 8.000000e-02 + vertex -1.144233e-02 -1.640345e-02 1.000000e-01 + vertex -1.036785e-02 -1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal 4.907176e-01 8.713187e-01 -0.000000e+00 + outer loop + vertex -9.250766e-03 -1.773199e-02 8.000000e-02 + vertex -1.036785e-02 -1.710286e-02 8.000000e-02 + vertex -1.036785e-02 -1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal 4.907176e-01 8.713187e-01 0.000000e+00 + outer loop + vertex -9.250766e-03 -1.773199e-02 8.000000e-02 + vertex -1.036785e-02 -1.710286e-02 1.000000e-01 + vertex -9.250766e-03 -1.773199e-02 1.000000e-01 + endloop + endfacet + facet normal 4.338837e-01 9.009689e-01 -0.000000e+00 + outer loop + vertex -8.095667e-03 -1.828825e-02 8.000000e-02 + vertex -9.250766e-03 -1.773199e-02 8.000000e-02 + vertex -9.250766e-03 -1.773199e-02 1.000000e-01 + endloop + endfacet + facet normal 4.338837e-01 9.009689e-01 0.000000e+00 + outer loop + vertex -8.095667e-03 -1.828825e-02 8.000000e-02 + vertex -9.250766e-03 -1.773199e-02 1.000000e-01 + vertex -8.095667e-03 -1.828825e-02 1.000000e-01 + endloop + endfacet + facet normal 3.752670e-01 9.269168e-01 0.000000e+00 + outer loop + vertex -6.907301e-03 -1.876937e-02 8.000000e-02 + vertex -8.095667e-03 -1.828825e-02 1.000000e-01 + vertex -6.907301e-03 -1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal 3.752670e-01 9.269168e-01 -0.000000e+00 + outer loop + vertex -6.907301e-03 -1.876937e-02 8.000000e-02 + vertex -8.095667e-03 -1.828825e-02 8.000000e-02 + vertex -8.095667e-03 -1.828825e-02 1.000000e-01 + endloop + endfacet + facet normal 3.151082e-01 9.490557e-01 0.000000e+00 + outer loop + vertex -5.690552e-03 -1.917336e-02 8.000000e-02 + vertex -6.907301e-03 -1.876937e-02 1.000000e-01 + vertex -5.690552e-03 -1.917336e-02 1.000000e-01 + endloop + endfacet + facet normal 3.151082e-01 9.490557e-01 -0.000000e+00 + outer loop + vertex -5.690552e-03 -1.917336e-02 8.000000e-02 + vertex -6.907301e-03 -1.876937e-02 8.000000e-02 + vertex -6.907301e-03 -1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal 2.536546e-01 9.672949e-01 0.000000e+00 + outer loop + vertex -4.450419e-03 -1.949856e-02 8.000000e-02 + vertex -5.690552e-03 -1.917336e-02 1.000000e-01 + vertex -4.450419e-03 -1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal 2.536546e-01 9.672949e-01 -0.000000e+00 + outer loop + vertex -4.450419e-03 -1.949856e-02 8.000000e-02 + vertex -5.690552e-03 -1.917336e-02 8.000000e-02 + vertex -5.690552e-03 -1.917336e-02 1.000000e-01 + endloop + endfacet + facet normal 1.911586e-01 9.815592e-01 0.000000e+00 + outer loop + vertex -3.191998e-03 -1.974364e-02 8.000000e-02 + vertex -4.450419e-03 -1.949856e-02 1.000000e-01 + vertex -3.191998e-03 -1.974364e-02 1.000000e-01 + endloop + endfacet + facet normal 1.911586e-01 9.815592e-01 -0.000000e+00 + outer loop + vertex -3.191998e-03 -1.974364e-02 8.000000e-02 + vertex -4.450419e-03 -1.949856e-02 8.000000e-02 + vertex -4.450419e-03 -1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal 1.278772e-01 9.917900e-01 0.000000e+00 + outer loop + vertex -1.920461e-03 -1.990758e-02 8.000000e-02 + vertex -3.191998e-03 -1.974364e-02 1.000000e-01 + vertex -1.920461e-03 -1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal 1.278772e-01 9.917900e-01 -0.000000e+00 + outer loop + vertex -1.920461e-03 -1.990758e-02 8.000000e-02 + vertex -3.191998e-03 -1.974364e-02 8.000000e-02 + vertex -3.191998e-03 -1.974364e-02 1.000000e-01 + endloop + endfacet + facet normal 6.407022e-02 9.979454e-01 0.000000e+00 + outer loop + vertex -6.410316e-04 -1.998972e-02 8.000000e-02 + vertex -1.920461e-03 -1.990758e-02 1.000000e-01 + vertex -6.410316e-04 -1.998972e-02 1.000000e-01 + endloop + endfacet + facet normal 6.407022e-02 9.979454e-01 -0.000000e+00 + outer loop + vertex -6.410316e-04 -1.998972e-02 8.000000e-02 + vertex -1.920461e-03 -1.990758e-02 8.000000e-02 + vertex -1.920461e-03 -1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 1.000000e+00 -0.000000e+00 + outer loop + vertex 6.410316e-04 -1.998972e-02 8.000000e-02 + vertex -6.410316e-04 -1.998972e-02 1.000000e-01 + vertex 6.410316e-04 -1.998972e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 1.000000e+00 -0.000000e+00 + outer loop + vertex 6.410316e-04 -1.998972e-02 8.000000e-02 + vertex -6.410316e-04 -1.998972e-02 8.000000e-02 + vertex -6.410316e-04 -1.998972e-02 1.000000e-01 + endloop + endfacet + facet normal -6.407022e-02 9.979454e-01 0.000000e+00 + outer loop + vertex 1.920461e-03 -1.990758e-02 8.000000e-02 + vertex 6.410316e-04 -1.998972e-02 1.000000e-01 + vertex 1.920461e-03 -1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal -6.407022e-02 9.979454e-01 0.000000e+00 + outer loop + vertex 1.920461e-03 -1.990758e-02 8.000000e-02 + vertex 6.410316e-04 -1.998972e-02 8.000000e-02 + vertex 6.410316e-04 -1.998972e-02 1.000000e-01 + endloop + endfacet + facet normal -1.278772e-01 9.917900e-01 0.000000e+00 + outer loop + vertex 3.191998e-03 -1.974364e-02 8.000000e-02 + vertex 1.920461e-03 -1.990758e-02 8.000000e-02 + vertex 1.920461e-03 -1.990758e-02 1.000000e-01 + endloop + endfacet + facet normal -1.278772e-01 9.917900e-01 0.000000e+00 + outer loop + vertex 3.191998e-03 -1.974364e-02 8.000000e-02 + vertex 1.920461e-03 -1.990758e-02 1.000000e-01 + vertex 3.191998e-03 -1.974364e-02 1.000000e-01 + endloop + endfacet + facet normal -1.911586e-01 9.815592e-01 0.000000e+00 + outer loop + vertex 4.450419e-03 -1.949856e-02 8.000000e-02 + vertex 3.191998e-03 -1.974364e-02 8.000000e-02 + vertex 3.191998e-03 -1.974364e-02 1.000000e-01 + endloop + endfacet + facet normal -1.911586e-01 9.815592e-01 0.000000e+00 + outer loop + vertex 4.450419e-03 -1.949856e-02 8.000000e-02 + vertex 3.191998e-03 -1.974364e-02 1.000000e-01 + vertex 4.450419e-03 -1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal -2.536546e-01 9.672949e-01 0.000000e+00 + outer loop + vertex 5.690552e-03 -1.917336e-02 8.000000e-02 + vertex 4.450419e-03 -1.949856e-02 8.000000e-02 + vertex 4.450419e-03 -1.949856e-02 1.000000e-01 + endloop + endfacet + facet normal -2.536546e-01 9.672949e-01 0.000000e+00 + outer loop + vertex 5.690552e-03 -1.917336e-02 8.000000e-02 + vertex 4.450419e-03 -1.949856e-02 1.000000e-01 + vertex 5.690552e-03 -1.917336e-02 1.000000e-01 + endloop + endfacet + facet normal -3.151082e-01 9.490557e-01 0.000000e+00 + outer loop + vertex 6.907301e-03 -1.876937e-02 8.000000e-02 + vertex 5.690552e-03 -1.917336e-02 8.000000e-02 + vertex 5.690552e-03 -1.917336e-02 1.000000e-01 + endloop + endfacet + facet normal -3.151082e-01 9.490557e-01 0.000000e+00 + outer loop + vertex 6.907301e-03 -1.876937e-02 8.000000e-02 + vertex 5.690552e-03 -1.917336e-02 1.000000e-01 + vertex 6.907301e-03 -1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal -3.752670e-01 9.269168e-01 0.000000e+00 + outer loop + vertex 8.095667e-03 -1.828825e-02 8.000000e-02 + vertex 6.907301e-03 -1.876937e-02 8.000000e-02 + vertex 6.907301e-03 -1.876937e-02 1.000000e-01 + endloop + endfacet + facet normal -3.752670e-01 9.269168e-01 0.000000e+00 + outer loop + vertex 8.095667e-03 -1.828825e-02 8.000000e-02 + vertex 6.907301e-03 -1.876937e-02 1.000000e-01 + vertex 8.095667e-03 -1.828825e-02 1.000000e-01 + endloop + endfacet + facet normal -4.338837e-01 9.009689e-01 0.000000e+00 + outer loop + vertex 9.250766e-03 -1.773199e-02 8.000000e-02 + vertex 8.095667e-03 -1.828825e-02 8.000000e-02 + vertex 8.095667e-03 -1.828825e-02 1.000000e-01 + endloop + endfacet + facet normal -4.338837e-01 9.009689e-01 0.000000e+00 + outer loop + vertex 9.250766e-03 -1.773199e-02 8.000000e-02 + vertex 8.095667e-03 -1.828825e-02 1.000000e-01 + vertex 9.250766e-03 -1.773199e-02 1.000000e-01 + endloop + endfacet + facet normal -4.907176e-01 8.713187e-01 0.000000e+00 + outer loop + vertex 1.036785e-02 -1.710286e-02 8.000000e-02 + vertex 9.250766e-03 -1.773199e-02 8.000000e-02 + vertex 9.250766e-03 -1.773199e-02 1.000000e-01 + endloop + endfacet + facet normal -4.907176e-01 8.713187e-01 0.000000e+00 + outer loop + vertex 1.036785e-02 -1.710286e-02 8.000000e-02 + vertex 9.250766e-03 -1.773199e-02 1.000000e-01 + vertex 1.036785e-02 -1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal -5.455349e-01 8.380881e-01 0.000000e+00 + outer loop + vertex 1.144233e-02 -1.640345e-02 8.000000e-02 + vertex 1.036785e-02 -1.710286e-02 8.000000e-02 + vertex 1.036785e-02 -1.710286e-02 1.000000e-01 + endloop + endfacet + facet normal -5.455349e-01 8.380881e-01 0.000000e+00 + outer loop + vertex 1.144233e-02 -1.640345e-02 8.000000e-02 + vertex 1.036785e-02 -1.710286e-02 1.000000e-01 + vertex 1.144233e-02 -1.640345e-02 1.000000e-01 + endloop + endfacet + facet normal -5.981105e-01 8.014136e-01 0.000000e+00 + outer loop + vertex 1.246980e-02 -1.563663e-02 8.000000e-02 + vertex 1.144233e-02 -1.640345e-02 8.000000e-02 + vertex 1.144233e-02 -1.640345e-02 1.000000e-01 + endloop + endfacet + facet normal -5.981105e-01 8.014136e-01 0.000000e+00 + outer loop + vertex 1.246980e-02 -1.563663e-02 8.000000e-02 + vertex 1.144233e-02 -1.640345e-02 1.000000e-01 + vertex 1.246980e-02 -1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal -6.482284e-01 7.614460e-01 0.000000e+00 + outer loop + vertex 1.344602e-02 -1.480556e-02 8.000000e-02 + vertex 1.246980e-02 -1.563663e-02 8.000000e-02 + vertex 1.246980e-02 -1.563663e-02 1.000000e-01 + endloop + endfacet + facet normal -6.482284e-01 7.614460e-01 0.000000e+00 + outer loop + vertex 1.344602e-02 -1.480556e-02 8.000000e-02 + vertex 1.246980e-02 -1.563663e-02 1.000000e-01 + vertex 1.344602e-02 -1.480556e-02 1.000000e-01 + endloop + endfacet + facet normal -6.956826e-01 7.183494e-01 0.000000e+00 + outer loop + vertex 1.436699e-02 -1.391365e-02 8.000000e-02 + vertex 1.344602e-02 -1.480556e-02 8.000000e-02 + vertex 1.344602e-02 -1.480556e-02 1.000000e-01 + endloop + endfacet + facet normal -6.956826e-01 7.183494e-01 0.000000e+00 + outer loop + vertex 1.436699e-02 -1.391365e-02 8.000000e-02 + vertex 1.344602e-02 -1.480556e-02 1.000000e-01 + vertex 1.436699e-02 -1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal -7.402780e-01 6.723009e-01 0.000000e+00 + outer loop + vertex 1.522892e-02 -1.296457e-02 8.000000e-02 + vertex 1.436699e-02 -1.391365e-02 8.000000e-02 + vertex 1.436699e-02 -1.391365e-02 1.000000e-01 + endloop + endfacet + facet normal -7.402780e-01 6.723009e-01 0.000000e+00 + outer loop + vertex 1.522892e-02 -1.296457e-02 8.000000e-02 + vertex 1.436699e-02 -1.391365e-02 1.000000e-01 + vertex 1.522892e-02 -1.296457e-02 1.000000e-01 + endloop + endfacet + facet normal -7.818315e-01 6.234898e-01 0.000000e+00 + outer loop + vertex 1.602827e-02 -1.196221e-02 8.000000e-02 + vertex 1.522892e-02 -1.296457e-02 8.000000e-02 + vertex 1.522892e-02 -1.296457e-02 1.000000e-01 + endloop + endfacet + facet normal -7.818315e-01 6.234898e-01 0.000000e+00 + outer loop + vertex 1.602827e-02 -1.196221e-02 8.000000e-02 + vertex 1.522892e-02 -1.296457e-02 1.000000e-01 + vertex 1.602827e-02 -1.196221e-02 1.000000e-01 + endloop + endfacet + facet normal -8.201723e-01 5.721167e-01 0.000000e+00 + outer loop + vertex 1.676176e-02 -1.091070e-02 8.000000e-02 + vertex 1.602827e-02 -1.196221e-02 8.000000e-02 + vertex 1.602827e-02 -1.196221e-02 1.000000e-01 + endloop + endfacet + facet normal -8.201723e-01 5.721167e-01 0.000000e+00 + outer loop + vertex 1.676176e-02 -1.091070e-02 8.000000e-02 + vertex 1.602827e-02 -1.196221e-02 1.000000e-01 + vertex 1.676176e-02 -1.091070e-02 1.000000e-01 + endloop + endfacet + facet normal -8.551428e-01 5.183926e-01 0.000000e+00 + outer loop + vertex 1.742637e-02 -9.814351e-03 8.000000e-02 + vertex 1.676176e-02 -1.091070e-02 8.000000e-02 + vertex 1.676176e-02 -1.091070e-02 1.000000e-01 + endloop + endfacet + facet normal -8.551428e-01 5.183926e-01 0.000000e+00 + outer loop + vertex 1.742637e-02 -9.814351e-03 8.000000e-02 + vertex 1.676176e-02 -1.091070e-02 1.000000e-01 + vertex 1.742637e-02 -9.814351e-03 1.000000e-01 + endloop + endfacet + facet normal -8.865993e-01 4.625383e-01 0.000000e+00 + outer loop + vertex 1.801938e-02 -8.677675e-03 8.000000e-02 + vertex 1.742637e-02 -9.814351e-03 8.000000e-02 + vertex 1.742637e-02 -9.814351e-03 1.000000e-01 + endloop + endfacet + facet normal -8.865993e-01 4.625383e-01 0.000000e+00 + outer loop + vertex 1.801938e-02 -8.677675e-03 8.000000e-02 + vertex 1.742637e-02 -9.814351e-03 1.000000e-01 + vertex 1.801938e-02 -8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal -9.144126e-01 4.047833e-01 0.000000e+00 + outer loop + vertex 1.853834e-02 -7.505340e-03 8.000000e-02 + vertex 1.801938e-02 -8.677675e-03 8.000000e-02 + vertex 1.801938e-02 -8.677675e-03 1.000000e-01 + endloop + endfacet + facet normal -9.144126e-01 4.047833e-01 0.000000e+00 + outer loop + vertex 1.853834e-02 -7.505340e-03 8.000000e-02 + vertex 1.801938e-02 -8.677675e-03 1.000000e-01 + vertex 1.853834e-02 -7.505340e-03 1.000000e-01 + endloop + endfacet +endsolid diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r3.stl b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r3.stl new file mode 100644 index 00000000..1017224d --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r3.stl @@ -0,0 +1,7114 @@ +solid + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.993926e-02 2.203510e-03 8.000000e-02 + vertex 5.993958e-02 2.691890e-03 8.000000e-02 + vertex 4.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.303174e-03 -3.986338e-02 8.000000e-02 + vertex -2.691890e-03 -5.993958e-02 8.000000e-02 + vertex -5.378359e-03 -5.975846e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.303174e-03 -3.986338e-02 8.000000e-02 + vertex -1.102174e-03 -3.998481e-02 8.000000e-02 + vertex -2.691890e-03 -5.993958e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.975723e-02 4.400329e-03 8.000000e-02 + vertex 5.945699e-02 8.053996e-03 8.000000e-02 + vertex 5.975846e-02 5.378359e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.975723e-02 4.400329e-03 8.000000e-02 + vertex 5.975846e-02 5.378359e-03 8.000000e-02 + vertex 3.993926e-02 2.203510e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.494142e-03 -3.962088e-02 8.000000e-02 + vertex -3.303174e-03 -3.986338e-02 8.000000e-02 + vertex -5.378359e-03 -5.975846e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.494142e-03 -3.962088e-02 8.000000e-02 + vertex -8.053996e-03 -5.945699e-02 8.000000e-02 + vertex -1.071341e-02 -5.903578e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.494142e-03 -3.962088e-02 8.000000e-02 + vertex -5.378359e-03 -5.975846e-02 8.000000e-02 + vertex -8.053996e-03 -5.945699e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.945445e-02 6.583784e-03 8.000000e-02 + vertex 5.903578e-02 1.071341e-02 8.000000e-02 + vertex 5.945699e-02 8.053996e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.945445e-02 6.583784e-03 8.000000e-02 + vertex 5.945699e-02 8.053996e-03 8.000000e-02 + vertex 3.975723e-02 4.400329e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.993958e-02 -2.691890e-03 8.000000e-02 + vertex -4.000000e-02 4.898587e-18 8.000000e-02 + vertex -3.993926e-02 -2.203510e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.993958e-02 -2.691890e-03 8.000000e-02 + vertex -3.993926e-02 -2.203510e-03 8.000000e-02 + vertex -5.975846e-02 -5.378359e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.691890e-03 5.993958e-02 8.000000e-02 + vertex 3.303174e-03 3.986338e-02 8.000000e-02 + vertex 1.102174e-03 3.998481e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.668425e-03 -3.925806e-02 8.000000e-02 + vertex -1.071341e-02 -5.903578e-02 8.000000e-02 + vertex -1.335126e-02 -5.849567e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.668425e-03 -3.925806e-02 8.000000e-02 + vertex -5.494142e-03 -3.962088e-02 8.000000e-02 + vertex -1.071341e-02 -5.903578e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.691890e-03 5.993958e-02 8.000000e-02 + vertex 5.378359e-03 5.975846e-02 8.000000e-02 + vertex 3.303174e-03 3.986338e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.673940e-18 6.000000e-02 8.000000e-02 + vertex 1.102174e-03 3.998481e-02 8.000000e-02 + vertex -1.102174e-03 3.998481e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.903186e-02 8.747244e-03 8.000000e-02 + vertex 5.849567e-02 1.335126e-02 8.000000e-02 + vertex 5.903578e-02 1.071341e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.903186e-02 8.747244e-03 8.000000e-02 + vertex 5.783777e-02 1.596221e-02 8.000000e-02 + vertex 5.849567e-02 1.335126e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.903186e-02 8.747244e-03 8.000000e-02 + vertex 5.903578e-02 1.071341e-02 8.000000e-02 + vertex 3.945445e-02 6.583784e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.819419e-03 -3.877601e-02 8.000000e-02 + vertex -7.668425e-03 -3.925806e-02 8.000000e-02 + vertex -1.335126e-02 -5.849567e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.673940e-18 6.000000e-02 8.000000e-02 + vertex 2.691890e-03 5.993958e-02 8.000000e-02 + vertex 1.102174e-03 3.998481e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -9.819419e-03 -3.877601e-02 8.000000e-02 + vertex -1.335126e-02 -5.849567e-02 8.000000e-02 + vertex -1.596221e-02 -5.783777e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.849072e-02 1.088414e-02 8.000000e-02 + vertex 5.783777e-02 1.596221e-02 8.000000e-02 + vertex 3.903186e-02 8.747244e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.849072e-02 1.088414e-02 8.000000e-02 + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + vertex 5.783777e-02 1.596221e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.000000e-02 7.347881e-18 8.000000e-02 + vertex -4.000000e-02 4.898587e-18 8.000000e-02 + vertex -5.993958e-02 -2.691890e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.194059e-02 -3.817620e-02 8.000000e-02 + vertex -1.596221e-02 -5.783777e-02 8.000000e-02 + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.194059e-02 -3.817620e-02 8.000000e-02 + vertex -9.819419e-03 -3.877601e-02 8.000000e-02 + vertex -1.596221e-02 -5.783777e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.993958e-02 2.691890e-03 8.000000e-02 + vertex -3.993926e-02 2.203510e-03 8.000000e-02 + vertex -4.000000e-02 4.898587e-18 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.993958e-02 2.691890e-03 8.000000e-02 + vertex -4.000000e-02 4.898587e-18 8.000000e-02 + vertex -6.000000e-02 7.347881e-18 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.691890e-03 5.993958e-02 8.000000e-02 + vertex -1.102174e-03 3.998481e-02 8.000000e-02 + vertex -3.303174e-03 3.986338e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.783269e-02 1.298798e-02 8.000000e-02 + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + vertex 3.849072e-02 1.088414e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.783269e-02 1.298798e-02 8.000000e-02 + vertex 5.617409e-02 2.108249e-02 8.000000e-02 + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.691890e-03 5.993958e-02 8.000000e-02 + vertex 3.673940e-18 6.000000e-02 8.000000e-02 + vertex -1.102174e-03 3.998481e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.402550e-02 -3.746045e-02 8.000000e-02 + vertex -1.194059e-02 -3.817620e-02 8.000000e-02 + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.402550e-02 -3.746045e-02 8.000000e-02 + vertex -2.108249e-02 -5.617409e-02 8.000000e-02 + vertex -2.358150e-02 -5.517167e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.402550e-02 -3.746045e-02 8.000000e-02 + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + vertex -2.108249e-02 -5.617409e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.975846e-02 5.378359e-03 8.000000e-02 + vertex -3.975723e-02 4.400329e-03 8.000000e-02 + vertex -3.993926e-02 2.203510e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.975846e-02 5.378359e-03 8.000000e-02 + vertex -3.993926e-02 2.203510e-03 8.000000e-02 + vertex -5.993958e-02 2.691890e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.378359e-03 5.975846e-02 8.000000e-02 + vertex -3.303174e-03 3.986338e-02 8.000000e-02 + vertex -5.494142e-03 3.962088e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.705976e-02 1.505237e-02 8.000000e-02 + vertex 5.517167e-02 2.358150e-02 8.000000e-02 + vertex 5.617409e-02 2.108249e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.705976e-02 1.505237e-02 8.000000e-02 + vertex 5.617409e-02 2.108249e-02 8.000000e-02 + vertex 3.783269e-02 1.298798e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.378359e-03 5.975846e-02 8.000000e-02 + vertex -2.691890e-03 5.993958e-02 8.000000e-02 + vertex -3.303174e-03 3.986338e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.606782e-02 -3.663093e-02 8.000000e-02 + vertex -2.358150e-02 -5.517167e-02 8.000000e-02 + vertex -2.603302e-02 -5.405813e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.606782e-02 -3.663093e-02 8.000000e-02 + vertex -1.402550e-02 -3.746045e-02 8.000000e-02 + vertex -2.358150e-02 -5.517167e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.053996e-03 5.945699e-02 8.000000e-02 + vertex -5.378359e-03 5.975846e-02 8.000000e-02 + vertex -5.494142e-03 3.962088e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.945699e-02 8.053996e-03 8.000000e-02 + vertex -3.975723e-02 4.400329e-03 8.000000e-02 + vertex -5.975846e-02 5.378359e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.617429e-02 1.707106e-02 8.000000e-02 + vertex 5.405813e-02 2.603302e-02 8.000000e-02 + vertex 5.517167e-02 2.358150e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.617429e-02 1.707106e-02 8.000000e-02 + vertex 5.517167e-02 2.358150e-02 8.000000e-02 + vertex 3.705976e-02 1.505237e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.806133e-02 -3.569017e-02 8.000000e-02 + vertex -2.603302e-02 -5.405813e-02 8.000000e-02 + vertex -2.843212e-02 -5.283573e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.945699e-02 8.053996e-03 8.000000e-02 + vertex -3.945445e-02 6.583784e-03 8.000000e-02 + vertex -3.975723e-02 4.400329e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.806133e-02 -3.569017e-02 8.000000e-02 + vertex -1.606782e-02 -3.663093e-02 8.000000e-02 + vertex -2.603302e-02 -5.405813e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.903578e-02 1.071341e-02 8.000000e-02 + vertex -3.945445e-02 6.583784e-03 8.000000e-02 + vertex -5.945699e-02 8.053996e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.903578e-02 1.071341e-02 8.000000e-02 + vertex -3.903186e-02 8.747244e-03 8.000000e-02 + vertex -3.945445e-02 6.583784e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.071341e-02 5.903578e-02 8.000000e-02 + vertex -5.494142e-03 3.962088e-02 8.000000e-02 + vertex -7.668425e-03 3.925806e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.517895e-02 1.903790e-02 8.000000e-02 + vertex 5.283573e-02 2.843212e-02 8.000000e-02 + vertex 5.405813e-02 2.603302e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.517895e-02 1.903790e-02 8.000000e-02 + vertex 5.150693e-02 3.077396e-02 8.000000e-02 + vertex 5.283573e-02 2.843212e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.517895e-02 1.903790e-02 8.000000e-02 + vertex 5.405813e-02 2.603302e-02 8.000000e-02 + vertex 3.617429e-02 1.707106e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.000000e-02 -3.464102e-02 8.000000e-02 + vertex -2.843212e-02 -5.283573e-02 8.000000e-02 + vertex -3.077396e-02 -5.150693e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.071341e-02 5.903578e-02 8.000000e-02 + vertex -8.053996e-03 5.945699e-02 8.000000e-02 + vertex -5.494142e-03 3.962088e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.000000e-02 -3.464102e-02 8.000000e-02 + vertex -1.806133e-02 -3.569017e-02 8.000000e-02 + vertex -2.843212e-02 -5.283573e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.335126e-02 5.849567e-02 8.000000e-02 + vertex -7.668425e-03 3.925806e-02 8.000000e-02 + vertex -9.819419e-03 3.877601e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.335126e-02 5.849567e-02 8.000000e-02 + vertex -1.071341e-02 5.903578e-02 8.000000e-02 + vertex -7.668425e-03 3.925806e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.849567e-02 1.335126e-02 8.000000e-02 + vertex -3.903186e-02 8.747244e-03 8.000000e-02 + vertex -5.903578e-02 1.071341e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.407678e-02 2.094692e-02 8.000000e-02 + vertex 5.007440e-02 3.305382e-02 8.000000e-02 + vertex 5.150693e-02 3.077396e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.407678e-02 2.094692e-02 8.000000e-02 + vertex 5.150693e-02 3.077396e-02 8.000000e-02 + vertex 3.517895e-02 1.903790e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.187793e-02 -3.348666e-02 8.000000e-02 + vertex -3.305382e-02 -5.007440e-02 8.000000e-02 + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.187793e-02 -3.348666e-02 8.000000e-02 + vertex -3.077396e-02 -5.150693e-02 8.000000e-02 + vertex -3.305382e-02 -5.007440e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.596221e-02 5.783777e-02 8.000000e-02 + vertex -9.819419e-03 3.877601e-02 8.000000e-02 + vertex -1.194059e-02 3.817620e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.187793e-02 -3.348666e-02 8.000000e-02 + vertex -2.000000e-02 -3.464102e-02 8.000000e-02 + vertex -3.077396e-02 -5.150693e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.596221e-02 5.783777e-02 8.000000e-02 + vertex -1.335126e-02 5.849567e-02 8.000000e-02 + vertex -9.819419e-03 3.877601e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.287111e-02 2.279232e-02 8.000000e-02 + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + vertex 5.007440e-02 3.305382e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.287111e-02 2.279232e-02 8.000000e-02 + vertex 5.007440e-02 3.305382e-02 8.000000e-02 + vertex 3.407678e-02 2.094692e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.783777e-02 1.596221e-02 8.000000e-02 + vertex -3.849072e-02 1.088414e-02 8.000000e-02 + vertex -3.903186e-02 8.747244e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.783777e-02 1.596221e-02 8.000000e-02 + vertex -3.903186e-02 8.747244e-03 8.000000e-02 + vertex -5.849567e-02 1.335126e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + vertex -3.849072e-02 1.088414e-02 8.000000e-02 + vertex -5.783777e-02 1.596221e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.368941e-02 -3.223060e-02 8.000000e-02 + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + vertex -3.740939e-02 -4.690989e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.368941e-02 -3.223060e-02 8.000000e-02 + vertex -2.187793e-02 -3.348666e-02 8.000000e-02 + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + vertex -3.783269e-02 1.298798e-02 8.000000e-02 + vertex -3.849072e-02 1.088414e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.156562e-02 2.456851e-02 8.000000e-02 + vertex 4.690989e-02 3.740939e-02 8.000000e-02 + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.156562e-02 2.456851e-02 8.000000e-02 + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + vertex 3.287111e-02 2.279232e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + vertex -1.194059e-02 3.817620e-02 8.000000e-02 + vertex -1.402550e-02 3.746045e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.867130e-02 -2.789187e-02 8.000000e-02 + vertex 4.336769e-02 -4.146376e-02 8.000000e-02 + vertex 4.146376e-02 -4.336769e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + vertex -1.596221e-02 5.783777e-02 8.000000e-02 + vertex -1.194059e-02 3.817620e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.542895e-02 -3.087667e-02 8.000000e-02 + vertex -3.740939e-02 -4.690989e-02 8.000000e-02 + vertex -3.947632e-02 -4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.617409e-02 2.108249e-02 8.000000e-02 + vertex -3.783269e-02 1.298798e-02 8.000000e-02 + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.542895e-02 -3.087667e-02 8.000000e-02 + vertex -2.368941e-02 -3.223060e-02 8.000000e-02 + vertex -3.740939e-02 -4.690989e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.016426e-02 2.627008e-02 8.000000e-02 + vertex 4.518429e-02 3.947632e-02 8.000000e-02 + vertex 4.690989e-02 3.740939e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.617409e-02 2.108249e-02 8.000000e-02 + vertex -3.705976e-02 1.505237e-02 8.000000e-02 + vertex -3.783269e-02 1.298798e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.016426e-02 2.627008e-02 8.000000e-02 + vertex 4.690989e-02 3.740939e-02 8.000000e-02 + vertex 3.156562e-02 2.456851e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.709126e-02 -2.942896e-02 8.000000e-02 + vertex 2.867130e-02 -2.789187e-02 8.000000e-02 + vertex 4.146376e-02 -4.336769e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.709126e-02 -2.942896e-02 8.000000e-02 + vertex -2.542895e-02 -3.087667e-02 8.000000e-02 + vertex -3.947632e-02 -4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.146376e-02 -4.336769e-02 8.000000e-02 + vertex -2.709126e-02 -2.942896e-02 8.000000e-02 + vertex -3.947632e-02 -4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.108249e-02 5.617409e-02 8.000000e-02 + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + vertex -1.402550e-02 3.746045e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.358150e-02 5.517167e-02 8.000000e-02 + vertex -2.108249e-02 5.617409e-02 8.000000e-02 + vertex -1.402550e-02 3.746045e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.336769e-02 4.146376e-02 8.000000e-02 + vertex 4.518429e-02 3.947632e-02 8.000000e-02 + vertex 3.016426e-02 2.627008e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.358150e-02 5.517167e-02 8.000000e-02 + vertex -1.402550e-02 3.746045e-02 8.000000e-02 + vertex -1.606782e-02 3.663093e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.867130e-02 2.789187e-02 8.000000e-02 + vertex 4.336769e-02 4.146376e-02 8.000000e-02 + vertex 3.016426e-02 2.627008e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.709126e-02 -2.942896e-02 8.000000e-02 + vertex 4.146376e-02 -4.336769e-02 8.000000e-02 + vertex 3.947632e-02 -4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.517167e-02 2.358150e-02 8.000000e-02 + vertex -3.705976e-02 1.505237e-02 8.000000e-02 + vertex -5.617409e-02 2.108249e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.016426e-02 -2.627008e-02 8.000000e-02 + vertex 4.518429e-02 -3.947632e-02 8.000000e-02 + vertex 4.336769e-02 -4.146376e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.016426e-02 -2.627008e-02 8.000000e-02 + vertex 4.690989e-02 -3.740939e-02 8.000000e-02 + vertex 4.518429e-02 -3.947632e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.867130e-02 -2.789187e-02 8.000000e-02 + vertex -2.709126e-02 -2.942896e-02 8.000000e-02 + vertex -4.146376e-02 -4.336769e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.146376e-02 4.336769e-02 8.000000e-02 + vertex 4.336769e-02 4.146376e-02 8.000000e-02 + vertex 2.867130e-02 2.789187e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.517167e-02 2.358150e-02 8.000000e-02 + vertex -3.617429e-02 1.707106e-02 8.000000e-02 + vertex -3.705976e-02 1.505237e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.336769e-02 -4.146376e-02 8.000000e-02 + vertex -2.867130e-02 -2.789187e-02 8.000000e-02 + vertex -4.146376e-02 -4.336769e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.405813e-02 2.603302e-02 8.000000e-02 + vertex -3.617429e-02 1.707106e-02 8.000000e-02 + vertex -5.517167e-02 2.358150e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.709126e-02 2.942896e-02 8.000000e-02 + vertex 4.146376e-02 4.336769e-02 8.000000e-02 + vertex 2.867130e-02 2.789187e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.016426e-02 -2.627008e-02 8.000000e-02 + vertex 4.336769e-02 -4.146376e-02 8.000000e-02 + vertex 2.867130e-02 -2.789187e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.405813e-02 2.603302e-02 8.000000e-02 + vertex -3.517895e-02 1.903790e-02 8.000000e-02 + vertex -3.617429e-02 1.707106e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.016426e-02 -2.627008e-02 8.000000e-02 + vertex -2.867130e-02 -2.789187e-02 8.000000e-02 + vertex -4.336769e-02 -4.146376e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.603302e-02 5.405813e-02 8.000000e-02 + vertex -1.606782e-02 3.663093e-02 8.000000e-02 + vertex -1.806133e-02 3.569017e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.603302e-02 5.405813e-02 8.000000e-02 + vertex -2.358150e-02 5.517167e-02 8.000000e-02 + vertex -1.606782e-02 3.663093e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.283573e-02 2.843212e-02 8.000000e-02 + vertex -3.517895e-02 1.903790e-02 8.000000e-02 + vertex -5.405813e-02 2.603302e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.542895e-02 -3.087667e-02 8.000000e-02 + vertex 3.947632e-02 -4.518429e-02 8.000000e-02 + vertex 3.740939e-02 -4.690989e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.542895e-02 -3.087667e-02 8.000000e-02 + vertex 2.709126e-02 -2.942896e-02 8.000000e-02 + vertex 3.947632e-02 -4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.947632e-02 4.518429e-02 8.000000e-02 + vertex 2.709126e-02 2.942896e-02 8.000000e-02 + vertex 2.542895e-02 3.087667e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.947632e-02 4.518429e-02 8.000000e-02 + vertex 4.146376e-02 4.336769e-02 8.000000e-02 + vertex 2.709126e-02 2.942896e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.156562e-02 -2.456851e-02 8.000000e-02 + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + vertex 4.690989e-02 -3.740939e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.843212e-02 5.283573e-02 8.000000e-02 + vertex -2.603302e-02 5.405813e-02 8.000000e-02 + vertex -1.806133e-02 3.569017e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.843212e-02 5.283573e-02 8.000000e-02 + vertex -1.806133e-02 3.569017e-02 8.000000e-02 + vertex -2.000000e-02 3.464102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.518429e-02 -3.947632e-02 8.000000e-02 + vertex -3.016426e-02 -2.627008e-02 8.000000e-02 + vertex -4.336769e-02 -4.146376e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.150693e-02 3.077396e-02 8.000000e-02 + vertex -3.517895e-02 1.903790e-02 8.000000e-02 + vertex -5.283573e-02 2.843212e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.740939e-02 4.690989e-02 8.000000e-02 + vertex 2.542895e-02 3.087667e-02 8.000000e-02 + vertex 2.368941e-02 3.223060e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.156562e-02 -2.456851e-02 8.000000e-02 + vertex 4.690989e-02 -3.740939e-02 8.000000e-02 + vertex 3.016426e-02 -2.627008e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.150693e-02 3.077396e-02 8.000000e-02 + vertex -3.407678e-02 2.094692e-02 8.000000e-02 + vertex -3.517895e-02 1.903790e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.740939e-02 4.690989e-02 8.000000e-02 + vertex 3.947632e-02 4.518429e-02 8.000000e-02 + vertex 2.542895e-02 3.087667e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.077396e-02 5.150693e-02 8.000000e-02 + vertex -2.843212e-02 5.283573e-02 8.000000e-02 + vertex -2.000000e-02 3.464102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.690989e-02 -3.740939e-02 8.000000e-02 + vertex -3.016426e-02 -2.627008e-02 8.000000e-02 + vertex -4.518429e-02 -3.947632e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.077396e-02 5.150693e-02 8.000000e-02 + vertex -2.000000e-02 3.464102e-02 8.000000e-02 + vertex -2.187793e-02 3.348666e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.690989e-02 -3.740939e-02 8.000000e-02 + vertex -3.156562e-02 -2.456851e-02 8.000000e-02 + vertex -3.016426e-02 -2.627008e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.007440e-02 3.305382e-02 8.000000e-02 + vertex -3.407678e-02 2.094692e-02 8.000000e-02 + vertex -5.150693e-02 3.077396e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.368941e-02 -3.223060e-02 8.000000e-02 + vertex 3.740939e-02 -4.690989e-02 8.000000e-02 + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.007440e-02 3.305382e-02 8.000000e-02 + vertex -3.287111e-02 2.279232e-02 8.000000e-02 + vertex -3.407678e-02 2.094692e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.368941e-02 -3.223060e-02 8.000000e-02 + vertex 2.542895e-02 -3.087667e-02 8.000000e-02 + vertex 3.740939e-02 -4.690989e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.305382e-02 5.007440e-02 8.000000e-02 + vertex -3.077396e-02 5.150693e-02 8.000000e-02 + vertex -2.187793e-02 3.348666e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.287111e-02 -2.279232e-02 8.000000e-02 + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + vertex 3.156562e-02 -2.456851e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.287111e-02 -2.279232e-02 8.000000e-02 + vertex 5.007440e-02 -3.305382e-02 8.000000e-02 + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + vertex -3.305382e-02 5.007440e-02 8.000000e-02 + vertex -2.187793e-02 3.348666e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + vertex -2.187793e-02 3.348666e-02 8.000000e-02 + vertex -2.368941e-02 3.223060e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + vertex -3.156562e-02 -2.456851e-02 8.000000e-02 + vertex -4.690989e-02 -3.740939e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + vertex -3.287111e-02 2.279232e-02 8.000000e-02 + vertex -5.007440e-02 3.305382e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + vertex -3.287111e-02 -2.279232e-02 8.000000e-02 + vertex -3.156562e-02 -2.456851e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + vertex 2.368941e-02 3.223060e-02 8.000000e-02 + vertex 2.187793e-02 3.348666e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + vertex -3.156562e-02 2.456851e-02 8.000000e-02 + vertex -3.287111e-02 2.279232e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + vertex 3.740939e-02 4.690989e-02 8.000000e-02 + vertex 2.368941e-02 3.223060e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.187793e-02 -3.348666e-02 8.000000e-02 + vertex 2.368941e-02 -3.223060e-02 8.000000e-02 + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.690989e-02 3.740939e-02 8.000000e-02 + vertex -3.016426e-02 2.627008e-02 8.000000e-02 + vertex -3.156562e-02 2.456851e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.690989e-02 3.740939e-02 8.000000e-02 + vertex -3.156562e-02 2.456851e-02 8.000000e-02 + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.740939e-02 4.690989e-02 8.000000e-02 + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + vertex -2.368941e-02 3.223060e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.740939e-02 4.690989e-02 8.000000e-02 + vertex -2.368941e-02 3.223060e-02 8.000000e-02 + vertex -2.542895e-02 3.087667e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.305382e-02 5.007440e-02 8.000000e-02 + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + vertex 2.187793e-02 3.348666e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.187793e-02 -3.348666e-02 8.000000e-02 + vertex 3.305382e-02 -5.007440e-02 8.000000e-02 + vertex 3.077396e-02 -5.150693e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.187793e-02 -3.348666e-02 8.000000e-02 + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + vertex 3.305382e-02 -5.007440e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.518429e-02 3.947632e-02 8.000000e-02 + vertex -3.016426e-02 2.627008e-02 8.000000e-02 + vertex -4.690989e-02 3.740939e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.947632e-02 4.518429e-02 8.000000e-02 + vertex -2.542895e-02 3.087667e-02 8.000000e-02 + vertex -2.709126e-02 2.942896e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.007440e-02 -3.305382e-02 8.000000e-02 + vertex -3.287111e-02 -2.279232e-02 8.000000e-02 + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.007440e-02 -3.305382e-02 8.000000e-02 + vertex -3.407678e-02 -2.094692e-02 8.000000e-02 + vertex -3.287111e-02 -2.279232e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.947632e-02 4.518429e-02 8.000000e-02 + vertex -3.740939e-02 4.690989e-02 8.000000e-02 + vertex -2.542895e-02 3.087667e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.407678e-02 -2.094692e-02 8.000000e-02 + vertex 5.150693e-02 -3.077396e-02 8.000000e-02 + vertex 5.007440e-02 -3.305382e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.336769e-02 4.146376e-02 8.000000e-02 + vertex -2.867130e-02 2.789187e-02 8.000000e-02 + vertex -3.016426e-02 2.627008e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.336769e-02 4.146376e-02 8.000000e-02 + vertex -3.016426e-02 2.627008e-02 8.000000e-02 + vertex -4.518429e-02 3.947632e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.146376e-02 4.336769e-02 8.000000e-02 + vertex -2.709126e-02 2.942896e-02 8.000000e-02 + vertex -2.867130e-02 2.789187e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.146376e-02 4.336769e-02 8.000000e-02 + vertex -2.867130e-02 2.789187e-02 8.000000e-02 + vertex -4.336769e-02 4.146376e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.146376e-02 4.336769e-02 8.000000e-02 + vertex -3.947632e-02 4.518429e-02 8.000000e-02 + vertex -2.709126e-02 2.942896e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.407678e-02 -2.094692e-02 8.000000e-02 + vertex 5.007440e-02 -3.305382e-02 8.000000e-02 + vertex 3.287111e-02 -2.279232e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.150693e-02 -3.077396e-02 8.000000e-02 + vertex -3.407678e-02 -2.094692e-02 8.000000e-02 + vertex -5.007440e-02 -3.305382e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.000000e-02 -3.464102e-02 8.000000e-02 + vertex 2.187793e-02 -3.348666e-02 8.000000e-02 + vertex 3.077396e-02 -5.150693e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.150693e-02 -3.077396e-02 8.000000e-02 + vertex -3.517895e-02 -1.903790e-02 8.000000e-02 + vertex -3.407678e-02 -2.094692e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.077396e-02 5.150693e-02 8.000000e-02 + vertex 2.187793e-02 3.348666e-02 8.000000e-02 + vertex 2.000000e-02 3.464102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.077396e-02 5.150693e-02 8.000000e-02 + vertex 3.305382e-02 5.007440e-02 8.000000e-02 + vertex 2.187793e-02 3.348666e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.000000e-02 -3.464102e-02 8.000000e-02 + vertex 3.077396e-02 -5.150693e-02 8.000000e-02 + vertex 2.843212e-02 -5.283573e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.843212e-02 5.283573e-02 8.000000e-02 + vertex 2.000000e-02 3.464102e-02 8.000000e-02 + vertex 1.806133e-02 3.569017e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.843212e-02 5.283573e-02 8.000000e-02 + vertex 3.077396e-02 5.150693e-02 8.000000e-02 + vertex 2.000000e-02 3.464102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.517895e-02 -1.903790e-02 8.000000e-02 + vertex 5.283573e-02 -2.843212e-02 8.000000e-02 + vertex 5.150693e-02 -3.077396e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.517895e-02 -1.903790e-02 8.000000e-02 + vertex 5.405813e-02 -2.603302e-02 8.000000e-02 + vertex 5.283573e-02 -2.843212e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.283573e-02 -2.843212e-02 8.000000e-02 + vertex -3.517895e-02 -1.903790e-02 8.000000e-02 + vertex -5.150693e-02 -3.077396e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.517895e-02 -1.903790e-02 8.000000e-02 + vertex 5.150693e-02 -3.077396e-02 8.000000e-02 + vertex 3.407678e-02 -2.094692e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.405813e-02 -2.603302e-02 8.000000e-02 + vertex -3.617429e-02 -1.707106e-02 8.000000e-02 + vertex -3.517895e-02 -1.903790e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.405813e-02 -2.603302e-02 8.000000e-02 + vertex -3.517895e-02 -1.903790e-02 8.000000e-02 + vertex -5.283573e-02 -2.843212e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.806133e-02 -3.569017e-02 8.000000e-02 + vertex 2.843212e-02 -5.283573e-02 8.000000e-02 + vertex 2.603302e-02 -5.405813e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.603302e-02 5.405813e-02 8.000000e-02 + vertex 1.806133e-02 3.569017e-02 8.000000e-02 + vertex 1.606782e-02 3.663093e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.806133e-02 -3.569017e-02 8.000000e-02 + vertex 2.000000e-02 -3.464102e-02 8.000000e-02 + vertex 2.843212e-02 -5.283573e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.603302e-02 5.405813e-02 8.000000e-02 + vertex 2.843212e-02 5.283573e-02 8.000000e-02 + vertex 1.806133e-02 3.569017e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.617429e-02 -1.707106e-02 8.000000e-02 + vertex 5.517167e-02 -2.358150e-02 8.000000e-02 + vertex 5.405813e-02 -2.603302e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.617429e-02 -1.707106e-02 8.000000e-02 + vertex 5.405813e-02 -2.603302e-02 8.000000e-02 + vertex 3.517895e-02 -1.903790e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.606782e-02 -3.663093e-02 8.000000e-02 + vertex 1.806133e-02 -3.569017e-02 8.000000e-02 + vertex 2.603302e-02 -5.405813e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.517167e-02 -2.358150e-02 8.000000e-02 + vertex -3.705976e-02 -1.505237e-02 8.000000e-02 + vertex -3.617429e-02 -1.707106e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.517167e-02 -2.358150e-02 8.000000e-02 + vertex -3.617429e-02 -1.707106e-02 8.000000e-02 + vertex -5.405813e-02 -2.603302e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.358150e-02 5.517167e-02 8.000000e-02 + vertex 1.606782e-02 3.663093e-02 8.000000e-02 + vertex 1.402550e-02 3.746045e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.606782e-02 -3.663093e-02 8.000000e-02 + vertex 2.603302e-02 -5.405813e-02 8.000000e-02 + vertex 2.358150e-02 -5.517167e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.358150e-02 5.517167e-02 8.000000e-02 + vertex 2.603302e-02 5.405813e-02 8.000000e-02 + vertex 1.606782e-02 3.663093e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.705976e-02 -1.505237e-02 8.000000e-02 + vertex 5.617409e-02 -2.108249e-02 8.000000e-02 + vertex 5.517167e-02 -2.358150e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.705976e-02 -1.505237e-02 8.000000e-02 + vertex 5.517167e-02 -2.358150e-02 8.000000e-02 + vertex 3.617429e-02 -1.707106e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.108249e-02 5.617409e-02 8.000000e-02 + vertex 2.358150e-02 5.517167e-02 8.000000e-02 + vertex 1.402550e-02 3.746045e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.617409e-02 -2.108249e-02 8.000000e-02 + vertex -3.783269e-02 -1.298798e-02 8.000000e-02 + vertex -3.705976e-02 -1.505237e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.617409e-02 -2.108249e-02 8.000000e-02 + vertex -3.705976e-02 -1.505237e-02 8.000000e-02 + vertex -5.517167e-02 -2.358150e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.402550e-02 -3.746045e-02 8.000000e-02 + vertex 2.108249e-02 -5.617409e-02 8.000000e-02 + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.402550e-02 -3.746045e-02 8.000000e-02 + vertex 2.358150e-02 -5.517167e-02 8.000000e-02 + vertex 2.108249e-02 -5.617409e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.402550e-02 -3.746045e-02 8.000000e-02 + vertex 1.606782e-02 -3.663093e-02 8.000000e-02 + vertex 2.358150e-02 -5.517167e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + vertex 1.402550e-02 3.746045e-02 8.000000e-02 + vertex 1.194059e-02 3.817620e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + vertex 2.108249e-02 5.617409e-02 8.000000e-02 + vertex 1.402550e-02 3.746045e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.783269e-02 -1.298798e-02 8.000000e-02 + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + vertex 5.617409e-02 -2.108249e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + vertex -3.849072e-02 -1.088414e-02 8.000000e-02 + vertex -3.783269e-02 -1.298798e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + vertex -3.783269e-02 -1.298798e-02 8.000000e-02 + vertex -5.617409e-02 -2.108249e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.783269e-02 -1.298798e-02 8.000000e-02 + vertex 5.617409e-02 -2.108249e-02 8.000000e-02 + vertex 3.705976e-02 -1.505237e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.194059e-02 -3.817620e-02 8.000000e-02 + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + vertex 1.596221e-02 -5.783777e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.194059e-02 -3.817620e-02 8.000000e-02 + vertex 1.402550e-02 -3.746045e-02 8.000000e-02 + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.596221e-02 5.783777e-02 8.000000e-02 + vertex 1.194059e-02 3.817620e-02 8.000000e-02 + vertex 9.819419e-03 3.877601e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.596221e-02 5.783777e-02 8.000000e-02 + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + vertex 1.194059e-02 3.817620e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.849072e-02 -1.088414e-02 8.000000e-02 + vertex 5.783777e-02 -1.596221e-02 8.000000e-02 + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.783777e-02 -1.596221e-02 8.000000e-02 + vertex -3.849072e-02 -1.088414e-02 8.000000e-02 + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.783777e-02 -1.596221e-02 8.000000e-02 + vertex -3.903186e-02 -8.747244e-03 8.000000e-02 + vertex -3.849072e-02 -1.088414e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.849072e-02 -1.088414e-02 8.000000e-02 + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + vertex 3.783269e-02 -1.298798e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 9.819419e-03 -3.877601e-02 8.000000e-02 + vertex 1.596221e-02 -5.783777e-02 8.000000e-02 + vertex 1.335126e-02 -5.849567e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 9.819419e-03 -3.877601e-02 8.000000e-02 + vertex 1.194059e-02 -3.817620e-02 8.000000e-02 + vertex 1.596221e-02 -5.783777e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.903186e-02 -8.747244e-03 8.000000e-02 + vertex 5.849567e-02 -1.335126e-02 8.000000e-02 + vertex 5.783777e-02 -1.596221e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.849567e-02 -1.335126e-02 8.000000e-02 + vertex -3.903186e-02 -8.747244e-03 8.000000e-02 + vertex -5.783777e-02 -1.596221e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.903186e-02 -8.747244e-03 8.000000e-02 + vertex 5.903578e-02 -1.071341e-02 8.000000e-02 + vertex 5.849567e-02 -1.335126e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.903186e-02 -8.747244e-03 8.000000e-02 + vertex 5.783777e-02 -1.596221e-02 8.000000e-02 + vertex 3.849072e-02 -1.088414e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.335126e-02 5.849567e-02 8.000000e-02 + vertex 9.819419e-03 3.877601e-02 8.000000e-02 + vertex 7.668425e-03 3.925806e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.335126e-02 5.849567e-02 8.000000e-02 + vertex 1.596221e-02 5.783777e-02 8.000000e-02 + vertex 9.819419e-03 3.877601e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.668425e-03 -3.925806e-02 8.000000e-02 + vertex 1.335126e-02 -5.849567e-02 8.000000e-02 + vertex 1.071341e-02 -5.903578e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.668425e-03 -3.925806e-02 8.000000e-02 + vertex 9.819419e-03 -3.877601e-02 8.000000e-02 + vertex 1.335126e-02 -5.849567e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.945445e-02 -6.583784e-03 8.000000e-02 + vertex 5.945699e-02 -8.053996e-03 8.000000e-02 + vertex 5.903578e-02 -1.071341e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.945445e-02 -6.583784e-03 8.000000e-02 + vertex 5.903578e-02 -1.071341e-02 8.000000e-02 + vertex 3.903186e-02 -8.747244e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.071341e-02 5.903578e-02 8.000000e-02 + vertex 1.335126e-02 5.849567e-02 8.000000e-02 + vertex 7.668425e-03 3.925806e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.071341e-02 5.903578e-02 8.000000e-02 + vertex 7.668425e-03 3.925806e-02 8.000000e-02 + vertex 5.494142e-03 3.962088e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.494142e-03 -3.962088e-02 8.000000e-02 + vertex 8.053996e-03 -5.945699e-02 8.000000e-02 + vertex 5.378359e-03 -5.975846e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.903578e-02 -1.071341e-02 8.000000e-02 + vertex -3.945445e-02 -6.583784e-03 8.000000e-02 + vertex -3.903186e-02 -8.747244e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.494142e-03 -3.962088e-02 8.000000e-02 + vertex 1.071341e-02 -5.903578e-02 8.000000e-02 + vertex 8.053996e-03 -5.945699e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.903578e-02 -1.071341e-02 8.000000e-02 + vertex -3.903186e-02 -8.747244e-03 8.000000e-02 + vertex -5.849567e-02 -1.335126e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.494142e-03 -3.962088e-02 8.000000e-02 + vertex 7.668425e-03 -3.925806e-02 8.000000e-02 + vertex 1.071341e-02 -5.903578e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.975723e-02 -4.400329e-03 8.000000e-02 + vertex 5.975846e-02 -5.378359e-03 8.000000e-02 + vertex 5.945699e-02 -8.053996e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.975723e-02 -4.400329e-03 8.000000e-02 + vertex 5.945699e-02 -8.053996e-03 8.000000e-02 + vertex 3.945445e-02 -6.583784e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 8.053996e-03 5.945699e-02 8.000000e-02 + vertex 1.071341e-02 5.903578e-02 8.000000e-02 + vertex 5.494142e-03 3.962088e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.303174e-03 -3.986338e-02 8.000000e-02 + vertex 5.378359e-03 -5.975846e-02 8.000000e-02 + vertex 2.691890e-03 -5.993958e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.303174e-03 -3.986338e-02 8.000000e-02 + vertex 5.494142e-03 -3.962088e-02 8.000000e-02 + vertex 5.378359e-03 -5.975846e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.945699e-02 -8.053996e-03 8.000000e-02 + vertex -3.945445e-02 -6.583784e-03 8.000000e-02 + vertex -5.903578e-02 -1.071341e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.945699e-02 -8.053996e-03 8.000000e-02 + vertex -3.975723e-02 -4.400329e-03 8.000000e-02 + vertex -3.945445e-02 -6.583784e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.993926e-02 -2.203510e-03 8.000000e-02 + vertex 5.993958e-02 -2.691890e-03 8.000000e-02 + vertex 5.975846e-02 -5.378359e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.993926e-02 -2.203510e-03 8.000000e-02 + vertex 5.975846e-02 -5.378359e-03 8.000000e-02 + vertex 3.975723e-02 -4.400329e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.102174e-03 -3.998481e-02 8.000000e-02 + vertex 2.691890e-03 -5.993958e-02 8.000000e-02 + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.102174e-03 -3.998481e-02 8.000000e-02 + vertex 3.303174e-03 -3.986338e-02 8.000000e-02 + vertex 2.691890e-03 -5.993958e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.000000e-02 0.000000e+00 8.000000e-02 + vertex 5.993958e-02 2.691890e-03 8.000000e-02 + vertex 6.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.378359e-03 5.975846e-02 8.000000e-02 + vertex 5.494142e-03 3.962088e-02 8.000000e-02 + vertex 3.303174e-03 3.986338e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.000000e-02 0.000000e+00 8.000000e-02 + vertex 6.000000e-02 0.000000e+00 8.000000e-02 + vertex 5.993958e-02 -2.691890e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.000000e-02 0.000000e+00 8.000000e-02 + vertex 5.993958e-02 -2.691890e-03 8.000000e-02 + vertex 3.993926e-02 -2.203510e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.378359e-03 5.975846e-02 8.000000e-02 + vertex 8.053996e-03 5.945699e-02 8.000000e-02 + vertex 5.494142e-03 3.962088e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.102174e-03 -3.998481e-02 8.000000e-02 + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + vertex -2.691890e-03 -5.993958e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.975846e-02 -5.378359e-03 8.000000e-02 + vertex -3.975723e-02 -4.400329e-03 8.000000e-02 + vertex -5.945699e-02 -8.053996e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.102174e-03 -3.998481e-02 8.000000e-02 + vertex 1.102174e-03 -3.998481e-02 8.000000e-02 + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.975846e-02 -5.378359e-03 8.000000e-02 + vertex -3.993926e-02 -2.203510e-03 8.000000e-02 + vertex -3.975723e-02 -4.400329e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.993926e-02 2.203510e-03 8.000000e-02 + vertex 5.975846e-02 5.378359e-03 8.000000e-02 + vertex 5.993958e-02 2.691890e-03 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + vertex -3.740939e-02 -4.690989e-02 8.000000e-02 + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 -8.220021e-01 -0.000000e+00 + outer loop + vertex -3.305382e-02 -5.007440e-02 1.000000e-01 + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex -3.305382e-02 -5.007440e-02 1.000000e-01 + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + vertex -3.305382e-02 -5.007440e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 -8.467242e-01 -0.000000e+00 + outer loop + vertex -3.077396e-02 -5.150693e-02 1.000000e-01 + vertex -3.305382e-02 -5.007440e-02 1.000000e-01 + vertex -3.305382e-02 -5.007440e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex -3.077396e-02 -5.150693e-02 1.000000e-01 + vertex -3.305382e-02 -5.007440e-02 8.000000e-02 + vertex -3.077396e-02 -5.150693e-02 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex 5.993958e-02 2.691890e-03 1.000000e-01 + vertex 6.000000e-02 0.000000e+00 8.000000e-02 + vertex 5.993958e-02 2.691890e-03 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex 5.993958e-02 2.691890e-03 1.000000e-01 + vertex 6.000000e-02 0.000000e+00 1.000000e-01 + vertex 6.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 -8.697411e-01 -0.000000e+00 + outer loop + vertex -2.843212e-02 -5.283573e-02 1.000000e-01 + vertex -3.077396e-02 -5.150693e-02 1.000000e-01 + vertex -3.077396e-02 -5.150693e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex -2.843212e-02 -5.283573e-02 1.000000e-01 + vertex -3.077396e-02 -5.150693e-02 8.000000e-02 + vertex -2.843212e-02 -5.283573e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex 5.975846e-02 5.378359e-03 1.000000e-01 + vertex 5.993958e-02 2.691890e-03 8.000000e-02 + vertex 5.975846e-02 5.378359e-03 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex 5.975846e-02 5.378359e-03 1.000000e-01 + vertex 5.993958e-02 2.691890e-03 1.000000e-01 + vertex 5.993958e-02 2.691890e-03 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 -8.910065e-01 -0.000000e+00 + outer loop + vertex -2.603302e-02 -5.405813e-02 1.000000e-01 + vertex -2.843212e-02 -5.283573e-02 1.000000e-01 + vertex -2.843212e-02 -5.283573e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex -2.603302e-02 -5.405813e-02 1.000000e-01 + vertex -2.843212e-02 -5.283573e-02 8.000000e-02 + vertex -2.603302e-02 -5.405813e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex 5.945699e-02 8.053996e-03 1.000000e-01 + vertex 5.975846e-02 5.378359e-03 8.000000e-02 + vertex 5.945699e-02 8.053996e-03 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex 5.945699e-02 8.053996e-03 1.000000e-01 + vertex 5.975846e-02 5.378359e-03 1.000000e-01 + vertex 5.975846e-02 5.378359e-03 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 -9.104775e-01 -0.000000e+00 + outer loop + vertex -2.358150e-02 -5.517167e-02 1.000000e-01 + vertex -2.603302e-02 -5.405813e-02 1.000000e-01 + vertex -2.603302e-02 -5.405813e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex -2.358150e-02 -5.517167e-02 1.000000e-01 + vertex -2.603302e-02 -5.405813e-02 8.000000e-02 + vertex -2.358150e-02 -5.517167e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex 5.903578e-02 1.071341e-02 1.000000e-01 + vertex 5.945699e-02 8.053996e-03 1.000000e-01 + vertex 5.945699e-02 8.053996e-03 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex 5.903578e-02 1.071341e-02 1.000000e-01 + vertex 5.945699e-02 8.053996e-03 8.000000e-02 + vertex 5.903578e-02 1.071341e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 -9.281150e-01 -0.000000e+00 + outer loop + vertex -2.108249e-02 -5.617409e-02 1.000000e-01 + vertex -2.358150e-02 -5.517167e-02 1.000000e-01 + vertex -2.358150e-02 -5.517167e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex -2.108249e-02 -5.617409e-02 1.000000e-01 + vertex -2.358150e-02 -5.517167e-02 8.000000e-02 + vertex -2.108249e-02 -5.617409e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex 5.849567e-02 1.335126e-02 1.000000e-01 + vertex 5.903578e-02 1.071341e-02 1.000000e-01 + vertex 5.903578e-02 1.071341e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex 5.849567e-02 1.335126e-02 1.000000e-01 + vertex 5.903578e-02 1.071341e-02 8.000000e-02 + vertex 5.849567e-02 1.335126e-02 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 -9.438833e-01 -0.000000e+00 + outer loop + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + vertex -2.108249e-02 -5.617409e-02 1.000000e-01 + vertex -2.108249e-02 -5.617409e-02 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + vertex -2.108249e-02 -5.617409e-02 8.000000e-02 + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex 5.783777e-02 1.596221e-02 1.000000e-01 + vertex 5.849567e-02 1.335126e-02 8.000000e-02 + vertex 5.783777e-02 1.596221e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex 5.783777e-02 1.596221e-02 1.000000e-01 + vertex 5.849567e-02 1.335126e-02 1.000000e-01 + vertex 5.849567e-02 1.335126e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 -9.577508e-01 -0.000000e+00 + outer loop + vertex -1.596221e-02 -5.783777e-02 1.000000e-01 + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + vertex 5.783777e-02 1.596221e-02 8.000000e-02 + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex -1.596221e-02 -5.783777e-02 1.000000e-01 + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + vertex -1.596221e-02 -5.783777e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + vertex 5.783777e-02 1.596221e-02 1.000000e-01 + vertex 5.783777e-02 1.596221e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 -9.696895e-01 -0.000000e+00 + outer loop + vertex -1.335126e-02 -5.849567e-02 1.000000e-01 + vertex -1.596221e-02 -5.783777e-02 1.000000e-01 + vertex -1.596221e-02 -5.783777e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex 5.617409e-02 2.108249e-02 1.000000e-01 + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex -1.335126e-02 -5.849567e-02 1.000000e-01 + vertex -1.596221e-02 -5.783777e-02 8.000000e-02 + vertex -1.335126e-02 -5.849567e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex 5.617409e-02 2.108249e-02 1.000000e-01 + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + vertex 5.617409e-02 2.108249e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex -1.071341e-02 -5.903578e-02 1.000000e-01 + vertex -1.335126e-02 -5.849567e-02 8.000000e-02 + vertex -1.071341e-02 -5.903578e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 -9.796754e-01 -0.000000e+00 + outer loop + vertex -1.071341e-02 -5.903578e-02 1.000000e-01 + vertex -1.335126e-02 -5.849567e-02 1.000000e-01 + vertex -1.335126e-02 -5.849567e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex 5.517167e-02 2.358150e-02 1.000000e-01 + vertex 5.617409e-02 2.108249e-02 8.000000e-02 + vertex 5.517167e-02 2.358150e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex 5.517167e-02 2.358150e-02 1.000000e-01 + vertex 5.617409e-02 2.108249e-02 1.000000e-01 + vertex 5.617409e-02 2.108249e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex -8.053996e-03 -5.945699e-02 1.000000e-01 + vertex -1.071341e-02 -5.903578e-02 8.000000e-02 + vertex -8.053996e-03 -5.945699e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 -9.876883e-01 -0.000000e+00 + outer loop + vertex -8.053996e-03 -5.945699e-02 1.000000e-01 + vertex -1.071341e-02 -5.903578e-02 1.000000e-01 + vertex -1.071341e-02 -5.903578e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex 5.405813e-02 2.603302e-02 1.000000e-01 + vertex 5.517167e-02 2.358150e-02 8.000000e-02 + vertex 5.405813e-02 2.603302e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex 5.405813e-02 2.603302e-02 1.000000e-01 + vertex 5.517167e-02 2.358150e-02 1.000000e-01 + vertex 5.517167e-02 2.358150e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex -5.378359e-03 -5.975846e-02 1.000000e-01 + vertex -8.053996e-03 -5.945699e-02 8.000000e-02 + vertex -5.378359e-03 -5.975846e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 -9.937122e-01 -0.000000e+00 + outer loop + vertex -5.378359e-03 -5.975846e-02 1.000000e-01 + vertex -8.053996e-03 -5.945699e-02 1.000000e-01 + vertex -8.053996e-03 -5.945699e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex 5.283573e-02 2.843212e-02 1.000000e-01 + vertex 5.405813e-02 2.603302e-02 8.000000e-02 + vertex 5.283573e-02 2.843212e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex 5.283573e-02 2.843212e-02 1.000000e-01 + vertex 5.405813e-02 2.603302e-02 1.000000e-01 + vertex 5.405813e-02 2.603302e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex -2.691890e-03 -5.993958e-02 1.000000e-01 + vertex -5.378359e-03 -5.975846e-02 8.000000e-02 + vertex -2.691890e-03 -5.993958e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 -9.977349e-01 -0.000000e+00 + outer loop + vertex -2.691890e-03 -5.993958e-02 1.000000e-01 + vertex -5.378359e-03 -5.975846e-02 1.000000e-01 + vertex -5.378359e-03 -5.975846e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex 5.150693e-02 3.077396e-02 1.000000e-01 + vertex 5.283573e-02 2.843212e-02 8.000000e-02 + vertex 5.150693e-02 3.077396e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex 5.150693e-02 3.077396e-02 1.000000e-01 + vertex 5.283573e-02 2.843212e-02 1.000000e-01 + vertex 5.283573e-02 2.843212e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + vertex -2.691890e-03 -5.993958e-02 8.000000e-02 + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 -9.997482e-01 -0.000000e+00 + outer loop + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + vertex -2.691890e-03 -5.993958e-02 1.000000e-01 + vertex -2.691890e-03 -5.993958e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex 5.007440e-02 3.305382e-02 1.000000e-01 + vertex 5.150693e-02 3.077396e-02 8.000000e-02 + vertex 5.007440e-02 3.305382e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex 5.007440e-02 3.305382e-02 1.000000e-01 + vertex 5.150693e-02 3.077396e-02 1.000000e-01 + vertex 5.150693e-02 3.077396e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex 2.691890e-03 -5.993958e-02 1.000000e-01 + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + vertex 2.691890e-03 -5.993958e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex 2.691890e-03 -5.993958e-02 1.000000e-01 + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + vertex 5.007440e-02 3.305382e-02 8.000000e-02 + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex 5.378359e-03 -5.975846e-02 1.000000e-01 + vertex 2.691890e-03 -5.993958e-02 1.000000e-01 + vertex 2.691890e-03 -5.993958e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + vertex 5.007440e-02 3.305382e-02 1.000000e-01 + vertex 5.007440e-02 3.305382e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex 5.378359e-03 -5.975846e-02 1.000000e-01 + vertex 2.691890e-03 -5.993958e-02 8.000000e-02 + vertex 5.378359e-03 -5.975846e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex 4.690989e-02 3.740939e-02 1.000000e-01 + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + vertex 4.690989e-02 3.740939e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex 8.053996e-03 -5.945699e-02 1.000000e-01 + vertex 5.378359e-03 -5.975846e-02 8.000000e-02 + vertex 8.053996e-03 -5.945699e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex 4.690989e-02 3.740939e-02 1.000000e-01 + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex 8.053996e-03 -5.945699e-02 1.000000e-01 + vertex 5.378359e-03 -5.975846e-02 1.000000e-01 + vertex 5.378359e-03 -5.975846e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex 4.518429e-02 3.947632e-02 1.000000e-01 + vertex 4.690989e-02 3.740939e-02 8.000000e-02 + vertex 4.518429e-02 3.947632e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex 1.071341e-02 -5.903578e-02 1.000000e-01 + vertex 8.053996e-03 -5.945699e-02 8.000000e-02 + vertex 1.071341e-02 -5.903578e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex 4.518429e-02 3.947632e-02 1.000000e-01 + vertex 4.690989e-02 3.740939e-02 1.000000e-01 + vertex 4.690989e-02 3.740939e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex 1.071341e-02 -5.903578e-02 1.000000e-01 + vertex 8.053996e-03 -5.945699e-02 1.000000e-01 + vertex 8.053996e-03 -5.945699e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex 1.335126e-02 -5.849567e-02 1.000000e-01 + vertex 1.071341e-02 -5.903578e-02 8.000000e-02 + vertex 1.335126e-02 -5.849567e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex 4.336769e-02 4.146376e-02 1.000000e-01 + vertex 4.518429e-02 3.947632e-02 8.000000e-02 + vertex 4.336769e-02 4.146376e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex 1.335126e-02 -5.849567e-02 1.000000e-01 + vertex 1.071341e-02 -5.903578e-02 1.000000e-01 + vertex 1.071341e-02 -5.903578e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex 4.336769e-02 4.146376e-02 1.000000e-01 + vertex 4.518429e-02 3.947632e-02 1.000000e-01 + vertex 4.518429e-02 3.947632e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex 1.596221e-02 -5.783777e-02 1.000000e-01 + vertex 1.335126e-02 -5.849567e-02 8.000000e-02 + vertex 1.596221e-02 -5.783777e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex 4.146376e-02 4.336769e-02 1.000000e-01 + vertex 4.336769e-02 4.146376e-02 8.000000e-02 + vertex 4.146376e-02 4.336769e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex 1.596221e-02 -5.783777e-02 1.000000e-01 + vertex 1.335126e-02 -5.849567e-02 1.000000e-01 + vertex 1.335126e-02 -5.849567e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex 4.146376e-02 4.336769e-02 1.000000e-01 + vertex 4.336769e-02 4.146376e-02 1.000000e-01 + vertex 4.336769e-02 4.146376e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + vertex 1.596221e-02 -5.783777e-02 8.000000e-02 + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex 3.947632e-02 4.518429e-02 1.000000e-01 + vertex 4.146376e-02 4.336769e-02 8.000000e-02 + vertex 3.947632e-02 4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + vertex 1.596221e-02 -5.783777e-02 1.000000e-01 + vertex 1.596221e-02 -5.783777e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex 3.947632e-02 4.518429e-02 1.000000e-01 + vertex 4.146376e-02 4.336769e-02 1.000000e-01 + vertex 4.146376e-02 4.336769e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex 2.108249e-02 -5.617409e-02 1.000000e-01 + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + vertex 2.108249e-02 -5.617409e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex 2.108249e-02 -5.617409e-02 1.000000e-01 + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex 3.740939e-02 4.690989e-02 1.000000e-01 + vertex 3.947632e-02 4.518429e-02 8.000000e-02 + vertex 3.740939e-02 4.690989e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex 3.740939e-02 4.690989e-02 1.000000e-01 + vertex 3.947632e-02 4.518429e-02 1.000000e-01 + vertex 3.947632e-02 4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex 2.358150e-02 -5.517167e-02 1.000000e-01 + vertex 2.108249e-02 -5.617409e-02 8.000000e-02 + vertex 2.358150e-02 -5.517167e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex 2.358150e-02 -5.517167e-02 1.000000e-01 + vertex 2.108249e-02 -5.617409e-02 1.000000e-01 + vertex 2.108249e-02 -5.617409e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + vertex 3.740939e-02 4.690989e-02 8.000000e-02 + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + vertex 3.740939e-02 4.690989e-02 1.000000e-01 + vertex 3.740939e-02 4.690989e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex 2.603302e-02 -5.405813e-02 1.000000e-01 + vertex 2.358150e-02 -5.517167e-02 8.000000e-02 + vertex 2.603302e-02 -5.405813e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex 2.603302e-02 -5.405813e-02 1.000000e-01 + vertex 2.358150e-02 -5.517167e-02 1.000000e-01 + vertex 2.358150e-02 -5.517167e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex 3.305382e-02 5.007440e-02 1.000000e-01 + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + vertex 3.305382e-02 5.007440e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex 3.305382e-02 5.007440e-02 1.000000e-01 + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex 2.843212e-02 -5.283573e-02 1.000000e-01 + vertex 2.603302e-02 -5.405813e-02 8.000000e-02 + vertex 2.843212e-02 -5.283573e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex 2.843212e-02 -5.283573e-02 1.000000e-01 + vertex 2.603302e-02 -5.405813e-02 1.000000e-01 + vertex 2.603302e-02 -5.405813e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex 3.077396e-02 5.150693e-02 1.000000e-01 + vertex 3.305382e-02 5.007440e-02 8.000000e-02 + vertex 3.077396e-02 5.150693e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex 3.077396e-02 5.150693e-02 1.000000e-01 + vertex 3.305382e-02 5.007440e-02 1.000000e-01 + vertex 3.305382e-02 5.007440e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex 3.077396e-02 -5.150693e-02 1.000000e-01 + vertex 2.843212e-02 -5.283573e-02 8.000000e-02 + vertex 3.077396e-02 -5.150693e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex 3.077396e-02 -5.150693e-02 1.000000e-01 + vertex 2.843212e-02 -5.283573e-02 1.000000e-01 + vertex 2.843212e-02 -5.283573e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex 2.843212e-02 5.283573e-02 1.000000e-01 + vertex 3.077396e-02 5.150693e-02 8.000000e-02 + vertex 2.843212e-02 5.283573e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex 3.305382e-02 -5.007440e-02 1.000000e-01 + vertex 3.077396e-02 -5.150693e-02 8.000000e-02 + vertex 3.305382e-02 -5.007440e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex 2.843212e-02 5.283573e-02 1.000000e-01 + vertex 3.077396e-02 5.150693e-02 1.000000e-01 + vertex 3.077396e-02 5.150693e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex 3.305382e-02 -5.007440e-02 1.000000e-01 + vertex 3.077396e-02 -5.150693e-02 1.000000e-01 + vertex 3.077396e-02 -5.150693e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex 2.603302e-02 5.405813e-02 1.000000e-01 + vertex 2.843212e-02 5.283573e-02 8.000000e-02 + vertex 2.603302e-02 5.405813e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + vertex 3.305382e-02 -5.007440e-02 8.000000e-02 + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex 2.603302e-02 5.405813e-02 1.000000e-01 + vertex 2.843212e-02 5.283573e-02 1.000000e-01 + vertex 2.843212e-02 5.283573e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + vertex 3.305382e-02 -5.007440e-02 1.000000e-01 + vertex 3.305382e-02 -5.007440e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex 2.358150e-02 5.517167e-02 1.000000e-01 + vertex 2.603302e-02 5.405813e-02 8.000000e-02 + vertex 2.358150e-02 5.517167e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex 3.740939e-02 -4.690989e-02 1.000000e-01 + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + vertex 3.740939e-02 -4.690989e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex 2.358150e-02 5.517167e-02 1.000000e-01 + vertex 2.603302e-02 5.405813e-02 1.000000e-01 + vertex 2.603302e-02 5.405813e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex 3.740939e-02 -4.690989e-02 1.000000e-01 + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex 3.947632e-02 -4.518429e-02 1.000000e-01 + vertex 3.740939e-02 -4.690989e-02 8.000000e-02 + vertex 3.947632e-02 -4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex 2.108249e-02 5.617409e-02 1.000000e-01 + vertex 2.358150e-02 5.517167e-02 8.000000e-02 + vertex 2.108249e-02 5.617409e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex 3.947632e-02 -4.518429e-02 1.000000e-01 + vertex 3.740939e-02 -4.690989e-02 1.000000e-01 + vertex 3.740939e-02 -4.690989e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex 2.108249e-02 5.617409e-02 1.000000e-01 + vertex 2.358150e-02 5.517167e-02 1.000000e-01 + vertex 2.358150e-02 5.517167e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex 4.146376e-02 -4.336769e-02 1.000000e-01 + vertex 3.947632e-02 -4.518429e-02 8.000000e-02 + vertex 4.146376e-02 -4.336769e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + vertex 2.108249e-02 5.617409e-02 8.000000e-02 + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex 4.146376e-02 -4.336769e-02 1.000000e-01 + vertex 3.947632e-02 -4.518429e-02 1.000000e-01 + vertex 3.947632e-02 -4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + vertex 2.108249e-02 5.617409e-02 1.000000e-01 + vertex 2.108249e-02 5.617409e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex 4.336769e-02 -4.146376e-02 1.000000e-01 + vertex 4.146376e-02 -4.336769e-02 8.000000e-02 + vertex 4.336769e-02 -4.146376e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex 4.336769e-02 -4.146376e-02 1.000000e-01 + vertex 4.146376e-02 -4.336769e-02 1.000000e-01 + vertex 4.146376e-02 -4.336769e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex 1.596221e-02 5.783777e-02 1.000000e-01 + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + vertex 1.596221e-02 5.783777e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex 1.596221e-02 5.783777e-02 1.000000e-01 + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex 4.518429e-02 -3.947632e-02 1.000000e-01 + vertex 4.336769e-02 -4.146376e-02 8.000000e-02 + vertex 4.518429e-02 -3.947632e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex 4.518429e-02 -3.947632e-02 1.000000e-01 + vertex 4.336769e-02 -4.146376e-02 1.000000e-01 + vertex 4.336769e-02 -4.146376e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex 1.335126e-02 5.849567e-02 1.000000e-01 + vertex 1.596221e-02 5.783777e-02 1.000000e-01 + vertex 1.596221e-02 5.783777e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex 1.335126e-02 5.849567e-02 1.000000e-01 + vertex 1.596221e-02 5.783777e-02 8.000000e-02 + vertex 1.335126e-02 5.849567e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex 4.690989e-02 -3.740939e-02 1.000000e-01 + vertex 4.518429e-02 -3.947632e-02 8.000000e-02 + vertex 4.690989e-02 -3.740939e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex 4.690989e-02 -3.740939e-02 1.000000e-01 + vertex 4.518429e-02 -3.947632e-02 1.000000e-01 + vertex 4.518429e-02 -3.947632e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex 1.071341e-02 5.903578e-02 1.000000e-01 + vertex 1.335126e-02 5.849567e-02 1.000000e-01 + vertex 1.335126e-02 5.849567e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex 1.071341e-02 5.903578e-02 1.000000e-01 + vertex 1.335126e-02 5.849567e-02 8.000000e-02 + vertex 1.071341e-02 5.903578e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + vertex 4.690989e-02 -3.740939e-02 8.000000e-02 + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + vertex 4.690989e-02 -3.740939e-02 1.000000e-01 + vertex 4.690989e-02 -3.740939e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex 8.053996e-03 5.945699e-02 1.000000e-01 + vertex 1.071341e-02 5.903578e-02 1.000000e-01 + vertex 1.071341e-02 5.903578e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex 8.053996e-03 5.945699e-02 1.000000e-01 + vertex 1.071341e-02 5.903578e-02 8.000000e-02 + vertex 8.053996e-03 5.945699e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex 5.007440e-02 -3.305382e-02 1.000000e-01 + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + vertex 5.007440e-02 -3.305382e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex 5.007440e-02 -3.305382e-02 1.000000e-01 + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex 5.378359e-03 5.975846e-02 1.000000e-01 + vertex 8.053996e-03 5.945699e-02 1.000000e-01 + vertex 8.053996e-03 5.945699e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex 5.378359e-03 5.975846e-02 1.000000e-01 + vertex 8.053996e-03 5.945699e-02 8.000000e-02 + vertex 5.378359e-03 5.975846e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex 5.150693e-02 -3.077396e-02 1.000000e-01 + vertex 5.007440e-02 -3.305382e-02 8.000000e-02 + vertex 5.150693e-02 -3.077396e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex 5.150693e-02 -3.077396e-02 1.000000e-01 + vertex 5.007440e-02 -3.305382e-02 1.000000e-01 + vertex 5.007440e-02 -3.305382e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex 2.691890e-03 5.993958e-02 1.000000e-01 + vertex 5.378359e-03 5.975846e-02 1.000000e-01 + vertex 5.378359e-03 5.975846e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex 2.691890e-03 5.993958e-02 1.000000e-01 + vertex 5.378359e-03 5.975846e-02 8.000000e-02 + vertex 2.691890e-03 5.993958e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex 5.283573e-02 -2.843212e-02 1.000000e-01 + vertex 5.150693e-02 -3.077396e-02 8.000000e-02 + vertex 5.283573e-02 -2.843212e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex 5.283573e-02 -2.843212e-02 1.000000e-01 + vertex 5.150693e-02 -3.077396e-02 1.000000e-01 + vertex 5.150693e-02 -3.077396e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex 3.673940e-18 6.000000e-02 1.000000e-01 + vertex 2.691890e-03 5.993958e-02 1.000000e-01 + vertex 2.691890e-03 5.993958e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex 3.673940e-18 6.000000e-02 1.000000e-01 + vertex 2.691890e-03 5.993958e-02 8.000000e-02 + vertex 3.673940e-18 6.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex 5.405813e-02 -2.603302e-02 1.000000e-01 + vertex 5.283573e-02 -2.843212e-02 1.000000e-01 + vertex 5.283573e-02 -2.843212e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex 5.405813e-02 -2.603302e-02 1.000000e-01 + vertex 5.283573e-02 -2.843212e-02 8.000000e-02 + vertex 5.405813e-02 -2.603302e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex 5.517167e-02 -2.358150e-02 1.000000e-01 + vertex 5.405813e-02 -2.603302e-02 1.000000e-01 + vertex 5.405813e-02 -2.603302e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex -2.691890e-03 5.993958e-02 1.000000e-01 + vertex 3.673940e-18 6.000000e-02 1.000000e-01 + vertex 3.673940e-18 6.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex 5.517167e-02 -2.358150e-02 1.000000e-01 + vertex 5.405813e-02 -2.603302e-02 8.000000e-02 + vertex 5.517167e-02 -2.358150e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex -2.691890e-03 5.993958e-02 1.000000e-01 + vertex 3.673940e-18 6.000000e-02 8.000000e-02 + vertex -2.691890e-03 5.993958e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex 5.617409e-02 -2.108249e-02 1.000000e-01 + vertex 5.517167e-02 -2.358150e-02 1.000000e-01 + vertex 5.517167e-02 -2.358150e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex -5.378359e-03 5.975846e-02 1.000000e-01 + vertex -2.691890e-03 5.993958e-02 1.000000e-01 + vertex -2.691890e-03 5.993958e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex 5.617409e-02 -2.108249e-02 1.000000e-01 + vertex 5.517167e-02 -2.358150e-02 8.000000e-02 + vertex 5.617409e-02 -2.108249e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex -5.378359e-03 5.975846e-02 1.000000e-01 + vertex -2.691890e-03 5.993958e-02 8.000000e-02 + vertex -5.378359e-03 5.975846e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + vertex 5.617409e-02 -2.108249e-02 1.000000e-01 + vertex 5.617409e-02 -2.108249e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + vertex 5.617409e-02 -2.108249e-02 8.000000e-02 + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex -8.053996e-03 5.945699e-02 1.000000e-01 + vertex -5.378359e-03 5.975846e-02 1.000000e-01 + vertex -5.378359e-03 5.975846e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex -8.053996e-03 5.945699e-02 1.000000e-01 + vertex -5.378359e-03 5.975846e-02 8.000000e-02 + vertex -8.053996e-03 5.945699e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex 5.783777e-02 -1.596221e-02 1.000000e-01 + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex 5.783777e-02 -1.596221e-02 1.000000e-01 + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + vertex 5.783777e-02 -1.596221e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex -1.071341e-02 5.903578e-02 1.000000e-01 + vertex -8.053996e-03 5.945699e-02 8.000000e-02 + vertex -1.071341e-02 5.903578e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex -1.071341e-02 5.903578e-02 1.000000e-01 + vertex -8.053996e-03 5.945699e-02 1.000000e-01 + vertex -8.053996e-03 5.945699e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex 5.849567e-02 -1.335126e-02 1.000000e-01 + vertex 5.783777e-02 -1.596221e-02 1.000000e-01 + vertex 5.783777e-02 -1.596221e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex 5.849567e-02 -1.335126e-02 1.000000e-01 + vertex 5.783777e-02 -1.596221e-02 8.000000e-02 + vertex 5.849567e-02 -1.335126e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex -1.335126e-02 5.849567e-02 1.000000e-01 + vertex -1.071341e-02 5.903578e-02 8.000000e-02 + vertex -1.335126e-02 5.849567e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex -1.335126e-02 5.849567e-02 1.000000e-01 + vertex -1.071341e-02 5.903578e-02 1.000000e-01 + vertex -1.071341e-02 5.903578e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex 5.903578e-02 -1.071341e-02 1.000000e-01 + vertex 5.849567e-02 -1.335126e-02 1.000000e-01 + vertex 5.849567e-02 -1.335126e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex 5.903578e-02 -1.071341e-02 1.000000e-01 + vertex 5.849567e-02 -1.335126e-02 8.000000e-02 + vertex 5.903578e-02 -1.071341e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex -1.596221e-02 5.783777e-02 1.000000e-01 + vertex -1.335126e-02 5.849567e-02 8.000000e-02 + vertex -1.596221e-02 5.783777e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex -1.596221e-02 5.783777e-02 1.000000e-01 + vertex -1.335126e-02 5.849567e-02 1.000000e-01 + vertex -1.335126e-02 5.849567e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex 5.945699e-02 -8.053996e-03 1.000000e-01 + vertex 5.903578e-02 -1.071341e-02 1.000000e-01 + vertex 5.903578e-02 -1.071341e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex 5.945699e-02 -8.053996e-03 1.000000e-01 + vertex 5.903578e-02 -1.071341e-02 8.000000e-02 + vertex 5.945699e-02 -8.053996e-03 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + vertex -1.596221e-02 5.783777e-02 8.000000e-02 + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + vertex -1.596221e-02 5.783777e-02 1.000000e-01 + vertex -1.596221e-02 5.783777e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex 5.975846e-02 -5.378359e-03 1.000000e-01 + vertex 5.945699e-02 -8.053996e-03 1.000000e-01 + vertex 5.945699e-02 -8.053996e-03 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex 5.975846e-02 -5.378359e-03 1.000000e-01 + vertex 5.945699e-02 -8.053996e-03 8.000000e-02 + vertex 5.975846e-02 -5.378359e-03 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex -2.108249e-02 5.617409e-02 1.000000e-01 + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + vertex -2.108249e-02 5.617409e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex 5.993958e-02 -2.691890e-03 1.000000e-01 + vertex 5.975846e-02 -5.378359e-03 1.000000e-01 + vertex 5.975846e-02 -5.378359e-03 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex -2.108249e-02 5.617409e-02 1.000000e-01 + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex 5.993958e-02 -2.691890e-03 1.000000e-01 + vertex 5.975846e-02 -5.378359e-03 8.000000e-02 + vertex 5.993958e-02 -2.691890e-03 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex 6.000000e-02 0.000000e+00 1.000000e-01 + vertex 5.993958e-02 -2.691890e-03 8.000000e-02 + vertex 6.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex 6.000000e-02 0.000000e+00 1.000000e-01 + vertex 5.993958e-02 -2.691890e-03 1.000000e-01 + vertex 5.993958e-02 -2.691890e-03 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex -2.358150e-02 5.517167e-02 1.000000e-01 + vertex -2.108249e-02 5.617409e-02 8.000000e-02 + vertex -2.358150e-02 5.517167e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex -2.358150e-02 5.517167e-02 1.000000e-01 + vertex -2.108249e-02 5.617409e-02 1.000000e-01 + vertex -2.108249e-02 5.617409e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex -2.603302e-02 5.405813e-02 1.000000e-01 + vertex -2.358150e-02 5.517167e-02 8.000000e-02 + vertex -2.603302e-02 5.405813e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex -2.603302e-02 5.405813e-02 1.000000e-01 + vertex -2.358150e-02 5.517167e-02 1.000000e-01 + vertex -2.358150e-02 5.517167e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex -2.843212e-02 5.283573e-02 1.000000e-01 + vertex -2.603302e-02 5.405813e-02 8.000000e-02 + vertex -2.843212e-02 5.283573e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex -2.843212e-02 5.283573e-02 1.000000e-01 + vertex -2.603302e-02 5.405813e-02 1.000000e-01 + vertex -2.603302e-02 5.405813e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex -3.077396e-02 5.150693e-02 1.000000e-01 + vertex -2.843212e-02 5.283573e-02 8.000000e-02 + vertex -3.077396e-02 5.150693e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex -3.077396e-02 5.150693e-02 1.000000e-01 + vertex -2.843212e-02 5.283573e-02 1.000000e-01 + vertex -2.843212e-02 5.283573e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex -3.305382e-02 5.007440e-02 1.000000e-01 + vertex -3.077396e-02 5.150693e-02 8.000000e-02 + vertex -3.305382e-02 5.007440e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex -3.305382e-02 5.007440e-02 1.000000e-01 + vertex -3.077396e-02 5.150693e-02 1.000000e-01 + vertex -3.077396e-02 5.150693e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + vertex -3.305382e-02 5.007440e-02 8.000000e-02 + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + vertex -3.305382e-02 5.007440e-02 1.000000e-01 + vertex -3.305382e-02 5.007440e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex -3.740939e-02 4.690989e-02 1.000000e-01 + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + vertex -3.740939e-02 4.690989e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex -3.740939e-02 4.690989e-02 1.000000e-01 + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex -3.947632e-02 4.518429e-02 1.000000e-01 + vertex -3.740939e-02 4.690989e-02 8.000000e-02 + vertex -3.947632e-02 4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex -3.947632e-02 4.518429e-02 1.000000e-01 + vertex -3.740939e-02 4.690989e-02 1.000000e-01 + vertex -3.740939e-02 4.690989e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex -4.146376e-02 4.336769e-02 1.000000e-01 + vertex -3.947632e-02 4.518429e-02 8.000000e-02 + vertex -4.146376e-02 4.336769e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex -4.146376e-02 4.336769e-02 1.000000e-01 + vertex -3.947632e-02 4.518429e-02 1.000000e-01 + vertex -3.947632e-02 4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex -4.336769e-02 4.146376e-02 1.000000e-01 + vertex -4.146376e-02 4.336769e-02 8.000000e-02 + vertex -4.336769e-02 4.146376e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex -4.336769e-02 4.146376e-02 1.000000e-01 + vertex -4.146376e-02 4.336769e-02 1.000000e-01 + vertex -4.146376e-02 4.336769e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex -4.518429e-02 3.947632e-02 1.000000e-01 + vertex -4.336769e-02 4.146376e-02 8.000000e-02 + vertex -4.518429e-02 3.947632e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex -4.518429e-02 3.947632e-02 1.000000e-01 + vertex -4.336769e-02 4.146376e-02 1.000000e-01 + vertex -4.336769e-02 4.146376e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex -4.690989e-02 3.740939e-02 1.000000e-01 + vertex -4.518429e-02 3.947632e-02 1.000000e-01 + vertex -4.518429e-02 3.947632e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex -4.690989e-02 3.740939e-02 1.000000e-01 + vertex -4.518429e-02 3.947632e-02 8.000000e-02 + vertex -4.690989e-02 3.740939e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + vertex -4.690989e-02 3.740939e-02 1.000000e-01 + vertex -4.690989e-02 3.740939e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + vertex -4.690989e-02 3.740939e-02 8.000000e-02 + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex -5.007440e-02 3.305382e-02 1.000000e-01 + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex -5.007440e-02 3.305382e-02 1.000000e-01 + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + vertex -5.007440e-02 3.305382e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex -5.150693e-02 3.077396e-02 1.000000e-01 + vertex -5.007440e-02 3.305382e-02 1.000000e-01 + vertex -5.007440e-02 3.305382e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex -5.150693e-02 3.077396e-02 1.000000e-01 + vertex -5.007440e-02 3.305382e-02 8.000000e-02 + vertex -5.150693e-02 3.077396e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex -5.283573e-02 2.843212e-02 1.000000e-01 + vertex -5.150693e-02 3.077396e-02 1.000000e-01 + vertex -5.150693e-02 3.077396e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex -5.283573e-02 2.843212e-02 1.000000e-01 + vertex -5.150693e-02 3.077396e-02 8.000000e-02 + vertex -5.283573e-02 2.843212e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex -5.405813e-02 2.603302e-02 1.000000e-01 + vertex -5.283573e-02 2.843212e-02 1.000000e-01 + vertex -5.283573e-02 2.843212e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex -5.405813e-02 2.603302e-02 1.000000e-01 + vertex -5.283573e-02 2.843212e-02 8.000000e-02 + vertex -5.405813e-02 2.603302e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex -5.517167e-02 2.358150e-02 1.000000e-01 + vertex -5.405813e-02 2.603302e-02 1.000000e-01 + vertex -5.405813e-02 2.603302e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex -5.517167e-02 2.358150e-02 1.000000e-01 + vertex -5.405813e-02 2.603302e-02 8.000000e-02 + vertex -5.517167e-02 2.358150e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex -5.617409e-02 2.108249e-02 1.000000e-01 + vertex -5.517167e-02 2.358150e-02 1.000000e-01 + vertex -5.517167e-02 2.358150e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex -5.617409e-02 2.108249e-02 1.000000e-01 + vertex -5.517167e-02 2.358150e-02 8.000000e-02 + vertex -5.617409e-02 2.108249e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + vertex -5.617409e-02 2.108249e-02 1.000000e-01 + vertex -5.617409e-02 2.108249e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + vertex -5.617409e-02 2.108249e-02 8.000000e-02 + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex -5.783777e-02 1.596221e-02 1.000000e-01 + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex -5.783777e-02 1.596221e-02 1.000000e-01 + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + vertex -5.783777e-02 1.596221e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex -5.849567e-02 1.335126e-02 1.000000e-01 + vertex -5.783777e-02 1.596221e-02 1.000000e-01 + vertex -5.783777e-02 1.596221e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex -5.849567e-02 1.335126e-02 1.000000e-01 + vertex -5.783777e-02 1.596221e-02 8.000000e-02 + vertex -5.849567e-02 1.335126e-02 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex -5.903578e-02 1.071341e-02 1.000000e-01 + vertex -5.849567e-02 1.335126e-02 1.000000e-01 + vertex -5.849567e-02 1.335126e-02 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex -5.903578e-02 1.071341e-02 1.000000e-01 + vertex -5.849567e-02 1.335126e-02 8.000000e-02 + vertex -5.903578e-02 1.071341e-02 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex -5.945699e-02 8.053996e-03 1.000000e-01 + vertex -5.903578e-02 1.071341e-02 1.000000e-01 + vertex -5.903578e-02 1.071341e-02 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex -5.945699e-02 8.053996e-03 1.000000e-01 + vertex -5.903578e-02 1.071341e-02 8.000000e-02 + vertex -5.945699e-02 8.053996e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex -5.975846e-02 5.378359e-03 1.000000e-01 + vertex -5.945699e-02 8.053996e-03 1.000000e-01 + vertex -5.945699e-02 8.053996e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex -5.975846e-02 5.378359e-03 1.000000e-01 + vertex -5.945699e-02 8.053996e-03 8.000000e-02 + vertex -5.975846e-02 5.378359e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex -5.993958e-02 2.691890e-03 1.000000e-01 + vertex -5.975846e-02 5.378359e-03 1.000000e-01 + vertex -5.975846e-02 5.378359e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex -5.993958e-02 2.691890e-03 1.000000e-01 + vertex -5.975846e-02 5.378359e-03 8.000000e-02 + vertex -5.993958e-02 2.691890e-03 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex -6.000000e-02 7.347881e-18 1.000000e-01 + vertex -5.993958e-02 2.691890e-03 1.000000e-01 + vertex -5.993958e-02 2.691890e-03 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex -6.000000e-02 7.347881e-18 1.000000e-01 + vertex -5.993958e-02 2.691890e-03 8.000000e-02 + vertex -6.000000e-02 7.347881e-18 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 -2.243806e-02 -0.000000e+00 + outer loop + vertex -5.993958e-02 -2.691890e-03 1.000000e-01 + vertex -6.000000e-02 7.347881e-18 1.000000e-01 + vertex -6.000000e-02 7.347881e-18 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex -5.993958e-02 -2.691890e-03 1.000000e-01 + vertex -6.000000e-02 7.347881e-18 8.000000e-02 + vertex -5.993958e-02 -2.691890e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex -5.975846e-02 -5.378359e-03 1.000000e-01 + vertex -5.993958e-02 -2.691890e-03 8.000000e-02 + vertex -5.975846e-02 -5.378359e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 -6.726901e-02 -0.000000e+00 + outer loop + vertex -5.975846e-02 -5.378359e-03 1.000000e-01 + vertex -5.993958e-02 -2.691890e-03 1.000000e-01 + vertex -5.993958e-02 -2.691890e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex -5.945699e-02 -8.053996e-03 1.000000e-01 + vertex -5.975846e-02 -5.378359e-03 8.000000e-02 + vertex -5.945699e-02 -8.053996e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 -1.119645e-01 -0.000000e+00 + outer loop + vertex -5.945699e-02 -8.053996e-03 1.000000e-01 + vertex -5.975846e-02 -5.378359e-03 1.000000e-01 + vertex -5.975846e-02 -5.378359e-03 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 -1.564345e-01 -0.000000e+00 + outer loop + vertex -5.903578e-02 -1.071341e-02 1.000000e-01 + vertex -5.945699e-02 -8.053996e-03 1.000000e-01 + vertex -5.945699e-02 -8.053996e-03 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex -5.903578e-02 -1.071341e-02 1.000000e-01 + vertex -5.945699e-02 -8.053996e-03 8.000000e-02 + vertex -5.903578e-02 -1.071341e-02 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex -5.849567e-02 -1.335126e-02 1.000000e-01 + vertex -5.903578e-02 -1.071341e-02 8.000000e-02 + vertex -5.849567e-02 -1.335126e-02 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 -2.005894e-01 -0.000000e+00 + outer loop + vertex -5.849567e-02 -1.335126e-02 1.000000e-01 + vertex -5.903578e-02 -1.071341e-02 1.000000e-01 + vertex -5.903578e-02 -1.071341e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex -5.783777e-02 -1.596221e-02 1.000000e-01 + vertex -5.849567e-02 -1.335126e-02 8.000000e-02 + vertex -5.783777e-02 -1.596221e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 -2.443404e-01 -0.000000e+00 + outer loop + vertex -5.783777e-02 -1.596221e-02 1.000000e-01 + vertex -5.849567e-02 -1.335126e-02 1.000000e-01 + vertex -5.849567e-02 -1.335126e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + vertex -5.783777e-02 -1.596221e-02 8.000000e-02 + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 -2.875993e-01 -0.000000e+00 + outer loop + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + vertex -5.783777e-02 -1.596221e-02 1.000000e-01 + vertex -5.783777e-02 -1.596221e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex -5.617409e-02 -2.108249e-02 1.000000e-01 + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + vertex -5.617409e-02 -2.108249e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 -3.302791e-01 -0.000000e+00 + outer loop + vertex -5.617409e-02 -2.108249e-02 1.000000e-01 + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex -5.517167e-02 -2.358150e-02 1.000000e-01 + vertex -5.617409e-02 -2.108249e-02 8.000000e-02 + vertex -5.517167e-02 -2.358150e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 -3.722937e-01 -0.000000e+00 + outer loop + vertex -5.517167e-02 -2.358150e-02 1.000000e-01 + vertex -5.617409e-02 -2.108249e-02 1.000000e-01 + vertex -5.617409e-02 -2.108249e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 -4.135585e-01 -0.000000e+00 + outer loop + vertex -5.405813e-02 -2.603302e-02 1.000000e-01 + vertex -5.517167e-02 -2.358150e-02 1.000000e-01 + vertex -5.517167e-02 -2.358150e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex -5.405813e-02 -2.603302e-02 1.000000e-01 + vertex -5.517167e-02 -2.358150e-02 8.000000e-02 + vertex -5.405813e-02 -2.603302e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 -4.539905e-01 -0.000000e+00 + outer loop + vertex -5.283573e-02 -2.843212e-02 1.000000e-01 + vertex -5.405813e-02 -2.603302e-02 1.000000e-01 + vertex -5.405813e-02 -2.603302e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex -5.283573e-02 -2.843212e-02 1.000000e-01 + vertex -5.405813e-02 -2.603302e-02 8.000000e-02 + vertex -5.283573e-02 -2.843212e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 -4.935082e-01 -0.000000e+00 + outer loop + vertex -5.150693e-02 -3.077396e-02 1.000000e-01 + vertex -5.283573e-02 -2.843212e-02 1.000000e-01 + vertex -5.283573e-02 -2.843212e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex -5.150693e-02 -3.077396e-02 1.000000e-01 + vertex -5.283573e-02 -2.843212e-02 8.000000e-02 + vertex -5.150693e-02 -3.077396e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 -5.320321e-01 -0.000000e+00 + outer loop + vertex -5.007440e-02 -3.305382e-02 1.000000e-01 + vertex -5.150693e-02 -3.077396e-02 1.000000e-01 + vertex -5.150693e-02 -3.077396e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex -5.007440e-02 -3.305382e-02 1.000000e-01 + vertex -5.150693e-02 -3.077396e-02 8.000000e-02 + vertex -5.007440e-02 -3.305382e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 -5.694845e-01 -0.000000e+00 + outer loop + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + vertex -5.007440e-02 -3.305382e-02 1.000000e-01 + vertex -5.007440e-02 -3.305382e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + vertex -5.007440e-02 -3.305382e-02 8.000000e-02 + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 -6.057900e-01 -0.000000e+00 + outer loop + vertex -4.690989e-02 -3.740939e-02 1.000000e-01 + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex -4.690989e-02 -3.740939e-02 1.000000e-01 + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + vertex -4.690989e-02 -3.740939e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 -6.408756e-01 -0.000000e+00 + outer loop + vertex -4.518429e-02 -3.947632e-02 1.000000e-01 + vertex -4.690989e-02 -3.740939e-02 1.000000e-01 + vertex -4.690989e-02 -3.740939e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex -4.518429e-02 -3.947632e-02 1.000000e-01 + vertex -4.690989e-02 -3.740939e-02 8.000000e-02 + vertex -4.518429e-02 -3.947632e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 -6.746705e-01 -0.000000e+00 + outer loop + vertex -4.336769e-02 -4.146376e-02 1.000000e-01 + vertex -4.518429e-02 -3.947632e-02 1.000000e-01 + vertex -4.518429e-02 -3.947632e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex -4.336769e-02 -4.146376e-02 1.000000e-01 + vertex -4.518429e-02 -3.947632e-02 8.000000e-02 + vertex -4.336769e-02 -4.146376e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 -7.071068e-01 -0.000000e+00 + outer loop + vertex -4.146376e-02 -4.336769e-02 1.000000e-01 + vertex -4.336769e-02 -4.146376e-02 1.000000e-01 + vertex -4.336769e-02 -4.146376e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex -4.146376e-02 -4.336769e-02 1.000000e-01 + vertex -4.336769e-02 -4.146376e-02 8.000000e-02 + vertex -4.146376e-02 -4.336769e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 -7.381190e-01 -0.000000e+00 + outer loop + vertex -3.947632e-02 -4.518429e-02 1.000000e-01 + vertex -4.146376e-02 -4.336769e-02 1.000000e-01 + vertex -4.146376e-02 -4.336769e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex -3.947632e-02 -4.518429e-02 1.000000e-01 + vertex -4.146376e-02 -4.336769e-02 8.000000e-02 + vertex -3.947632e-02 -4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 -7.676447e-01 -0.000000e+00 + outer loop + vertex -3.740939e-02 -4.690989e-02 1.000000e-01 + vertex -3.947632e-02 -4.518429e-02 1.000000e-01 + vertex -3.947632e-02 -4.518429e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex -3.740939e-02 -4.690989e-02 1.000000e-01 + vertex -3.947632e-02 -4.518429e-02 8.000000e-02 + vertex -3.740939e-02 -4.690989e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 -7.956245e-01 -0.000000e+00 + outer loop + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + vertex -3.740939e-02 -4.690989e-02 1.000000e-01 + vertex -3.740939e-02 -4.690989e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.102174e-03 -3.998481e-02 1.000000e-01 + vertex -1.102174e-03 -3.998481e-02 1.000000e-01 + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.993926e-02 2.203510e-03 1.000000e-01 + vertex -5.975846e-02 5.378359e-03 1.000000e-01 + vertex -5.993958e-02 2.691890e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.993926e-02 2.203510e-03 1.000000e-01 + vertex -5.993958e-02 2.691890e-03 1.000000e-01 + vertex -4.000000e-02 4.898587e-18 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.975846e-02 -5.378359e-03 1.000000e-01 + vertex 3.975723e-02 -4.400329e-03 1.000000e-01 + vertex 5.945699e-02 -8.053996e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.303174e-03 -3.986338e-02 1.000000e-01 + vertex 2.691890e-03 -5.993958e-02 1.000000e-01 + vertex 5.378359e-03 -5.975846e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.975846e-02 -5.378359e-03 1.000000e-01 + vertex 3.993926e-02 -2.203510e-03 1.000000e-01 + vertex 3.975723e-02 -4.400329e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.378359e-03 5.975846e-02 1.000000e-01 + vertex -8.053996e-03 5.945699e-02 1.000000e-01 + vertex -5.494142e-03 3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.378359e-03 5.975846e-02 1.000000e-01 + vertex -5.494142e-03 3.962088e-02 1.000000e-01 + vertex -3.303174e-03 3.986338e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.303174e-03 -3.986338e-02 1.000000e-01 + vertex 1.102174e-03 -3.998481e-02 1.000000e-01 + vertex 2.691890e-03 -5.993958e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.975723e-02 4.400329e-03 1.000000e-01 + vertex -5.945699e-02 8.053996e-03 1.000000e-01 + vertex -5.975846e-02 5.378359e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.975723e-02 4.400329e-03 1.000000e-01 + vertex -5.975846e-02 5.378359e-03 1.000000e-01 + vertex -3.993926e-02 2.203510e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.494142e-03 -3.962088e-02 1.000000e-01 + vertex 5.378359e-03 -5.975846e-02 1.000000e-01 + vertex 8.053996e-03 -5.945699e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.494142e-03 -3.962088e-02 1.000000e-01 + vertex 8.053996e-03 -5.945699e-02 1.000000e-01 + vertex 1.071341e-02 -5.903578e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.494142e-03 -3.962088e-02 1.000000e-01 + vertex 3.303174e-03 -3.986338e-02 1.000000e-01 + vertex 5.378359e-03 -5.975846e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.945445e-02 6.583784e-03 1.000000e-01 + vertex -5.945699e-02 8.053996e-03 1.000000e-01 + vertex -3.975723e-02 4.400329e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.945445e-02 6.583784e-03 1.000000e-01 + vertex -5.903578e-02 1.071341e-02 1.000000e-01 + vertex -5.945699e-02 8.053996e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.668425e-03 -3.925806e-02 1.000000e-01 + vertex 1.071341e-02 -5.903578e-02 1.000000e-01 + vertex 1.335126e-02 -5.849567e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.668425e-03 -3.925806e-02 1.000000e-01 + vertex 5.494142e-03 -3.962088e-02 1.000000e-01 + vertex 1.071341e-02 -5.903578e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.903186e-02 8.747244e-03 1.000000e-01 + vertex -5.903578e-02 1.071341e-02 1.000000e-01 + vertex -3.945445e-02 6.583784e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.903186e-02 8.747244e-03 1.000000e-01 + vertex -5.783777e-02 1.596221e-02 1.000000e-01 + vertex -5.849567e-02 1.335126e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.903186e-02 8.747244e-03 1.000000e-01 + vertex -5.849567e-02 1.335126e-02 1.000000e-01 + vertex -5.903578e-02 1.071341e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.819419e-03 -3.877601e-02 1.000000e-01 + vertex 1.335126e-02 -5.849567e-02 1.000000e-01 + vertex 1.596221e-02 -5.783777e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.993958e-02 -2.691890e-03 1.000000e-01 + vertex 4.000000e-02 0.000000e+00 1.000000e-01 + vertex 3.993926e-02 -2.203510e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.819419e-03 -3.877601e-02 1.000000e-01 + vertex 7.668425e-03 -3.925806e-02 1.000000e-01 + vertex 1.335126e-02 -5.849567e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.993958e-02 -2.691890e-03 1.000000e-01 + vertex 3.993926e-02 -2.203510e-03 1.000000e-01 + vertex 5.975846e-02 -5.378359e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.691890e-03 5.993958e-02 1.000000e-01 + vertex -5.378359e-03 5.975846e-02 1.000000e-01 + vertex -3.303174e-03 3.986338e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.849072e-02 1.088414e-02 1.000000e-01 + vertex -5.783777e-02 1.596221e-02 1.000000e-01 + vertex -3.903186e-02 8.747244e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.691890e-03 5.993958e-02 1.000000e-01 + vertex -3.303174e-03 3.986338e-02 1.000000e-01 + vertex -1.102174e-03 3.998481e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.849072e-02 1.088414e-02 1.000000e-01 + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + vertex -5.783777e-02 1.596221e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.194059e-02 -3.817620e-02 1.000000e-01 + vertex 1.596221e-02 -5.783777e-02 1.000000e-01 + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.000000e-02 0.000000e+00 1.000000e-01 + vertex 4.000000e-02 0.000000e+00 1.000000e-01 + vertex 5.993958e-02 -2.691890e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.194059e-02 -3.817620e-02 1.000000e-01 + vertex 9.819419e-03 -3.877601e-02 1.000000e-01 + vertex 1.596221e-02 -5.783777e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.783269e-02 1.298798e-02 1.000000e-01 + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + vertex -3.849072e-02 1.088414e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.673940e-18 6.000000e-02 1.000000e-01 + vertex -1.102174e-03 3.998481e-02 1.000000e-01 + vertex 1.102174e-03 3.998481e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.673940e-18 6.000000e-02 1.000000e-01 + vertex -2.691890e-03 5.993958e-02 1.000000e-01 + vertex -1.102174e-03 3.998481e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.993958e-02 2.691890e-03 1.000000e-01 + vertex 4.000000e-02 0.000000e+00 1.000000e-01 + vertex 6.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.993958e-02 2.691890e-03 1.000000e-01 + vertex 3.993926e-02 2.203510e-03 1.000000e-01 + vertex 4.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.783269e-02 1.298798e-02 1.000000e-01 + vertex -5.617409e-02 2.108249e-02 1.000000e-01 + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.402550e-02 -3.746045e-02 1.000000e-01 + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + vertex 2.108249e-02 -5.617409e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.402550e-02 -3.746045e-02 1.000000e-01 + vertex 2.108249e-02 -5.617409e-02 1.000000e-01 + vertex 2.358150e-02 -5.517167e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.402550e-02 -3.746045e-02 1.000000e-01 + vertex 1.194059e-02 -3.817620e-02 1.000000e-01 + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.705976e-02 1.505237e-02 1.000000e-01 + vertex -5.617409e-02 2.108249e-02 1.000000e-01 + vertex -3.783269e-02 1.298798e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.705976e-02 1.505237e-02 1.000000e-01 + vertex -5.517167e-02 2.358150e-02 1.000000e-01 + vertex -5.617409e-02 2.108249e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.691890e-03 5.993958e-02 1.000000e-01 + vertex 1.102174e-03 3.998481e-02 1.000000e-01 + vertex 3.303174e-03 3.986338e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.691890e-03 5.993958e-02 1.000000e-01 + vertex 3.673940e-18 6.000000e-02 1.000000e-01 + vertex 1.102174e-03 3.998481e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.975846e-02 5.378359e-03 1.000000e-01 + vertex 3.975723e-02 4.400329e-03 1.000000e-01 + vertex 3.993926e-02 2.203510e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.606782e-02 -3.663093e-02 1.000000e-01 + vertex 2.358150e-02 -5.517167e-02 1.000000e-01 + vertex 2.603302e-02 -5.405813e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.606782e-02 -3.663093e-02 1.000000e-01 + vertex 1.402550e-02 -3.746045e-02 1.000000e-01 + vertex 2.358150e-02 -5.517167e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.975846e-02 5.378359e-03 1.000000e-01 + vertex 3.993926e-02 2.203510e-03 1.000000e-01 + vertex 5.993958e-02 2.691890e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.617429e-02 1.707106e-02 1.000000e-01 + vertex -5.517167e-02 2.358150e-02 1.000000e-01 + vertex -3.705976e-02 1.505237e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.617429e-02 1.707106e-02 1.000000e-01 + vertex -5.405813e-02 2.603302e-02 1.000000e-01 + vertex -5.517167e-02 2.358150e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.806133e-02 -3.569017e-02 1.000000e-01 + vertex 2.603302e-02 -5.405813e-02 1.000000e-01 + vertex 2.843212e-02 -5.283573e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.806133e-02 -3.569017e-02 1.000000e-01 + vertex 1.606782e-02 -3.663093e-02 1.000000e-01 + vertex 2.603302e-02 -5.405813e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.378359e-03 5.975846e-02 1.000000e-01 + vertex 3.303174e-03 3.986338e-02 1.000000e-01 + vertex 5.494142e-03 3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.378359e-03 5.975846e-02 1.000000e-01 + vertex 2.691890e-03 5.993958e-02 1.000000e-01 + vertex 3.303174e-03 3.986338e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.945699e-02 8.053996e-03 1.000000e-01 + vertex 3.945445e-02 6.583784e-03 1.000000e-01 + vertex 3.975723e-02 4.400329e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.517895e-02 1.903790e-02 1.000000e-01 + vertex -5.150693e-02 3.077396e-02 1.000000e-01 + vertex -5.283573e-02 2.843212e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.517895e-02 1.903790e-02 1.000000e-01 + vertex -5.283573e-02 2.843212e-02 1.000000e-01 + vertex -5.405813e-02 2.603302e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.517895e-02 1.903790e-02 1.000000e-01 + vertex -5.405813e-02 2.603302e-02 1.000000e-01 + vertex -3.617429e-02 1.707106e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.945699e-02 8.053996e-03 1.000000e-01 + vertex 3.975723e-02 4.400329e-03 1.000000e-01 + vertex 5.975846e-02 5.378359e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.000000e-02 -3.464102e-02 1.000000e-01 + vertex 2.843212e-02 -5.283573e-02 1.000000e-01 + vertex 3.077396e-02 -5.150693e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.000000e-02 -3.464102e-02 1.000000e-01 + vertex 1.806133e-02 -3.569017e-02 1.000000e-01 + vertex 2.843212e-02 -5.283573e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.053996e-03 5.945699e-02 1.000000e-01 + vertex 5.378359e-03 5.975846e-02 1.000000e-01 + vertex 5.494142e-03 3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.903578e-02 1.071341e-02 1.000000e-01 + vertex 3.903186e-02 8.747244e-03 1.000000e-01 + vertex 3.945445e-02 6.583784e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.407678e-02 2.094692e-02 1.000000e-01 + vertex -5.007440e-02 3.305382e-02 1.000000e-01 + vertex -5.150693e-02 3.077396e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.407678e-02 2.094692e-02 1.000000e-01 + vertex -5.150693e-02 3.077396e-02 1.000000e-01 + vertex -3.517895e-02 1.903790e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.187793e-02 -3.348666e-02 1.000000e-01 + vertex 3.077396e-02 -5.150693e-02 1.000000e-01 + vertex 3.305382e-02 -5.007440e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.187793e-02 -3.348666e-02 1.000000e-01 + vertex 3.305382e-02 -5.007440e-02 1.000000e-01 + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.187793e-02 -3.348666e-02 1.000000e-01 + vertex 2.000000e-02 -3.464102e-02 1.000000e-01 + vertex 3.077396e-02 -5.150693e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.903578e-02 1.071341e-02 1.000000e-01 + vertex 3.945445e-02 6.583784e-03 1.000000e-01 + vertex 5.945699e-02 8.053996e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.071341e-02 5.903578e-02 1.000000e-01 + vertex 8.053996e-03 5.945699e-02 1.000000e-01 + vertex 5.494142e-03 3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.287111e-02 2.279232e-02 1.000000e-01 + vertex -5.007440e-02 3.305382e-02 1.000000e-01 + vertex -3.407678e-02 2.094692e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.287111e-02 2.279232e-02 1.000000e-01 + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + vertex -5.007440e-02 3.305382e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.071341e-02 5.903578e-02 1.000000e-01 + vertex 5.494142e-03 3.962088e-02 1.000000e-01 + vertex 7.668425e-03 3.925806e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.368941e-02 -3.223060e-02 1.000000e-01 + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + vertex 3.740939e-02 -4.690989e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.368941e-02 -3.223060e-02 1.000000e-01 + vertex 2.187793e-02 -3.348666e-02 1.000000e-01 + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.156562e-02 2.456851e-02 1.000000e-01 + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + vertex -3.287111e-02 2.279232e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.156562e-02 2.456851e-02 1.000000e-01 + vertex -4.690989e-02 3.740939e-02 1.000000e-01 + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.849567e-02 1.335126e-02 1.000000e-01 + vertex 3.903186e-02 8.747244e-03 1.000000e-01 + vertex 5.903578e-02 1.071341e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.335126e-02 5.849567e-02 1.000000e-01 + vertex 1.071341e-02 5.903578e-02 1.000000e-01 + vertex 7.668425e-03 3.925806e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.542895e-02 -3.087667e-02 1.000000e-01 + vertex 3.740939e-02 -4.690989e-02 1.000000e-01 + vertex 3.947632e-02 -4.518429e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.335126e-02 5.849567e-02 1.000000e-01 + vertex 7.668425e-03 3.925806e-02 1.000000e-01 + vertex 9.819419e-03 3.877601e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.596221e-02 5.783777e-02 1.000000e-01 + vertex 1.335126e-02 5.849567e-02 1.000000e-01 + vertex 9.819419e-03 3.877601e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.542895e-02 -3.087667e-02 1.000000e-01 + vertex 2.368941e-02 -3.223060e-02 1.000000e-01 + vertex 3.740939e-02 -4.690989e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.016426e-02 2.627008e-02 1.000000e-01 + vertex -4.518429e-02 3.947632e-02 1.000000e-01 + vertex -4.690989e-02 3.740939e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.867130e-02 -2.789187e-02 1.000000e-01 + vertex -4.336769e-02 -4.146376e-02 1.000000e-01 + vertex -4.146376e-02 -4.336769e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.016426e-02 2.627008e-02 1.000000e-01 + vertex -4.690989e-02 3.740939e-02 1.000000e-01 + vertex -3.156562e-02 2.456851e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.596221e-02 5.783777e-02 1.000000e-01 + vertex 9.819419e-03 3.877601e-02 1.000000e-01 + vertex 1.194059e-02 3.817620e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.783777e-02 1.596221e-02 1.000000e-01 + vertex 3.903186e-02 8.747244e-03 1.000000e-01 + vertex 5.849567e-02 1.335126e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.783777e-02 1.596221e-02 1.000000e-01 + vertex 3.849072e-02 1.088414e-02 1.000000e-01 + vertex 3.903186e-02 8.747244e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.709126e-02 -2.942896e-02 1.000000e-01 + vertex 2.542895e-02 -3.087667e-02 1.000000e-01 + vertex 3.947632e-02 -4.518429e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.146376e-02 -4.336769e-02 1.000000e-01 + vertex 2.709126e-02 -2.942896e-02 1.000000e-01 + vertex 3.947632e-02 -4.518429e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.336769e-02 4.146376e-02 1.000000e-01 + vertex -4.518429e-02 3.947632e-02 1.000000e-01 + vertex -3.016426e-02 2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + vertex 1.596221e-02 5.783777e-02 1.000000e-01 + vertex 1.194059e-02 3.817620e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.867130e-02 2.789187e-02 1.000000e-01 + vertex -4.336769e-02 4.146376e-02 1.000000e-01 + vertex -3.016426e-02 2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.709126e-02 -2.942896e-02 1.000000e-01 + vertex -4.146376e-02 -4.336769e-02 1.000000e-01 + vertex -3.947632e-02 -4.518429e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.709126e-02 -2.942896e-02 1.000000e-01 + vertex -2.867130e-02 -2.789187e-02 1.000000e-01 + vertex -4.146376e-02 -4.336769e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + vertex 1.194059e-02 3.817620e-02 1.000000e-01 + vertex 1.402550e-02 3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + vertex 3.849072e-02 1.088414e-02 1.000000e-01 + vertex 5.783777e-02 1.596221e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + vertex 3.783269e-02 1.298798e-02 1.000000e-01 + vertex 3.849072e-02 1.088414e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.867130e-02 -2.789187e-02 1.000000e-01 + vertex 2.709126e-02 -2.942896e-02 1.000000e-01 + vertex 4.146376e-02 -4.336769e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.336769e-02 -4.146376e-02 1.000000e-01 + vertex 2.867130e-02 -2.789187e-02 1.000000e-01 + vertex 4.146376e-02 -4.336769e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.146376e-02 4.336769e-02 1.000000e-01 + vertex -4.336769e-02 4.146376e-02 1.000000e-01 + vertex -2.867130e-02 2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.108249e-02 5.617409e-02 1.000000e-01 + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + vertex 1.402550e-02 3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.709126e-02 2.942896e-02 1.000000e-01 + vertex -4.146376e-02 4.336769e-02 1.000000e-01 + vertex -2.867130e-02 2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.016426e-02 -2.627008e-02 1.000000e-01 + vertex -4.690989e-02 -3.740939e-02 1.000000e-01 + vertex -4.518429e-02 -3.947632e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.016426e-02 -2.627008e-02 1.000000e-01 + vertex -4.518429e-02 -3.947632e-02 1.000000e-01 + vertex -4.336769e-02 -4.146376e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.016426e-02 -2.627008e-02 1.000000e-01 + vertex -4.336769e-02 -4.146376e-02 1.000000e-01 + vertex -2.867130e-02 -2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.617409e-02 2.108249e-02 1.000000e-01 + vertex 3.705976e-02 1.505237e-02 1.000000e-01 + vertex 3.783269e-02 1.298798e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.016426e-02 -2.627008e-02 1.000000e-01 + vertex 2.867130e-02 -2.789187e-02 1.000000e-01 + vertex 4.336769e-02 -4.146376e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.617409e-02 2.108249e-02 1.000000e-01 + vertex 3.783269e-02 1.298798e-02 1.000000e-01 + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.542895e-02 -3.087667e-02 1.000000e-01 + vertex -2.709126e-02 -2.942896e-02 1.000000e-01 + vertex -3.947632e-02 -4.518429e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.542895e-02 -3.087667e-02 1.000000e-01 + vertex -3.947632e-02 -4.518429e-02 1.000000e-01 + vertex -3.740939e-02 -4.690989e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.358150e-02 5.517167e-02 1.000000e-01 + vertex 2.108249e-02 5.617409e-02 1.000000e-01 + vertex 1.402550e-02 3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.156562e-02 -2.456851e-02 1.000000e-01 + vertex -4.690989e-02 -3.740939e-02 1.000000e-01 + vertex -3.016426e-02 -2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.358150e-02 5.517167e-02 1.000000e-01 + vertex 1.402550e-02 3.746045e-02 1.000000e-01 + vertex 1.606782e-02 3.663093e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.518429e-02 -3.947632e-02 1.000000e-01 + vertex 3.016426e-02 -2.627008e-02 1.000000e-01 + vertex 4.336769e-02 -4.146376e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.947632e-02 4.518429e-02 1.000000e-01 + vertex -2.709126e-02 2.942896e-02 1.000000e-01 + vertex -2.542895e-02 3.087667e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.517167e-02 2.358150e-02 1.000000e-01 + vertex 3.617429e-02 1.707106e-02 1.000000e-01 + vertex 3.705976e-02 1.505237e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.947632e-02 4.518429e-02 1.000000e-01 + vertex -4.146376e-02 4.336769e-02 1.000000e-01 + vertex -2.709126e-02 2.942896e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.517167e-02 2.358150e-02 1.000000e-01 + vertex 3.705976e-02 1.505237e-02 1.000000e-01 + vertex 5.617409e-02 2.108249e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.156562e-02 -2.456851e-02 1.000000e-01 + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + vertex -4.690989e-02 -3.740939e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.603302e-02 5.405813e-02 1.000000e-01 + vertex 2.358150e-02 5.517167e-02 1.000000e-01 + vertex 1.606782e-02 3.663093e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.603302e-02 5.405813e-02 1.000000e-01 + vertex 1.606782e-02 3.663093e-02 1.000000e-01 + vertex 1.806133e-02 3.569017e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.405813e-02 2.603302e-02 1.000000e-01 + vertex 3.617429e-02 1.707106e-02 1.000000e-01 + vertex 5.517167e-02 2.358150e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.368941e-02 -3.223060e-02 1.000000e-01 + vertex -2.542895e-02 -3.087667e-02 1.000000e-01 + vertex -3.740939e-02 -4.690989e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.368941e-02 -3.223060e-02 1.000000e-01 + vertex -3.740939e-02 -4.690989e-02 1.000000e-01 + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.690989e-02 -3.740939e-02 1.000000e-01 + vertex 3.016426e-02 -2.627008e-02 1.000000e-01 + vertex 4.518429e-02 -3.947632e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.405813e-02 2.603302e-02 1.000000e-01 + vertex 3.517895e-02 1.903790e-02 1.000000e-01 + vertex 3.617429e-02 1.707106e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.690989e-02 -3.740939e-02 1.000000e-01 + vertex 3.156562e-02 -2.456851e-02 1.000000e-01 + vertex 3.016426e-02 -2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.740939e-02 4.690989e-02 1.000000e-01 + vertex -3.947632e-02 4.518429e-02 1.000000e-01 + vertex -2.542895e-02 3.087667e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.740939e-02 4.690989e-02 1.000000e-01 + vertex -2.542895e-02 3.087667e-02 1.000000e-01 + vertex -2.368941e-02 3.223060e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.843212e-02 5.283573e-02 1.000000e-01 + vertex 2.603302e-02 5.405813e-02 1.000000e-01 + vertex 1.806133e-02 3.569017e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.843212e-02 5.283573e-02 1.000000e-01 + vertex 1.806133e-02 3.569017e-02 1.000000e-01 + vertex 2.000000e-02 3.464102e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.287111e-02 -2.279232e-02 1.000000e-01 + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + vertex -3.156562e-02 -2.456851e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.283573e-02 2.843212e-02 1.000000e-01 + vertex 3.517895e-02 1.903790e-02 1.000000e-01 + vertex 5.405813e-02 2.603302e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.150693e-02 3.077396e-02 1.000000e-01 + vertex 3.407678e-02 2.094692e-02 1.000000e-01 + vertex 3.517895e-02 1.903790e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.287111e-02 -2.279232e-02 1.000000e-01 + vertex -5.007440e-02 -3.305382e-02 1.000000e-01 + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + vertex 3.156562e-02 -2.456851e-02 1.000000e-01 + vertex 4.690989e-02 -3.740939e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + vertex 3.287111e-02 -2.279232e-02 1.000000e-01 + vertex 3.156562e-02 -2.456851e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.150693e-02 3.077396e-02 1.000000e-01 + vertex 3.517895e-02 1.903790e-02 1.000000e-01 + vertex 5.283573e-02 2.843212e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.077396e-02 5.150693e-02 1.000000e-01 + vertex 2.843212e-02 5.283573e-02 1.000000e-01 + vertex 2.000000e-02 3.464102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + vertex -3.740939e-02 4.690989e-02 1.000000e-01 + vertex -2.368941e-02 3.223060e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.187793e-02 -3.348666e-02 1.000000e-01 + vertex -2.368941e-02 -3.223060e-02 1.000000e-01 + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + vertex -2.368941e-02 3.223060e-02 1.000000e-01 + vertex -2.187793e-02 3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.187793e-02 -3.348666e-02 1.000000e-01 + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + vertex -3.305382e-02 -5.007440e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.187793e-02 -3.348666e-02 1.000000e-01 + vertex -3.305382e-02 -5.007440e-02 1.000000e-01 + vertex -3.077396e-02 -5.150693e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.077396e-02 5.150693e-02 1.000000e-01 + vertex 2.000000e-02 3.464102e-02 1.000000e-01 + vertex 2.187793e-02 3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.007440e-02 3.305382e-02 1.000000e-01 + vertex 3.407678e-02 2.094692e-02 1.000000e-01 + vertex 5.150693e-02 3.077396e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.007440e-02 3.305382e-02 1.000000e-01 + vertex 3.287111e-02 2.279232e-02 1.000000e-01 + vertex 3.407678e-02 2.094692e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.407678e-02 -2.094692e-02 1.000000e-01 + vertex -5.007440e-02 -3.305382e-02 1.000000e-01 + vertex -3.287111e-02 -2.279232e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.007440e-02 -3.305382e-02 1.000000e-01 + vertex 3.287111e-02 -2.279232e-02 1.000000e-01 + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.305382e-02 5.007440e-02 1.000000e-01 + vertex 3.077396e-02 5.150693e-02 1.000000e-01 + vertex 2.187793e-02 3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.007440e-02 -3.305382e-02 1.000000e-01 + vertex 3.407678e-02 -2.094692e-02 1.000000e-01 + vertex 3.287111e-02 -2.279232e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.305382e-02 5.007440e-02 1.000000e-01 + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + vertex -2.187793e-02 3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + vertex 3.287111e-02 2.279232e-02 1.000000e-01 + vertex 5.007440e-02 3.305382e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + vertex 3.156562e-02 2.456851e-02 1.000000e-01 + vertex 3.287111e-02 2.279232e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.407678e-02 -2.094692e-02 1.000000e-01 + vertex -5.150693e-02 -3.077396e-02 1.000000e-01 + vertex -5.007440e-02 -3.305382e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + vertex 3.305382e-02 5.007440e-02 1.000000e-01 + vertex 2.187793e-02 3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + vertex 2.187793e-02 3.348666e-02 1.000000e-01 + vertex 2.368941e-02 3.223060e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.000000e-02 -3.464102e-02 1.000000e-01 + vertex -2.187793e-02 -3.348666e-02 1.000000e-01 + vertex -3.077396e-02 -5.150693e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.740939e-02 4.690989e-02 1.000000e-01 + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + vertex 2.368941e-02 3.223060e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.000000e-02 -3.464102e-02 1.000000e-01 + vertex -3.077396e-02 -5.150693e-02 1.000000e-01 + vertex -2.843212e-02 -5.283573e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.740939e-02 4.690989e-02 1.000000e-01 + vertex 2.368941e-02 3.223060e-02 1.000000e-01 + vertex 2.542895e-02 3.087667e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.690989e-02 3.740939e-02 1.000000e-01 + vertex 3.156562e-02 2.456851e-02 1.000000e-01 + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.690989e-02 3.740939e-02 1.000000e-01 + vertex 3.016426e-02 2.627008e-02 1.000000e-01 + vertex 3.156562e-02 2.456851e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.077396e-02 5.150693e-02 1.000000e-01 + vertex -3.305382e-02 5.007440e-02 1.000000e-01 + vertex -2.187793e-02 3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.077396e-02 5.150693e-02 1.000000e-01 + vertex -2.187793e-02 3.348666e-02 1.000000e-01 + vertex -2.000000e-02 3.464102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.947632e-02 4.518429e-02 1.000000e-01 + vertex 3.740939e-02 4.690989e-02 1.000000e-01 + vertex 2.542895e-02 3.087667e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.150693e-02 -3.077396e-02 1.000000e-01 + vertex 3.517895e-02 -1.903790e-02 1.000000e-01 + vertex 3.407678e-02 -2.094692e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.150693e-02 -3.077396e-02 1.000000e-01 + vertex 3.407678e-02 -2.094692e-02 1.000000e-01 + vertex 5.007440e-02 -3.305382e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.947632e-02 4.518429e-02 1.000000e-01 + vertex 2.542895e-02 3.087667e-02 1.000000e-01 + vertex 2.709126e-02 2.942896e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.518429e-02 3.947632e-02 1.000000e-01 + vertex 3.016426e-02 2.627008e-02 1.000000e-01 + vertex 4.690989e-02 3.740939e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.517895e-02 -1.903790e-02 1.000000e-01 + vertex -5.150693e-02 -3.077396e-02 1.000000e-01 + vertex -3.407678e-02 -2.094692e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.146376e-02 4.336769e-02 1.000000e-01 + vertex 3.947632e-02 4.518429e-02 1.000000e-01 + vertex 2.709126e-02 2.942896e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.146376e-02 4.336769e-02 1.000000e-01 + vertex 2.709126e-02 2.942896e-02 1.000000e-01 + vertex 2.867130e-02 2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.336769e-02 4.146376e-02 1.000000e-01 + vertex 2.867130e-02 2.789187e-02 1.000000e-01 + vertex 3.016426e-02 2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.336769e-02 4.146376e-02 1.000000e-01 + vertex 3.016426e-02 2.627008e-02 1.000000e-01 + vertex 4.518429e-02 3.947632e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.336769e-02 4.146376e-02 1.000000e-01 + vertex 4.146376e-02 4.336769e-02 1.000000e-01 + vertex 2.867130e-02 2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.517895e-02 -1.903790e-02 1.000000e-01 + vertex -5.405813e-02 -2.603302e-02 1.000000e-01 + vertex -5.283573e-02 -2.843212e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.517895e-02 -1.903790e-02 1.000000e-01 + vertex -5.283573e-02 -2.843212e-02 1.000000e-01 + vertex -5.150693e-02 -3.077396e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.283573e-02 -2.843212e-02 1.000000e-01 + vertex 3.517895e-02 -1.903790e-02 1.000000e-01 + vertex 5.150693e-02 -3.077396e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.843212e-02 5.283573e-02 1.000000e-01 + vertex -3.077396e-02 5.150693e-02 1.000000e-01 + vertex -2.000000e-02 3.464102e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.843212e-02 5.283573e-02 1.000000e-01 + vertex -2.000000e-02 3.464102e-02 1.000000e-01 + vertex -1.806133e-02 3.569017e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.806133e-02 -3.569017e-02 1.000000e-01 + vertex -2.000000e-02 -3.464102e-02 1.000000e-01 + vertex -2.843212e-02 -5.283573e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.806133e-02 -3.569017e-02 1.000000e-01 + vertex -2.843212e-02 -5.283573e-02 1.000000e-01 + vertex -2.603302e-02 -5.405813e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.617429e-02 -1.707106e-02 1.000000e-01 + vertex -5.405813e-02 -2.603302e-02 1.000000e-01 + vertex -3.517895e-02 -1.903790e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.405813e-02 -2.603302e-02 1.000000e-01 + vertex 3.617429e-02 -1.707106e-02 1.000000e-01 + vertex 3.517895e-02 -1.903790e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.405813e-02 -2.603302e-02 1.000000e-01 + vertex 3.517895e-02 -1.903790e-02 1.000000e-01 + vertex 5.283573e-02 -2.843212e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.617429e-02 -1.707106e-02 1.000000e-01 + vertex -5.517167e-02 -2.358150e-02 1.000000e-01 + vertex -5.405813e-02 -2.603302e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.603302e-02 5.405813e-02 1.000000e-01 + vertex -2.843212e-02 5.283573e-02 1.000000e-01 + vertex -1.806133e-02 3.569017e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.603302e-02 5.405813e-02 1.000000e-01 + vertex -1.806133e-02 3.569017e-02 1.000000e-01 + vertex -1.606782e-02 3.663093e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.606782e-02 -3.663093e-02 1.000000e-01 + vertex -1.806133e-02 -3.569017e-02 1.000000e-01 + vertex -2.603302e-02 -5.405813e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.606782e-02 -3.663093e-02 1.000000e-01 + vertex -2.603302e-02 -5.405813e-02 1.000000e-01 + vertex -2.358150e-02 -5.517167e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.705976e-02 -1.505237e-02 1.000000e-01 + vertex -5.517167e-02 -2.358150e-02 1.000000e-01 + vertex -3.617429e-02 -1.707106e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.517167e-02 -2.358150e-02 1.000000e-01 + vertex 3.705976e-02 -1.505237e-02 1.000000e-01 + vertex 3.617429e-02 -1.707106e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.517167e-02 -2.358150e-02 1.000000e-01 + vertex 3.617429e-02 -1.707106e-02 1.000000e-01 + vertex 5.405813e-02 -2.603302e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.705976e-02 -1.505237e-02 1.000000e-01 + vertex -5.617409e-02 -2.108249e-02 1.000000e-01 + vertex -5.517167e-02 -2.358150e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.358150e-02 5.517167e-02 1.000000e-01 + vertex -1.606782e-02 3.663093e-02 1.000000e-01 + vertex -1.402550e-02 3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.358150e-02 5.517167e-02 1.000000e-01 + vertex -2.603302e-02 5.405813e-02 1.000000e-01 + vertex -1.606782e-02 3.663093e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.402550e-02 -3.746045e-02 1.000000e-01 + vertex -1.606782e-02 -3.663093e-02 1.000000e-01 + vertex -2.358150e-02 -5.517167e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.402550e-02 -3.746045e-02 1.000000e-01 + vertex -2.358150e-02 -5.517167e-02 1.000000e-01 + vertex -2.108249e-02 -5.617409e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.402550e-02 -3.746045e-02 1.000000e-01 + vertex -2.108249e-02 -5.617409e-02 1.000000e-01 + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.617409e-02 -2.108249e-02 1.000000e-01 + vertex 3.783269e-02 -1.298798e-02 1.000000e-01 + vertex 3.705976e-02 -1.505237e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.617409e-02 -2.108249e-02 1.000000e-01 + vertex 3.705976e-02 -1.505237e-02 1.000000e-01 + vertex 5.517167e-02 -2.358150e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.783269e-02 -1.298798e-02 1.000000e-01 + vertex -5.617409e-02 -2.108249e-02 1.000000e-01 + vertex -3.705976e-02 -1.505237e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.108249e-02 5.617409e-02 1.000000e-01 + vertex -2.358150e-02 5.517167e-02 1.000000e-01 + vertex -1.402550e-02 3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.783269e-02 -1.298798e-02 1.000000e-01 + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + vertex -5.617409e-02 -2.108249e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + vertex 3.849072e-02 -1.088414e-02 1.000000e-01 + vertex 3.783269e-02 -1.298798e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.194059e-02 -3.817620e-02 1.000000e-01 + vertex -1.402550e-02 -3.746045e-02 1.000000e-01 + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.194059e-02 -3.817620e-02 1.000000e-01 + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + vertex -1.596221e-02 -5.783777e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + vertex 3.783269e-02 -1.298798e-02 1.000000e-01 + vertex 5.617409e-02 -2.108249e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + vertex -1.402550e-02 3.746045e-02 1.000000e-01 + vertex -1.194059e-02 3.817620e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + vertex -2.108249e-02 5.617409e-02 1.000000e-01 + vertex -1.402550e-02 3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.849072e-02 -1.088414e-02 1.000000e-01 + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + vertex -3.783269e-02 -1.298798e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.849072e-02 -1.088414e-02 1.000000e-01 + vertex -5.783777e-02 -1.596221e-02 1.000000e-01 + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -9.819419e-03 -3.877601e-02 1.000000e-01 + vertex -1.194059e-02 -3.817620e-02 1.000000e-01 + vertex -1.596221e-02 -5.783777e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -9.819419e-03 -3.877601e-02 1.000000e-01 + vertex -1.596221e-02 -5.783777e-02 1.000000e-01 + vertex -1.335126e-02 -5.849567e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.596221e-02 5.783777e-02 1.000000e-01 + vertex -1.194059e-02 3.817620e-02 1.000000e-01 + vertex -9.819419e-03 3.877601e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.596221e-02 5.783777e-02 1.000000e-01 + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + vertex -1.194059e-02 3.817620e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.783777e-02 -1.596221e-02 1.000000e-01 + vertex 3.903186e-02 -8.747244e-03 1.000000e-01 + vertex 3.849072e-02 -1.088414e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.783777e-02 -1.596221e-02 1.000000e-01 + vertex 3.849072e-02 -1.088414e-02 1.000000e-01 + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.903186e-02 -8.747244e-03 1.000000e-01 + vertex -5.903578e-02 -1.071341e-02 1.000000e-01 + vertex -5.849567e-02 -1.335126e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.903186e-02 -8.747244e-03 1.000000e-01 + vertex -5.849567e-02 -1.335126e-02 1.000000e-01 + vertex -5.783777e-02 -1.596221e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.903186e-02 -8.747244e-03 1.000000e-01 + vertex -5.783777e-02 -1.596221e-02 1.000000e-01 + vertex -3.849072e-02 -1.088414e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.668425e-03 -3.925806e-02 1.000000e-01 + vertex -1.335126e-02 -5.849567e-02 1.000000e-01 + vertex -1.071341e-02 -5.903578e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.668425e-03 -3.925806e-02 1.000000e-01 + vertex -9.819419e-03 -3.877601e-02 1.000000e-01 + vertex -1.335126e-02 -5.849567e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.849567e-02 -1.335126e-02 1.000000e-01 + vertex 3.903186e-02 -8.747244e-03 1.000000e-01 + vertex 5.783777e-02 -1.596221e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.335126e-02 5.849567e-02 1.000000e-01 + vertex -1.596221e-02 5.783777e-02 1.000000e-01 + vertex -9.819419e-03 3.877601e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.945445e-02 -6.583784e-03 1.000000e-01 + vertex -5.945699e-02 -8.053996e-03 1.000000e-01 + vertex -5.903578e-02 -1.071341e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.945445e-02 -6.583784e-03 1.000000e-01 + vertex -5.903578e-02 -1.071341e-02 1.000000e-01 + vertex -3.903186e-02 -8.747244e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.335126e-02 5.849567e-02 1.000000e-01 + vertex -9.819419e-03 3.877601e-02 1.000000e-01 + vertex -7.668425e-03 3.925806e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.494142e-03 -3.962088e-02 1.000000e-01 + vertex -1.071341e-02 -5.903578e-02 1.000000e-01 + vertex -8.053996e-03 -5.945699e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.494142e-03 -3.962088e-02 1.000000e-01 + vertex -8.053996e-03 -5.945699e-02 1.000000e-01 + vertex -5.378359e-03 -5.975846e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.494142e-03 -3.962088e-02 1.000000e-01 + vertex -7.668425e-03 -3.925806e-02 1.000000e-01 + vertex -1.071341e-02 -5.903578e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.903578e-02 -1.071341e-02 1.000000e-01 + vertex 3.903186e-02 -8.747244e-03 1.000000e-01 + vertex 5.849567e-02 -1.335126e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.903578e-02 -1.071341e-02 1.000000e-01 + vertex 3.945445e-02 -6.583784e-03 1.000000e-01 + vertex 3.903186e-02 -8.747244e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.975723e-02 -4.400329e-03 1.000000e-01 + vertex -5.975846e-02 -5.378359e-03 1.000000e-01 + vertex -5.945699e-02 -8.053996e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.975723e-02 -4.400329e-03 1.000000e-01 + vertex -5.945699e-02 -8.053996e-03 1.000000e-01 + vertex -3.945445e-02 -6.583784e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.071341e-02 5.903578e-02 1.000000e-01 + vertex -1.335126e-02 5.849567e-02 1.000000e-01 + vertex -7.668425e-03 3.925806e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.303174e-03 -3.986338e-02 1.000000e-01 + vertex -5.378359e-03 -5.975846e-02 1.000000e-01 + vertex -2.691890e-03 -5.993958e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.071341e-02 5.903578e-02 1.000000e-01 + vertex -7.668425e-03 3.925806e-02 1.000000e-01 + vertex -5.494142e-03 3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.303174e-03 -3.986338e-02 1.000000e-01 + vertex -5.494142e-03 -3.962088e-02 1.000000e-01 + vertex -5.378359e-03 -5.975846e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.993926e-02 -2.203510e-03 1.000000e-01 + vertex -5.993958e-02 -2.691890e-03 1.000000e-01 + vertex -5.975846e-02 -5.378359e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.993926e-02 -2.203510e-03 1.000000e-01 + vertex -5.975846e-02 -5.378359e-03 1.000000e-01 + vertex -3.975723e-02 -4.400329e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.102174e-03 -3.998481e-02 1.000000e-01 + vertex -2.691890e-03 -5.993958e-02 1.000000e-01 + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -8.053996e-03 5.945699e-02 1.000000e-01 + vertex -1.071341e-02 5.903578e-02 1.000000e-01 + vertex -5.494142e-03 3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.945699e-02 -8.053996e-03 1.000000e-01 + vertex 3.945445e-02 -6.583784e-03 1.000000e-01 + vertex 5.903578e-02 -1.071341e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.102174e-03 -3.998481e-02 1.000000e-01 + vertex -3.303174e-03 -3.986338e-02 1.000000e-01 + vertex -2.691890e-03 -5.993958e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.945699e-02 -8.053996e-03 1.000000e-01 + vertex 3.975723e-02 -4.400329e-03 1.000000e-01 + vertex 3.945445e-02 -6.583784e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.000000e-02 4.898587e-18 1.000000e-01 + vertex -5.993958e-02 -2.691890e-03 1.000000e-01 + vertex -3.993926e-02 -2.203510e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.000000e-02 4.898587e-18 1.000000e-01 + vertex -5.993958e-02 2.691890e-03 1.000000e-01 + vertex -6.000000e-02 7.347881e-18 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.000000e-02 4.898587e-18 1.000000e-01 + vertex -6.000000e-02 7.347881e-18 1.000000e-01 + vertex -5.993958e-02 -2.691890e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.102174e-03 -3.998481e-02 1.000000e-01 + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + vertex 2.691890e-03 -5.993958e-02 1.000000e-01 + endloop + endfacet + facet normal -3.246995e-01 9.458172e-01 0.000000e+00 + outer loop + vertex 1.402550e-02 -3.746045e-02 8.000000e-02 + vertex 1.194059e-02 -3.817620e-02 1.000000e-01 + vertex 1.402550e-02 -3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal -3.246995e-01 9.458172e-01 0.000000e+00 + outer loop + vertex 1.402550e-02 -3.746045e-02 8.000000e-02 + vertex 1.194059e-02 -3.817620e-02 8.000000e-02 + vertex 1.194059e-02 -3.817620e-02 1.000000e-01 + endloop + endfacet + facet normal -3.763094e-01 9.264941e-01 0.000000e+00 + outer loop + vertex 1.606782e-02 -3.663093e-02 8.000000e-02 + vertex 1.402550e-02 -3.746045e-02 8.000000e-02 + vertex 1.402550e-02 -3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal -3.763094e-01 9.264941e-01 0.000000e+00 + outer loop + vertex 1.606782e-02 -3.663093e-02 8.000000e-02 + vertex 1.402550e-02 -3.746045e-02 1.000000e-01 + vertex 1.606782e-02 -3.663093e-02 1.000000e-01 + endloop + endfacet + facet normal -4.267764e-01 9.043572e-01 0.000000e+00 + outer loop + vertex 1.806133e-02 -3.569017e-02 8.000000e-02 + vertex 1.606782e-02 -3.663093e-02 8.000000e-02 + vertex 1.606782e-02 -3.663093e-02 1.000000e-01 + endloop + endfacet + facet normal -9.996203e-01 -2.755434e-02 0.000000e+00 + outer loop + vertex 3.993926e-02 2.203510e-03 8.000000e-02 + vertex 4.000000e-02 0.000000e+00 1.000000e-01 + vertex 3.993926e-02 2.203510e-03 1.000000e-01 + endloop + endfacet + facet normal -4.267764e-01 9.043572e-01 0.000000e+00 + outer loop + vertex 1.806133e-02 -3.569017e-02 8.000000e-02 + vertex 1.606782e-02 -3.663093e-02 1.000000e-01 + vertex 1.806133e-02 -3.569017e-02 1.000000e-01 + endloop + endfacet + facet normal -9.996203e-01 -2.755434e-02 0.000000e+00 + outer loop + vertex 3.993926e-02 2.203510e-03 8.000000e-02 + vertex 4.000000e-02 0.000000e+00 8.000000e-02 + vertex 4.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal -4.759474e-01 8.794738e-01 0.000000e+00 + outer loop + vertex 2.000000e-02 -3.464102e-02 8.000000e-02 + vertex 1.806133e-02 -3.569017e-02 8.000000e-02 + vertex 1.806133e-02 -3.569017e-02 1.000000e-01 + endloop + endfacet + facet normal -9.965845e-01 -8.257935e-02 0.000000e+00 + outer loop + vertex 3.975723e-02 4.400329e-03 8.000000e-02 + vertex 3.993926e-02 2.203510e-03 1.000000e-01 + vertex 3.975723e-02 4.400329e-03 1.000000e-01 + endloop + endfacet + facet normal -4.759474e-01 8.794738e-01 0.000000e+00 + outer loop + vertex 2.000000e-02 -3.464102e-02 8.000000e-02 + vertex 1.806133e-02 -3.569017e-02 1.000000e-01 + vertex 2.000000e-02 -3.464102e-02 1.000000e-01 + endloop + endfacet + facet normal -9.965845e-01 -8.257935e-02 0.000000e+00 + outer loop + vertex 3.975723e-02 4.400329e-03 8.000000e-02 + vertex 3.993926e-02 2.203510e-03 8.000000e-02 + vertex 3.993926e-02 2.203510e-03 1.000000e-01 + endloop + endfacet + facet normal -5.236729e-01 8.519194e-01 0.000000e+00 + outer loop + vertex 2.187793e-02 -3.348666e-02 8.000000e-02 + vertex 2.000000e-02 -3.464102e-02 8.000000e-02 + vertex 2.000000e-02 -3.464102e-02 1.000000e-01 + endloop + endfacet + facet normal -9.905221e-01 -1.373536e-01 0.000000e+00 + outer loop + vertex 3.945445e-02 6.583784e-03 8.000000e-02 + vertex 3.975723e-02 4.400329e-03 1.000000e-01 + vertex 3.945445e-02 6.583784e-03 1.000000e-01 + endloop + endfacet + facet normal -5.236729e-01 8.519194e-01 0.000000e+00 + outer loop + vertex 2.187793e-02 -3.348666e-02 8.000000e-02 + vertex 2.000000e-02 -3.464102e-02 1.000000e-01 + vertex 2.187793e-02 -3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal -9.905221e-01 -1.373536e-01 0.000000e+00 + outer loop + vertex 3.945445e-02 6.583784e-03 8.000000e-02 + vertex 3.975723e-02 4.400329e-03 8.000000e-02 + vertex 3.975723e-02 4.400329e-03 1.000000e-01 + endloop + endfacet + facet normal -5.698081e-01 8.217778e-01 0.000000e+00 + outer loop + vertex 2.368941e-02 -3.223060e-02 8.000000e-02 + vertex 2.187793e-02 -3.348666e-02 8.000000e-02 + vertex 2.187793e-02 -3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal -5.698081e-01 8.217778e-01 0.000000e+00 + outer loop + vertex 2.368941e-02 -3.223060e-02 8.000000e-02 + vertex 2.187793e-02 -3.348666e-02 1.000000e-01 + vertex 2.368941e-02 -3.223060e-02 1.000000e-01 + endloop + endfacet + facet normal -9.814515e-01 -1.917106e-01 0.000000e+00 + outer loop + vertex 3.903186e-02 8.747244e-03 8.000000e-02 + vertex 3.945445e-02 6.583784e-03 1.000000e-01 + vertex 3.903186e-02 8.747244e-03 1.000000e-01 + endloop + endfacet + facet normal -9.814515e-01 -1.917106e-01 0.000000e+00 + outer loop + vertex 3.903186e-02 8.747244e-03 8.000000e-02 + vertex 3.945445e-02 6.583784e-03 8.000000e-02 + vertex 3.945445e-02 6.583784e-03 1.000000e-01 + endloop + endfacet + facet normal -6.142127e-01 7.891405e-01 0.000000e+00 + outer loop + vertex 2.542895e-02 -3.087667e-02 8.000000e-02 + vertex 2.368941e-02 -3.223060e-02 8.000000e-02 + vertex 2.368941e-02 -3.223060e-02 1.000000e-01 + endloop + endfacet + facet normal -6.142127e-01 7.891405e-01 0.000000e+00 + outer loop + vertex 2.542895e-02 -3.087667e-02 8.000000e-02 + vertex 2.368941e-02 -3.223060e-02 1.000000e-01 + vertex 2.542895e-02 -3.087667e-02 1.000000e-01 + endloop + endfacet + facet normal -9.694003e-01 -2.454855e-01 0.000000e+00 + outer loop + vertex 3.849072e-02 1.088414e-02 8.000000e-02 + vertex 3.903186e-02 8.747244e-03 1.000000e-01 + vertex 3.849072e-02 1.088414e-02 1.000000e-01 + endloop + endfacet + facet normal -9.694003e-01 -2.454855e-01 0.000000e+00 + outer loop + vertex 3.849072e-02 1.088414e-02 8.000000e-02 + vertex 3.903186e-02 8.747244e-03 8.000000e-02 + vertex 3.903186e-02 8.747244e-03 1.000000e-01 + endloop + endfacet + facet normal -6.567520e-01 7.541066e-01 0.000000e+00 + outer loop + vertex 2.709126e-02 -2.942896e-02 8.000000e-02 + vertex 2.542895e-02 -3.087667e-02 8.000000e-02 + vertex 2.542895e-02 -3.087667e-02 1.000000e-01 + endloop + endfacet + facet normal -6.567520e-01 7.541066e-01 0.000000e+00 + outer loop + vertex 2.709126e-02 -2.942896e-02 8.000000e-02 + vertex 2.542895e-02 -3.087667e-02 1.000000e-01 + vertex 2.709126e-02 -2.942896e-02 1.000000e-01 + endloop + endfacet + facet normal -9.544050e-01 -2.985148e-01 0.000000e+00 + outer loop + vertex 3.783269e-02 1.298798e-02 8.000000e-02 + vertex 3.849072e-02 1.088414e-02 1.000000e-01 + vertex 3.783269e-02 1.298798e-02 1.000000e-01 + endloop + endfacet + facet normal -9.544050e-01 -2.985148e-01 0.000000e+00 + outer loop + vertex 3.783269e-02 1.298798e-02 8.000000e-02 + vertex 3.849072e-02 1.088414e-02 8.000000e-02 + vertex 3.849072e-02 1.088414e-02 1.000000e-01 + endloop + endfacet + facet normal -6.972968e-01 7.167825e-01 0.000000e+00 + outer loop + vertex 2.867130e-02 -2.789187e-02 8.000000e-02 + vertex 2.709126e-02 -2.942896e-02 8.000000e-02 + vertex 2.709126e-02 -2.942896e-02 1.000000e-01 + endloop + endfacet + facet normal -6.972968e-01 7.167825e-01 0.000000e+00 + outer loop + vertex 2.867130e-02 -2.789187e-02 8.000000e-02 + vertex 2.709126e-02 -2.942896e-02 1.000000e-01 + vertex 2.867130e-02 -2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal -9.365112e-01 -3.506376e-01 0.000000e+00 + outer loop + vertex 3.705976e-02 1.505237e-02 8.000000e-02 + vertex 3.783269e-02 1.298798e-02 1.000000e-01 + vertex 3.705976e-02 1.505237e-02 1.000000e-01 + endloop + endfacet + facet normal -7.357239e-01 6.772816e-01 0.000000e+00 + outer loop + vertex 3.016426e-02 -2.627008e-02 8.000000e-02 + vertex 2.867130e-02 -2.789187e-02 1.000000e-01 + vertex 3.016426e-02 -2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal -9.365112e-01 -3.506376e-01 0.000000e+00 + outer loop + vertex 3.705976e-02 1.505237e-02 8.000000e-02 + vertex 3.783269e-02 1.298798e-02 8.000000e-02 + vertex 3.783269e-02 1.298798e-02 1.000000e-01 + endloop + endfacet + facet normal -7.357239e-01 6.772816e-01 0.000000e+00 + outer loop + vertex 3.016426e-02 -2.627008e-02 8.000000e-02 + vertex 2.867130e-02 -2.789187e-02 8.000000e-02 + vertex 2.867130e-02 -2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal -9.157733e-01 -4.016954e-01 0.000000e+00 + outer loop + vertex 3.617429e-02 1.707106e-02 8.000000e-02 + vertex 3.705976e-02 1.505237e-02 1.000000e-01 + vertex 3.617429e-02 1.707106e-02 1.000000e-01 + endloop + endfacet + facet normal -7.719167e-01 6.357237e-01 0.000000e+00 + outer loop + vertex 3.156562e-02 -2.456851e-02 8.000000e-02 + vertex 3.016426e-02 -2.627008e-02 1.000000e-01 + vertex 3.156562e-02 -2.456851e-02 1.000000e-01 + endloop + endfacet + facet normal -9.157733e-01 -4.016954e-01 0.000000e+00 + outer loop + vertex 3.617429e-02 1.707106e-02 8.000000e-02 + vertex 3.705976e-02 1.505237e-02 8.000000e-02 + vertex 3.705976e-02 1.505237e-02 1.000000e-01 + endloop + endfacet + facet normal -7.719167e-01 6.357237e-01 0.000000e+00 + outer loop + vertex 3.156562e-02 -2.456851e-02 8.000000e-02 + vertex 3.016426e-02 -2.627008e-02 8.000000e-02 + vertex 3.016426e-02 -2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal -8.922542e-01 -4.515334e-01 0.000000e+00 + outer loop + vertex 3.517895e-02 1.903790e-02 8.000000e-02 + vertex 3.617429e-02 1.707106e-02 1.000000e-01 + vertex 3.517895e-02 1.903790e-02 1.000000e-01 + endloop + endfacet + facet normal -8.057651e-01 5.922353e-01 0.000000e+00 + outer loop + vertex 3.287111e-02 -2.279232e-02 8.000000e-02 + vertex 3.156562e-02 -2.456851e-02 1.000000e-01 + vertex 3.287111e-02 -2.279232e-02 1.000000e-01 + endloop + endfacet + facet normal -8.922542e-01 -4.515334e-01 0.000000e+00 + outer loop + vertex 3.517895e-02 1.903790e-02 8.000000e-02 + vertex 3.617429e-02 1.707106e-02 8.000000e-02 + vertex 3.617429e-02 1.707106e-02 1.000000e-01 + endloop + endfacet + facet normal -8.057651e-01 5.922353e-01 0.000000e+00 + outer loop + vertex 3.287111e-02 -2.279232e-02 8.000000e-02 + vertex 3.156562e-02 -2.456851e-02 8.000000e-02 + vertex 3.156562e-02 -2.456851e-02 1.000000e-01 + endloop + endfacet + facet normal -8.371665e-01 5.469482e-01 0.000000e+00 + outer loop + vertex 3.407678e-02 -2.094692e-02 8.000000e-02 + vertex 3.287111e-02 -2.279232e-02 1.000000e-01 + vertex 3.407678e-02 -2.094692e-02 1.000000e-01 + endloop + endfacet + facet normal -8.660254e-01 -5.000000e-01 0.000000e+00 + outer loop + vertex 3.407678e-02 2.094692e-02 8.000000e-02 + vertex 3.517895e-02 1.903790e-02 1.000000e-01 + vertex 3.407678e-02 2.094692e-02 1.000000e-01 + endloop + endfacet + facet normal -8.660254e-01 -5.000000e-01 0.000000e+00 + outer loop + vertex 3.407678e-02 2.094692e-02 8.000000e-02 + vertex 3.517895e-02 1.903790e-02 8.000000e-02 + vertex 3.517895e-02 1.903790e-02 1.000000e-01 + endloop + endfacet + facet normal -8.371665e-01 5.469482e-01 0.000000e+00 + outer loop + vertex 3.407678e-02 -2.094692e-02 8.000000e-02 + vertex 3.287111e-02 -2.279232e-02 8.000000e-02 + vertex 3.287111e-02 -2.279232e-02 1.000000e-01 + endloop + endfacet + facet normal -8.660254e-01 5.000000e-01 0.000000e+00 + outer loop + vertex 3.517895e-02 -1.903790e-02 8.000000e-02 + vertex 3.407678e-02 -2.094692e-02 1.000000e-01 + vertex 3.517895e-02 -1.903790e-02 1.000000e-01 + endloop + endfacet + facet normal -8.371665e-01 -5.469482e-01 0.000000e+00 + outer loop + vertex 3.287111e-02 2.279232e-02 8.000000e-02 + vertex 3.407678e-02 2.094692e-02 1.000000e-01 + vertex 3.287111e-02 2.279232e-02 1.000000e-01 + endloop + endfacet + facet normal -8.660254e-01 5.000000e-01 0.000000e+00 + outer loop + vertex 3.517895e-02 -1.903790e-02 8.000000e-02 + vertex 3.407678e-02 -2.094692e-02 8.000000e-02 + vertex 3.407678e-02 -2.094692e-02 1.000000e-01 + endloop + endfacet + facet normal -8.371665e-01 -5.469482e-01 0.000000e+00 + outer loop + vertex 3.287111e-02 2.279232e-02 8.000000e-02 + vertex 3.407678e-02 2.094692e-02 8.000000e-02 + vertex 3.407678e-02 2.094692e-02 1.000000e-01 + endloop + endfacet + facet normal -8.922542e-01 4.515334e-01 0.000000e+00 + outer loop + vertex 3.617429e-02 -1.707106e-02 8.000000e-02 + vertex 3.517895e-02 -1.903790e-02 1.000000e-01 + vertex 3.617429e-02 -1.707106e-02 1.000000e-01 + endloop + endfacet + facet normal -8.057651e-01 -5.922353e-01 0.000000e+00 + outer loop + vertex 3.156562e-02 2.456851e-02 8.000000e-02 + vertex 3.287111e-02 2.279232e-02 1.000000e-01 + vertex 3.156562e-02 2.456851e-02 1.000000e-01 + endloop + endfacet + facet normal -8.922542e-01 4.515334e-01 0.000000e+00 + outer loop + vertex 3.617429e-02 -1.707106e-02 8.000000e-02 + vertex 3.517895e-02 -1.903790e-02 8.000000e-02 + vertex 3.517895e-02 -1.903790e-02 1.000000e-01 + endloop + endfacet + facet normal -8.057651e-01 -5.922353e-01 0.000000e+00 + outer loop + vertex 3.156562e-02 2.456851e-02 8.000000e-02 + vertex 3.287111e-02 2.279232e-02 8.000000e-02 + vertex 3.287111e-02 2.279232e-02 1.000000e-01 + endloop + endfacet + facet normal -9.157733e-01 4.016954e-01 0.000000e+00 + outer loop + vertex 3.705976e-02 -1.505237e-02 8.000000e-02 + vertex 3.617429e-02 -1.707106e-02 1.000000e-01 + vertex 3.705976e-02 -1.505237e-02 1.000000e-01 + endloop + endfacet + facet normal -7.719167e-01 -6.357237e-01 0.000000e+00 + outer loop + vertex 3.016426e-02 2.627008e-02 8.000000e-02 + vertex 3.156562e-02 2.456851e-02 1.000000e-01 + vertex 3.016426e-02 2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal -9.157733e-01 4.016954e-01 0.000000e+00 + outer loop + vertex 3.705976e-02 -1.505237e-02 8.000000e-02 + vertex 3.617429e-02 -1.707106e-02 8.000000e-02 + vertex 3.617429e-02 -1.707106e-02 1.000000e-01 + endloop + endfacet + facet normal -7.719167e-01 -6.357237e-01 0.000000e+00 + outer loop + vertex 3.016426e-02 2.627008e-02 8.000000e-02 + vertex 3.156562e-02 2.456851e-02 8.000000e-02 + vertex 3.156562e-02 2.456851e-02 1.000000e-01 + endloop + endfacet + facet normal -9.365112e-01 3.506376e-01 0.000000e+00 + outer loop + vertex 3.783269e-02 -1.298798e-02 8.000000e-02 + vertex 3.705976e-02 -1.505237e-02 1.000000e-01 + vertex 3.783269e-02 -1.298798e-02 1.000000e-01 + endloop + endfacet + facet normal -9.365112e-01 3.506376e-01 0.000000e+00 + outer loop + vertex 3.783269e-02 -1.298798e-02 8.000000e-02 + vertex 3.705976e-02 -1.505237e-02 8.000000e-02 + vertex 3.705976e-02 -1.505237e-02 1.000000e-01 + endloop + endfacet + facet normal -7.357239e-01 -6.772816e-01 0.000000e+00 + outer loop + vertex 2.867130e-02 2.789187e-02 8.000000e-02 + vertex 3.016426e-02 2.627008e-02 1.000000e-01 + vertex 2.867130e-02 2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal -7.357239e-01 -6.772816e-01 0.000000e+00 + outer loop + vertex 2.867130e-02 2.789187e-02 8.000000e-02 + vertex 3.016426e-02 2.627008e-02 8.000000e-02 + vertex 3.016426e-02 2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal -9.544050e-01 2.985148e-01 0.000000e+00 + outer loop + vertex 3.849072e-02 -1.088414e-02 8.000000e-02 + vertex 3.783269e-02 -1.298798e-02 1.000000e-01 + vertex 3.849072e-02 -1.088414e-02 1.000000e-01 + endloop + endfacet + facet normal -9.544050e-01 2.985148e-01 0.000000e+00 + outer loop + vertex 3.849072e-02 -1.088414e-02 8.000000e-02 + vertex 3.783269e-02 -1.298798e-02 8.000000e-02 + vertex 3.783269e-02 -1.298798e-02 1.000000e-01 + endloop + endfacet + facet normal -6.972968e-01 -7.167825e-01 0.000000e+00 + outer loop + vertex 2.709126e-02 2.942896e-02 8.000000e-02 + vertex 2.867130e-02 2.789187e-02 1.000000e-01 + vertex 2.709126e-02 2.942896e-02 1.000000e-01 + endloop + endfacet + facet normal -6.972968e-01 -7.167825e-01 0.000000e+00 + outer loop + vertex 2.709126e-02 2.942896e-02 8.000000e-02 + vertex 2.867130e-02 2.789187e-02 8.000000e-02 + vertex 2.867130e-02 2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal -9.694003e-01 2.454855e-01 0.000000e+00 + outer loop + vertex 3.903186e-02 -8.747244e-03 8.000000e-02 + vertex 3.849072e-02 -1.088414e-02 1.000000e-01 + vertex 3.903186e-02 -8.747244e-03 1.000000e-01 + endloop + endfacet + facet normal -9.694003e-01 2.454855e-01 0.000000e+00 + outer loop + vertex 3.903186e-02 -8.747244e-03 8.000000e-02 + vertex 3.849072e-02 -1.088414e-02 8.000000e-02 + vertex 3.849072e-02 -1.088414e-02 1.000000e-01 + endloop + endfacet + facet normal -6.567520e-01 -7.541066e-01 0.000000e+00 + outer loop + vertex 2.542895e-02 3.087667e-02 8.000000e-02 + vertex 2.709126e-02 2.942896e-02 1.000000e-01 + vertex 2.542895e-02 3.087667e-02 1.000000e-01 + endloop + endfacet + facet normal -9.814515e-01 1.917106e-01 0.000000e+00 + outer loop + vertex 3.945445e-02 -6.583784e-03 8.000000e-02 + vertex 3.903186e-02 -8.747244e-03 1.000000e-01 + vertex 3.945445e-02 -6.583784e-03 1.000000e-01 + endloop + endfacet + facet normal -6.567520e-01 -7.541066e-01 0.000000e+00 + outer loop + vertex 2.542895e-02 3.087667e-02 8.000000e-02 + vertex 2.709126e-02 2.942896e-02 8.000000e-02 + vertex 2.709126e-02 2.942896e-02 1.000000e-01 + endloop + endfacet + facet normal -9.814515e-01 1.917106e-01 0.000000e+00 + outer loop + vertex 3.945445e-02 -6.583784e-03 8.000000e-02 + vertex 3.903186e-02 -8.747244e-03 8.000000e-02 + vertex 3.903186e-02 -8.747244e-03 1.000000e-01 + endloop + endfacet + facet normal -6.142127e-01 -7.891405e-01 0.000000e+00 + outer loop + vertex 2.368941e-02 3.223060e-02 8.000000e-02 + vertex 2.542895e-02 3.087667e-02 8.000000e-02 + vertex 2.542895e-02 3.087667e-02 1.000000e-01 + endloop + endfacet + facet normal -6.142127e-01 -7.891405e-01 0.000000e+00 + outer loop + vertex 2.368941e-02 3.223060e-02 8.000000e-02 + vertex 2.542895e-02 3.087667e-02 1.000000e-01 + vertex 2.368941e-02 3.223060e-02 1.000000e-01 + endloop + endfacet + facet normal -9.905221e-01 1.373536e-01 0.000000e+00 + outer loop + vertex 3.975723e-02 -4.400329e-03 8.000000e-02 + vertex 3.945445e-02 -6.583784e-03 1.000000e-01 + vertex 3.975723e-02 -4.400329e-03 1.000000e-01 + endloop + endfacet + facet normal -9.905221e-01 1.373536e-01 0.000000e+00 + outer loop + vertex 3.975723e-02 -4.400329e-03 8.000000e-02 + vertex 3.945445e-02 -6.583784e-03 8.000000e-02 + vertex 3.945445e-02 -6.583784e-03 1.000000e-01 + endloop + endfacet + facet normal -9.965845e-01 8.257935e-02 0.000000e+00 + outer loop + vertex 3.993926e-02 -2.203510e-03 8.000000e-02 + vertex 3.975723e-02 -4.400329e-03 1.000000e-01 + vertex 3.993926e-02 -2.203510e-03 1.000000e-01 + endloop + endfacet + facet normal -9.965845e-01 8.257935e-02 0.000000e+00 + outer loop + vertex 3.993926e-02 -2.203510e-03 8.000000e-02 + vertex 3.975723e-02 -4.400329e-03 8.000000e-02 + vertex 3.975723e-02 -4.400329e-03 1.000000e-01 + endloop + endfacet + facet normal -5.698081e-01 -8.217778e-01 0.000000e+00 + outer loop + vertex 2.187793e-02 3.348666e-02 8.000000e-02 + vertex 2.368941e-02 3.223060e-02 8.000000e-02 + vertex 2.368941e-02 3.223060e-02 1.000000e-01 + endloop + endfacet + facet normal -5.698081e-01 -8.217778e-01 0.000000e+00 + outer loop + vertex 2.187793e-02 3.348666e-02 8.000000e-02 + vertex 2.368941e-02 3.223060e-02 1.000000e-01 + vertex 2.187793e-02 3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal -9.996203e-01 2.755434e-02 0.000000e+00 + outer loop + vertex 4.000000e-02 0.000000e+00 8.000000e-02 + vertex 3.993926e-02 -2.203510e-03 1.000000e-01 + vertex 4.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal -9.996203e-01 2.755434e-02 0.000000e+00 + outer loop + vertex 4.000000e-02 0.000000e+00 8.000000e-02 + vertex 3.993926e-02 -2.203510e-03 8.000000e-02 + vertex 3.993926e-02 -2.203510e-03 1.000000e-01 + endloop + endfacet + facet normal -5.236729e-01 -8.519194e-01 0.000000e+00 + outer loop + vertex 2.000000e-02 3.464102e-02 8.000000e-02 + vertex 2.187793e-02 3.348666e-02 8.000000e-02 + vertex 2.187793e-02 3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal -5.236729e-01 -8.519194e-01 0.000000e+00 + outer loop + vertex 2.000000e-02 3.464102e-02 8.000000e-02 + vertex 2.187793e-02 3.348666e-02 1.000000e-01 + vertex 2.000000e-02 3.464102e-02 1.000000e-01 + endloop + endfacet + facet normal -4.759474e-01 -8.794738e-01 0.000000e+00 + outer loop + vertex 1.806133e-02 3.569017e-02 8.000000e-02 + vertex 2.000000e-02 3.464102e-02 8.000000e-02 + vertex 2.000000e-02 3.464102e-02 1.000000e-01 + endloop + endfacet + facet normal -4.759474e-01 -8.794738e-01 0.000000e+00 + outer loop + vertex 1.806133e-02 3.569017e-02 8.000000e-02 + vertex 2.000000e-02 3.464102e-02 1.000000e-01 + vertex 1.806133e-02 3.569017e-02 1.000000e-01 + endloop + endfacet + facet normal -4.267764e-01 -9.043572e-01 0.000000e+00 + outer loop + vertex 1.606782e-02 3.663093e-02 8.000000e-02 + vertex 1.806133e-02 3.569017e-02 8.000000e-02 + vertex 1.806133e-02 3.569017e-02 1.000000e-01 + endloop + endfacet + facet normal -4.267764e-01 -9.043572e-01 0.000000e+00 + outer loop + vertex 1.606782e-02 3.663093e-02 8.000000e-02 + vertex 1.806133e-02 3.569017e-02 1.000000e-01 + vertex 1.606782e-02 3.663093e-02 1.000000e-01 + endloop + endfacet + facet normal -3.763094e-01 -9.264941e-01 0.000000e+00 + outer loop + vertex 1.402550e-02 3.746045e-02 8.000000e-02 + vertex 1.606782e-02 3.663093e-02 1.000000e-01 + vertex 1.402550e-02 3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal -3.763094e-01 -9.264941e-01 0.000000e+00 + outer loop + vertex 1.402550e-02 3.746045e-02 8.000000e-02 + vertex 1.606782e-02 3.663093e-02 8.000000e-02 + vertex 1.606782e-02 3.663093e-02 1.000000e-01 + endloop + endfacet + facet normal -3.246995e-01 -9.458172e-01 0.000000e+00 + outer loop + vertex 1.194059e-02 3.817620e-02 8.000000e-02 + vertex 1.402550e-02 3.746045e-02 1.000000e-01 + vertex 1.194059e-02 3.817620e-02 1.000000e-01 + endloop + endfacet + facet normal -3.246995e-01 -9.458172e-01 0.000000e+00 + outer loop + vertex 1.194059e-02 3.817620e-02 8.000000e-02 + vertex 1.402550e-02 3.746045e-02 8.000000e-02 + vertex 1.402550e-02 3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal -2.721035e-01 -9.622680e-01 0.000000e+00 + outer loop + vertex 9.819419e-03 3.877601e-02 8.000000e-02 + vertex 1.194059e-02 3.817620e-02 1.000000e-01 + vertex 9.819419e-03 3.877601e-02 1.000000e-01 + endloop + endfacet + facet normal -2.721035e-01 -9.622680e-01 0.000000e+00 + outer loop + vertex 9.819419e-03 3.877601e-02 8.000000e-02 + vertex 1.194059e-02 3.817620e-02 8.000000e-02 + vertex 1.194059e-02 3.817620e-02 1.000000e-01 + endloop + endfacet + facet normal -2.186811e-01 -9.757964e-01 0.000000e+00 + outer loop + vertex 7.668425e-03 3.925806e-02 8.000000e-02 + vertex 9.819419e-03 3.877601e-02 1.000000e-01 + vertex 7.668425e-03 3.925806e-02 1.000000e-01 + endloop + endfacet + facet normal -2.186811e-01 -9.757964e-01 0.000000e+00 + outer loop + vertex 7.668425e-03 3.925806e-02 8.000000e-02 + vertex 9.819419e-03 3.877601e-02 8.000000e-02 + vertex 9.819419e-03 3.877601e-02 1.000000e-01 + endloop + endfacet + facet normal -1.645946e-01 -9.863613e-01 0.000000e+00 + outer loop + vertex 5.494142e-03 3.962088e-02 8.000000e-02 + vertex 7.668425e-03 3.925806e-02 1.000000e-01 + vertex 5.494142e-03 3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal -1.645946e-01 -9.863613e-01 0.000000e+00 + outer loop + vertex 5.494142e-03 3.962088e-02 8.000000e-02 + vertex 7.668425e-03 3.925806e-02 8.000000e-02 + vertex 7.668425e-03 3.925806e-02 1.000000e-01 + endloop + endfacet + facet normal -1.100082e-01 -9.939307e-01 0.000000e+00 + outer loop + vertex 3.303174e-03 3.986338e-02 8.000000e-02 + vertex 5.494142e-03 3.962088e-02 1.000000e-01 + vertex 3.303174e-03 3.986338e-02 1.000000e-01 + endloop + endfacet + facet normal -1.100082e-01 -9.939307e-01 0.000000e+00 + outer loop + vertex 3.303174e-03 3.986338e-02 8.000000e-02 + vertex 5.494142e-03 3.962088e-02 8.000000e-02 + vertex 5.494142e-03 3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal -5.508776e-02 -9.984815e-01 0.000000e+00 + outer loop + vertex 1.102174e-03 3.998481e-02 8.000000e-02 + vertex 3.303174e-03 3.986338e-02 1.000000e-01 + vertex 1.102174e-03 3.998481e-02 1.000000e-01 + endloop + endfacet + facet normal -5.508776e-02 -9.984815e-01 0.000000e+00 + outer loop + vertex 1.102174e-03 3.998481e-02 8.000000e-02 + vertex 3.303174e-03 3.986338e-02 8.000000e-02 + vertex 3.303174e-03 3.986338e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 -1.000000e+00 0.000000e+00 + outer loop + vertex -1.102174e-03 3.998481e-02 8.000000e-02 + vertex 1.102174e-03 3.998481e-02 1.000000e-01 + vertex -1.102174e-03 3.998481e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 -1.000000e+00 0.000000e+00 + outer loop + vertex -1.102174e-03 3.998481e-02 8.000000e-02 + vertex 1.102174e-03 3.998481e-02 8.000000e-02 + vertex 1.102174e-03 3.998481e-02 1.000000e-01 + endloop + endfacet + facet normal 5.508776e-02 -9.984815e-01 0.000000e+00 + outer loop + vertex -3.303174e-03 3.986338e-02 8.000000e-02 + vertex -1.102174e-03 3.998481e-02 1.000000e-01 + vertex -3.303174e-03 3.986338e-02 1.000000e-01 + endloop + endfacet + facet normal 5.508776e-02 -9.984815e-01 0.000000e+00 + outer loop + vertex -3.303174e-03 3.986338e-02 8.000000e-02 + vertex -1.102174e-03 3.998481e-02 8.000000e-02 + vertex -1.102174e-03 3.998481e-02 1.000000e-01 + endloop + endfacet + facet normal 1.100082e-01 -9.939307e-01 0.000000e+00 + outer loop + vertex -5.494142e-03 3.962088e-02 8.000000e-02 + vertex -3.303174e-03 3.986338e-02 1.000000e-01 + vertex -5.494142e-03 3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal 1.100082e-01 -9.939307e-01 0.000000e+00 + outer loop + vertex -5.494142e-03 3.962088e-02 8.000000e-02 + vertex -3.303174e-03 3.986338e-02 8.000000e-02 + vertex -3.303174e-03 3.986338e-02 1.000000e-01 + endloop + endfacet + facet normal 1.645946e-01 -9.863613e-01 0.000000e+00 + outer loop + vertex -7.668425e-03 3.925806e-02 8.000000e-02 + vertex -5.494142e-03 3.962088e-02 1.000000e-01 + vertex -7.668425e-03 3.925806e-02 1.000000e-01 + endloop + endfacet + facet normal 1.645946e-01 -9.863613e-01 0.000000e+00 + outer loop + vertex -7.668425e-03 3.925806e-02 8.000000e-02 + vertex -5.494142e-03 3.962088e-02 8.000000e-02 + vertex -5.494142e-03 3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal 2.186811e-01 -9.757964e-01 0.000000e+00 + outer loop + vertex -9.819419e-03 3.877601e-02 8.000000e-02 + vertex -7.668425e-03 3.925806e-02 1.000000e-01 + vertex -9.819419e-03 3.877601e-02 1.000000e-01 + endloop + endfacet + facet normal 2.186811e-01 -9.757964e-01 0.000000e+00 + outer loop + vertex -9.819419e-03 3.877601e-02 8.000000e-02 + vertex -7.668425e-03 3.925806e-02 8.000000e-02 + vertex -7.668425e-03 3.925806e-02 1.000000e-01 + endloop + endfacet + facet normal 2.721035e-01 -9.622680e-01 0.000000e+00 + outer loop + vertex -1.194059e-02 3.817620e-02 8.000000e-02 + vertex -9.819419e-03 3.877601e-02 1.000000e-01 + vertex -1.194059e-02 3.817620e-02 1.000000e-01 + endloop + endfacet + facet normal 2.721035e-01 -9.622680e-01 0.000000e+00 + outer loop + vertex -1.194059e-02 3.817620e-02 8.000000e-02 + vertex -9.819419e-03 3.877601e-02 8.000000e-02 + vertex -9.819419e-03 3.877601e-02 1.000000e-01 + endloop + endfacet + facet normal 3.246995e-01 -9.458172e-01 0.000000e+00 + outer loop + vertex -1.402550e-02 3.746045e-02 8.000000e-02 + vertex -1.194059e-02 3.817620e-02 1.000000e-01 + vertex -1.402550e-02 3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal 3.246995e-01 -9.458172e-01 0.000000e+00 + outer loop + vertex -1.402550e-02 3.746045e-02 8.000000e-02 + vertex -1.194059e-02 3.817620e-02 8.000000e-02 + vertex -1.194059e-02 3.817620e-02 1.000000e-01 + endloop + endfacet + facet normal 3.763094e-01 -9.264941e-01 0.000000e+00 + outer loop + vertex -1.606782e-02 3.663093e-02 8.000000e-02 + vertex -1.402550e-02 3.746045e-02 1.000000e-01 + vertex -1.606782e-02 3.663093e-02 1.000000e-01 + endloop + endfacet + facet normal 3.763094e-01 -9.264941e-01 0.000000e+00 + outer loop + vertex -1.606782e-02 3.663093e-02 8.000000e-02 + vertex -1.402550e-02 3.746045e-02 8.000000e-02 + vertex -1.402550e-02 3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal 4.267764e-01 -9.043572e-01 0.000000e+00 + outer loop + vertex -1.806133e-02 3.569017e-02 8.000000e-02 + vertex -1.606782e-02 3.663093e-02 1.000000e-01 + vertex -1.806133e-02 3.569017e-02 1.000000e-01 + endloop + endfacet + facet normal 4.267764e-01 -9.043572e-01 0.000000e+00 + outer loop + vertex -1.806133e-02 3.569017e-02 8.000000e-02 + vertex -1.606782e-02 3.663093e-02 8.000000e-02 + vertex -1.606782e-02 3.663093e-02 1.000000e-01 + endloop + endfacet + facet normal 4.759474e-01 -8.794738e-01 0.000000e+00 + outer loop + vertex -2.000000e-02 3.464102e-02 8.000000e-02 + vertex -1.806133e-02 3.569017e-02 1.000000e-01 + vertex -2.000000e-02 3.464102e-02 1.000000e-01 + endloop + endfacet + facet normal 4.759474e-01 -8.794738e-01 0.000000e+00 + outer loop + vertex -2.000000e-02 3.464102e-02 8.000000e-02 + vertex -1.806133e-02 3.569017e-02 8.000000e-02 + vertex -1.806133e-02 3.569017e-02 1.000000e-01 + endloop + endfacet + facet normal 5.236729e-01 -8.519194e-01 0.000000e+00 + outer loop + vertex -2.187793e-02 3.348666e-02 8.000000e-02 + vertex -2.000000e-02 3.464102e-02 1.000000e-01 + vertex -2.187793e-02 3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal 5.236729e-01 -8.519194e-01 0.000000e+00 + outer loop + vertex -2.187793e-02 3.348666e-02 8.000000e-02 + vertex -2.000000e-02 3.464102e-02 8.000000e-02 + vertex -2.000000e-02 3.464102e-02 1.000000e-01 + endloop + endfacet + facet normal 5.698081e-01 -8.217778e-01 0.000000e+00 + outer loop + vertex -2.368941e-02 3.223060e-02 8.000000e-02 + vertex -2.187793e-02 3.348666e-02 1.000000e-01 + vertex -2.368941e-02 3.223060e-02 1.000000e-01 + endloop + endfacet + facet normal 5.698081e-01 -8.217778e-01 0.000000e+00 + outer loop + vertex -2.368941e-02 3.223060e-02 8.000000e-02 + vertex -2.187793e-02 3.348666e-02 8.000000e-02 + vertex -2.187793e-02 3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal 6.142127e-01 -7.891405e-01 0.000000e+00 + outer loop + vertex -2.542895e-02 3.087667e-02 8.000000e-02 + vertex -2.368941e-02 3.223060e-02 1.000000e-01 + vertex -2.542895e-02 3.087667e-02 1.000000e-01 + endloop + endfacet + facet normal 6.142127e-01 -7.891405e-01 0.000000e+00 + outer loop + vertex -2.542895e-02 3.087667e-02 8.000000e-02 + vertex -2.368941e-02 3.223060e-02 8.000000e-02 + vertex -2.368941e-02 3.223060e-02 1.000000e-01 + endloop + endfacet + facet normal 6.567520e-01 -7.541066e-01 0.000000e+00 + outer loop + vertex -2.709126e-02 2.942896e-02 8.000000e-02 + vertex -2.542895e-02 3.087667e-02 1.000000e-01 + vertex -2.709126e-02 2.942896e-02 1.000000e-01 + endloop + endfacet + facet normal 6.567520e-01 -7.541066e-01 0.000000e+00 + outer loop + vertex -2.709126e-02 2.942896e-02 8.000000e-02 + vertex -2.542895e-02 3.087667e-02 8.000000e-02 + vertex -2.542895e-02 3.087667e-02 1.000000e-01 + endloop + endfacet + facet normal 6.972968e-01 -7.167825e-01 0.000000e+00 + outer loop + vertex -2.867130e-02 2.789187e-02 8.000000e-02 + vertex -2.709126e-02 2.942896e-02 8.000000e-02 + vertex -2.709126e-02 2.942896e-02 1.000000e-01 + endloop + endfacet + facet normal 6.972968e-01 -7.167825e-01 0.000000e+00 + outer loop + vertex -2.867130e-02 2.789187e-02 8.000000e-02 + vertex -2.709126e-02 2.942896e-02 1.000000e-01 + vertex -2.867130e-02 2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal 7.357239e-01 -6.772816e-01 0.000000e+00 + outer loop + vertex -3.016426e-02 2.627008e-02 8.000000e-02 + vertex -2.867130e-02 2.789187e-02 8.000000e-02 + vertex -2.867130e-02 2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal 7.357239e-01 -6.772816e-01 0.000000e+00 + outer loop + vertex -3.016426e-02 2.627008e-02 8.000000e-02 + vertex -2.867130e-02 2.789187e-02 1.000000e-01 + vertex -3.016426e-02 2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal 7.719167e-01 -6.357237e-01 0.000000e+00 + outer loop + vertex -3.156562e-02 2.456851e-02 8.000000e-02 + vertex -3.016426e-02 2.627008e-02 8.000000e-02 + vertex -3.016426e-02 2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal 7.719167e-01 -6.357237e-01 0.000000e+00 + outer loop + vertex -3.156562e-02 2.456851e-02 8.000000e-02 + vertex -3.016426e-02 2.627008e-02 1.000000e-01 + vertex -3.156562e-02 2.456851e-02 1.000000e-01 + endloop + endfacet + facet normal 8.057651e-01 -5.922353e-01 0.000000e+00 + outer loop + vertex -3.287111e-02 2.279232e-02 8.000000e-02 + vertex -3.156562e-02 2.456851e-02 8.000000e-02 + vertex -3.156562e-02 2.456851e-02 1.000000e-01 + endloop + endfacet + facet normal 8.057651e-01 -5.922353e-01 0.000000e+00 + outer loop + vertex -3.287111e-02 2.279232e-02 8.000000e-02 + vertex -3.156562e-02 2.456851e-02 1.000000e-01 + vertex -3.287111e-02 2.279232e-02 1.000000e-01 + endloop + endfacet + facet normal 8.371665e-01 -5.469482e-01 0.000000e+00 + outer loop + vertex -3.407678e-02 2.094692e-02 8.000000e-02 + vertex -3.287111e-02 2.279232e-02 8.000000e-02 + vertex -3.287111e-02 2.279232e-02 1.000000e-01 + endloop + endfacet + facet normal 8.371665e-01 -5.469482e-01 0.000000e+00 + outer loop + vertex -3.407678e-02 2.094692e-02 8.000000e-02 + vertex -3.287111e-02 2.279232e-02 1.000000e-01 + vertex -3.407678e-02 2.094692e-02 1.000000e-01 + endloop + endfacet + facet normal 8.660254e-01 -5.000000e-01 0.000000e+00 + outer loop + vertex -3.517895e-02 1.903790e-02 8.000000e-02 + vertex -3.407678e-02 2.094692e-02 8.000000e-02 + vertex -3.407678e-02 2.094692e-02 1.000000e-01 + endloop + endfacet + facet normal 8.660254e-01 -5.000000e-01 0.000000e+00 + outer loop + vertex -3.517895e-02 1.903790e-02 8.000000e-02 + vertex -3.407678e-02 2.094692e-02 1.000000e-01 + vertex -3.517895e-02 1.903790e-02 1.000000e-01 + endloop + endfacet + facet normal 8.922542e-01 -4.515334e-01 0.000000e+00 + outer loop + vertex -3.617429e-02 1.707106e-02 8.000000e-02 + vertex -3.517895e-02 1.903790e-02 8.000000e-02 + vertex -3.517895e-02 1.903790e-02 1.000000e-01 + endloop + endfacet + facet normal 8.922542e-01 -4.515334e-01 0.000000e+00 + outer loop + vertex -3.617429e-02 1.707106e-02 8.000000e-02 + vertex -3.517895e-02 1.903790e-02 1.000000e-01 + vertex -3.617429e-02 1.707106e-02 1.000000e-01 + endloop + endfacet + facet normal 9.157733e-01 -4.016954e-01 0.000000e+00 + outer loop + vertex -3.705976e-02 1.505237e-02 8.000000e-02 + vertex -3.617429e-02 1.707106e-02 8.000000e-02 + vertex -3.617429e-02 1.707106e-02 1.000000e-01 + endloop + endfacet + facet normal 9.157733e-01 -4.016954e-01 0.000000e+00 + outer loop + vertex -3.705976e-02 1.505237e-02 8.000000e-02 + vertex -3.617429e-02 1.707106e-02 1.000000e-01 + vertex -3.705976e-02 1.505237e-02 1.000000e-01 + endloop + endfacet + facet normal 9.365112e-01 -3.506376e-01 0.000000e+00 + outer loop + vertex -3.783269e-02 1.298798e-02 8.000000e-02 + vertex -3.705976e-02 1.505237e-02 8.000000e-02 + vertex -3.705976e-02 1.505237e-02 1.000000e-01 + endloop + endfacet + facet normal 9.365112e-01 -3.506376e-01 0.000000e+00 + outer loop + vertex -3.783269e-02 1.298798e-02 8.000000e-02 + vertex -3.705976e-02 1.505237e-02 1.000000e-01 + vertex -3.783269e-02 1.298798e-02 1.000000e-01 + endloop + endfacet + facet normal 9.544050e-01 -2.985148e-01 0.000000e+00 + outer loop + vertex -3.849072e-02 1.088414e-02 8.000000e-02 + vertex -3.783269e-02 1.298798e-02 8.000000e-02 + vertex -3.783269e-02 1.298798e-02 1.000000e-01 + endloop + endfacet + facet normal 9.544050e-01 -2.985148e-01 0.000000e+00 + outer loop + vertex -3.849072e-02 1.088414e-02 8.000000e-02 + vertex -3.783269e-02 1.298798e-02 1.000000e-01 + vertex -3.849072e-02 1.088414e-02 1.000000e-01 + endloop + endfacet + facet normal 9.694003e-01 -2.454855e-01 0.000000e+00 + outer loop + vertex -3.903186e-02 8.747244e-03 8.000000e-02 + vertex -3.849072e-02 1.088414e-02 8.000000e-02 + vertex -3.849072e-02 1.088414e-02 1.000000e-01 + endloop + endfacet + facet normal 9.694003e-01 -2.454855e-01 0.000000e+00 + outer loop + vertex -3.903186e-02 8.747244e-03 8.000000e-02 + vertex -3.849072e-02 1.088414e-02 1.000000e-01 + vertex -3.903186e-02 8.747244e-03 1.000000e-01 + endloop + endfacet + facet normal 9.814515e-01 -1.917106e-01 0.000000e+00 + outer loop + vertex -3.945445e-02 6.583784e-03 8.000000e-02 + vertex -3.903186e-02 8.747244e-03 8.000000e-02 + vertex -3.903186e-02 8.747244e-03 1.000000e-01 + endloop + endfacet + facet normal 9.814515e-01 -1.917106e-01 0.000000e+00 + outer loop + vertex -3.945445e-02 6.583784e-03 8.000000e-02 + vertex -3.903186e-02 8.747244e-03 1.000000e-01 + vertex -3.945445e-02 6.583784e-03 1.000000e-01 + endloop + endfacet + facet normal 9.905221e-01 -1.373536e-01 0.000000e+00 + outer loop + vertex -3.975723e-02 4.400329e-03 8.000000e-02 + vertex -3.945445e-02 6.583784e-03 8.000000e-02 + vertex -3.945445e-02 6.583784e-03 1.000000e-01 + endloop + endfacet + facet normal 9.905221e-01 -1.373536e-01 0.000000e+00 + outer loop + vertex -3.975723e-02 4.400329e-03 8.000000e-02 + vertex -3.945445e-02 6.583784e-03 1.000000e-01 + vertex -3.975723e-02 4.400329e-03 1.000000e-01 + endloop + endfacet + facet normal 9.965845e-01 -8.257935e-02 0.000000e+00 + outer loop + vertex -3.993926e-02 2.203510e-03 8.000000e-02 + vertex -3.975723e-02 4.400329e-03 8.000000e-02 + vertex -3.975723e-02 4.400329e-03 1.000000e-01 + endloop + endfacet + facet normal 9.965845e-01 -8.257935e-02 0.000000e+00 + outer loop + vertex -3.993926e-02 2.203510e-03 8.000000e-02 + vertex -3.975723e-02 4.400329e-03 1.000000e-01 + vertex -3.993926e-02 2.203510e-03 1.000000e-01 + endloop + endfacet + facet normal 9.996203e-01 -2.755434e-02 0.000000e+00 + outer loop + vertex -4.000000e-02 4.898587e-18 8.000000e-02 + vertex -3.993926e-02 2.203510e-03 1.000000e-01 + vertex -4.000000e-02 4.898587e-18 1.000000e-01 + endloop + endfacet + facet normal 9.996203e-01 -2.755434e-02 0.000000e+00 + outer loop + vertex -4.000000e-02 4.898587e-18 8.000000e-02 + vertex -3.993926e-02 2.203510e-03 8.000000e-02 + vertex -3.993926e-02 2.203510e-03 1.000000e-01 + endloop + endfacet + facet normal 9.996203e-01 2.755434e-02 0.000000e+00 + outer loop + vertex -3.993926e-02 -2.203510e-03 8.000000e-02 + vertex -4.000000e-02 4.898587e-18 1.000000e-01 + vertex -3.993926e-02 -2.203510e-03 1.000000e-01 + endloop + endfacet + facet normal 9.996203e-01 2.755434e-02 -0.000000e+00 + outer loop + vertex -3.993926e-02 -2.203510e-03 8.000000e-02 + vertex -4.000000e-02 4.898587e-18 8.000000e-02 + vertex -4.000000e-02 4.898587e-18 1.000000e-01 + endloop + endfacet + facet normal 9.965845e-01 8.257935e-02 0.000000e+00 + outer loop + vertex -3.975723e-02 -4.400329e-03 8.000000e-02 + vertex -3.993926e-02 -2.203510e-03 1.000000e-01 + vertex -3.975723e-02 -4.400329e-03 1.000000e-01 + endloop + endfacet + facet normal 9.965845e-01 8.257935e-02 -0.000000e+00 + outer loop + vertex -3.975723e-02 -4.400329e-03 8.000000e-02 + vertex -3.993926e-02 -2.203510e-03 8.000000e-02 + vertex -3.993926e-02 -2.203510e-03 1.000000e-01 + endloop + endfacet + facet normal 9.905221e-01 1.373536e-01 0.000000e+00 + outer loop + vertex -3.945445e-02 -6.583784e-03 8.000000e-02 + vertex -3.975723e-02 -4.400329e-03 1.000000e-01 + vertex -3.945445e-02 -6.583784e-03 1.000000e-01 + endloop + endfacet + facet normal 9.905221e-01 1.373536e-01 -0.000000e+00 + outer loop + vertex -3.945445e-02 -6.583784e-03 8.000000e-02 + vertex -3.975723e-02 -4.400329e-03 8.000000e-02 + vertex -3.975723e-02 -4.400329e-03 1.000000e-01 + endloop + endfacet + facet normal 9.814515e-01 1.917106e-01 0.000000e+00 + outer loop + vertex -3.903186e-02 -8.747244e-03 8.000000e-02 + vertex -3.945445e-02 -6.583784e-03 1.000000e-01 + vertex -3.903186e-02 -8.747244e-03 1.000000e-01 + endloop + endfacet + facet normal 9.814515e-01 1.917106e-01 -0.000000e+00 + outer loop + vertex -3.903186e-02 -8.747244e-03 8.000000e-02 + vertex -3.945445e-02 -6.583784e-03 8.000000e-02 + vertex -3.945445e-02 -6.583784e-03 1.000000e-01 + endloop + endfacet + facet normal 9.694003e-01 2.454855e-01 -0.000000e+00 + outer loop + vertex -3.849072e-02 -1.088414e-02 8.000000e-02 + vertex -3.903186e-02 -8.747244e-03 8.000000e-02 + vertex -3.903186e-02 -8.747244e-03 1.000000e-01 + endloop + endfacet + facet normal 9.694003e-01 2.454855e-01 0.000000e+00 + outer loop + vertex -3.849072e-02 -1.088414e-02 8.000000e-02 + vertex -3.903186e-02 -8.747244e-03 1.000000e-01 + vertex -3.849072e-02 -1.088414e-02 1.000000e-01 + endloop + endfacet + facet normal 9.544050e-01 2.985148e-01 0.000000e+00 + outer loop + vertex -3.783269e-02 -1.298798e-02 8.000000e-02 + vertex -3.849072e-02 -1.088414e-02 1.000000e-01 + vertex -3.783269e-02 -1.298798e-02 1.000000e-01 + endloop + endfacet + facet normal 9.544050e-01 2.985148e-01 -0.000000e+00 + outer loop + vertex -3.783269e-02 -1.298798e-02 8.000000e-02 + vertex -3.849072e-02 -1.088414e-02 8.000000e-02 + vertex -3.849072e-02 -1.088414e-02 1.000000e-01 + endloop + endfacet + facet normal 9.365112e-01 3.506376e-01 0.000000e+00 + outer loop + vertex -3.705976e-02 -1.505237e-02 8.000000e-02 + vertex -3.783269e-02 -1.298798e-02 1.000000e-01 + vertex -3.705976e-02 -1.505237e-02 1.000000e-01 + endloop + endfacet + facet normal 9.365112e-01 3.506376e-01 -0.000000e+00 + outer loop + vertex -3.705976e-02 -1.505237e-02 8.000000e-02 + vertex -3.783269e-02 -1.298798e-02 8.000000e-02 + vertex -3.783269e-02 -1.298798e-02 1.000000e-01 + endloop + endfacet + facet normal 9.157733e-01 4.016954e-01 0.000000e+00 + outer loop + vertex -3.617429e-02 -1.707106e-02 8.000000e-02 + vertex -3.705976e-02 -1.505237e-02 1.000000e-01 + vertex -3.617429e-02 -1.707106e-02 1.000000e-01 + endloop + endfacet + facet normal 9.157733e-01 4.016954e-01 -0.000000e+00 + outer loop + vertex -3.617429e-02 -1.707106e-02 8.000000e-02 + vertex -3.705976e-02 -1.505237e-02 8.000000e-02 + vertex -3.705976e-02 -1.505237e-02 1.000000e-01 + endloop + endfacet + facet normal 8.922542e-01 4.515334e-01 0.000000e+00 + outer loop + vertex -3.517895e-02 -1.903790e-02 8.000000e-02 + vertex -3.617429e-02 -1.707106e-02 1.000000e-01 + vertex -3.517895e-02 -1.903790e-02 1.000000e-01 + endloop + endfacet + facet normal 8.922542e-01 4.515334e-01 -0.000000e+00 + outer loop + vertex -3.517895e-02 -1.903790e-02 8.000000e-02 + vertex -3.617429e-02 -1.707106e-02 8.000000e-02 + vertex -3.617429e-02 -1.707106e-02 1.000000e-01 + endloop + endfacet + facet normal 8.660254e-01 5.000000e-01 0.000000e+00 + outer loop + vertex -3.407678e-02 -2.094692e-02 8.000000e-02 + vertex -3.517895e-02 -1.903790e-02 1.000000e-01 + vertex -3.407678e-02 -2.094692e-02 1.000000e-01 + endloop + endfacet + facet normal 8.660254e-01 5.000000e-01 -0.000000e+00 + outer loop + vertex -3.407678e-02 -2.094692e-02 8.000000e-02 + vertex -3.517895e-02 -1.903790e-02 8.000000e-02 + vertex -3.517895e-02 -1.903790e-02 1.000000e-01 + endloop + endfacet + facet normal 8.371665e-01 5.469482e-01 -0.000000e+00 + outer loop + vertex -3.287111e-02 -2.279232e-02 8.000000e-02 + vertex -3.407678e-02 -2.094692e-02 8.000000e-02 + vertex -3.407678e-02 -2.094692e-02 1.000000e-01 + endloop + endfacet + facet normal 8.371665e-01 5.469482e-01 0.000000e+00 + outer loop + vertex -3.287111e-02 -2.279232e-02 8.000000e-02 + vertex -3.407678e-02 -2.094692e-02 1.000000e-01 + vertex -3.287111e-02 -2.279232e-02 1.000000e-01 + endloop + endfacet + facet normal 8.057651e-01 5.922353e-01 -0.000000e+00 + outer loop + vertex -3.156562e-02 -2.456851e-02 8.000000e-02 + vertex -3.287111e-02 -2.279232e-02 8.000000e-02 + vertex -3.287111e-02 -2.279232e-02 1.000000e-01 + endloop + endfacet + facet normal 8.057651e-01 5.922353e-01 0.000000e+00 + outer loop + vertex -3.156562e-02 -2.456851e-02 8.000000e-02 + vertex -3.287111e-02 -2.279232e-02 1.000000e-01 + vertex -3.156562e-02 -2.456851e-02 1.000000e-01 + endloop + endfacet + facet normal 7.719167e-01 6.357237e-01 -0.000000e+00 + outer loop + vertex -3.016426e-02 -2.627008e-02 8.000000e-02 + vertex -3.156562e-02 -2.456851e-02 8.000000e-02 + vertex -3.156562e-02 -2.456851e-02 1.000000e-01 + endloop + endfacet + facet normal 7.719167e-01 6.357237e-01 0.000000e+00 + outer loop + vertex -3.016426e-02 -2.627008e-02 8.000000e-02 + vertex -3.156562e-02 -2.456851e-02 1.000000e-01 + vertex -3.016426e-02 -2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal 7.357239e-01 6.772816e-01 -0.000000e+00 + outer loop + vertex -2.867130e-02 -2.789187e-02 8.000000e-02 + vertex -3.016426e-02 -2.627008e-02 8.000000e-02 + vertex -3.016426e-02 -2.627008e-02 1.000000e-01 + endloop + endfacet + facet normal 7.357239e-01 6.772816e-01 0.000000e+00 + outer loop + vertex -2.867130e-02 -2.789187e-02 8.000000e-02 + vertex -3.016426e-02 -2.627008e-02 1.000000e-01 + vertex -2.867130e-02 -2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal 6.972968e-01 7.167825e-01 -0.000000e+00 + outer loop + vertex -2.709126e-02 -2.942896e-02 8.000000e-02 + vertex -2.867130e-02 -2.789187e-02 8.000000e-02 + vertex -2.867130e-02 -2.789187e-02 1.000000e-01 + endloop + endfacet + facet normal 6.972968e-01 7.167825e-01 0.000000e+00 + outer loop + vertex -2.709126e-02 -2.942896e-02 8.000000e-02 + vertex -2.867130e-02 -2.789187e-02 1.000000e-01 + vertex -2.709126e-02 -2.942896e-02 1.000000e-01 + endloop + endfacet + facet normal 6.567520e-01 7.541066e-01 -0.000000e+00 + outer loop + vertex -2.542895e-02 -3.087667e-02 8.000000e-02 + vertex -2.709126e-02 -2.942896e-02 8.000000e-02 + vertex -2.709126e-02 -2.942896e-02 1.000000e-01 + endloop + endfacet + facet normal 6.567520e-01 7.541066e-01 0.000000e+00 + outer loop + vertex -2.542895e-02 -3.087667e-02 8.000000e-02 + vertex -2.709126e-02 -2.942896e-02 1.000000e-01 + vertex -2.542895e-02 -3.087667e-02 1.000000e-01 + endloop + endfacet + facet normal 6.142127e-01 7.891405e-01 -0.000000e+00 + outer loop + vertex -2.368941e-02 -3.223060e-02 8.000000e-02 + vertex -2.542895e-02 -3.087667e-02 8.000000e-02 + vertex -2.542895e-02 -3.087667e-02 1.000000e-01 + endloop + endfacet + facet normal 6.142127e-01 7.891405e-01 0.000000e+00 + outer loop + vertex -2.368941e-02 -3.223060e-02 8.000000e-02 + vertex -2.542895e-02 -3.087667e-02 1.000000e-01 + vertex -2.368941e-02 -3.223060e-02 1.000000e-01 + endloop + endfacet + facet normal 5.698081e-01 8.217778e-01 -0.000000e+00 + outer loop + vertex -2.187793e-02 -3.348666e-02 8.000000e-02 + vertex -2.368941e-02 -3.223060e-02 8.000000e-02 + vertex -2.368941e-02 -3.223060e-02 1.000000e-01 + endloop + endfacet + facet normal 5.698081e-01 8.217778e-01 0.000000e+00 + outer loop + vertex -2.187793e-02 -3.348666e-02 8.000000e-02 + vertex -2.368941e-02 -3.223060e-02 1.000000e-01 + vertex -2.187793e-02 -3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal 5.236729e-01 8.519194e-01 -0.000000e+00 + outer loop + vertex -2.000000e-02 -3.464102e-02 8.000000e-02 + vertex -2.187793e-02 -3.348666e-02 8.000000e-02 + vertex -2.187793e-02 -3.348666e-02 1.000000e-01 + endloop + endfacet + facet normal 5.236729e-01 8.519194e-01 0.000000e+00 + outer loop + vertex -2.000000e-02 -3.464102e-02 8.000000e-02 + vertex -2.187793e-02 -3.348666e-02 1.000000e-01 + vertex -2.000000e-02 -3.464102e-02 1.000000e-01 + endloop + endfacet + facet normal 4.759474e-01 8.794738e-01 -0.000000e+00 + outer loop + vertex -1.806133e-02 -3.569017e-02 8.000000e-02 + vertex -2.000000e-02 -3.464102e-02 8.000000e-02 + vertex -2.000000e-02 -3.464102e-02 1.000000e-01 + endloop + endfacet + facet normal 4.759474e-01 8.794738e-01 0.000000e+00 + outer loop + vertex -1.806133e-02 -3.569017e-02 8.000000e-02 + vertex -2.000000e-02 -3.464102e-02 1.000000e-01 + vertex -1.806133e-02 -3.569017e-02 1.000000e-01 + endloop + endfacet + facet normal 4.267764e-01 9.043572e-01 -0.000000e+00 + outer loop + vertex -1.606782e-02 -3.663093e-02 8.000000e-02 + vertex -1.806133e-02 -3.569017e-02 8.000000e-02 + vertex -1.806133e-02 -3.569017e-02 1.000000e-01 + endloop + endfacet + facet normal 4.267764e-01 9.043572e-01 0.000000e+00 + outer loop + vertex -1.606782e-02 -3.663093e-02 8.000000e-02 + vertex -1.806133e-02 -3.569017e-02 1.000000e-01 + vertex -1.606782e-02 -3.663093e-02 1.000000e-01 + endloop + endfacet + facet normal 3.763094e-01 9.264941e-01 -0.000000e+00 + outer loop + vertex -1.402550e-02 -3.746045e-02 8.000000e-02 + vertex -1.606782e-02 -3.663093e-02 8.000000e-02 + vertex -1.606782e-02 -3.663093e-02 1.000000e-01 + endloop + endfacet + facet normal 3.763094e-01 9.264941e-01 0.000000e+00 + outer loop + vertex -1.402550e-02 -3.746045e-02 8.000000e-02 + vertex -1.606782e-02 -3.663093e-02 1.000000e-01 + vertex -1.402550e-02 -3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal 3.246995e-01 9.458172e-01 -0.000000e+00 + outer loop + vertex -1.194059e-02 -3.817620e-02 8.000000e-02 + vertex -1.402550e-02 -3.746045e-02 8.000000e-02 + vertex -1.402550e-02 -3.746045e-02 1.000000e-01 + endloop + endfacet + facet normal 3.246995e-01 9.458172e-01 0.000000e+00 + outer loop + vertex -1.194059e-02 -3.817620e-02 8.000000e-02 + vertex -1.402550e-02 -3.746045e-02 1.000000e-01 + vertex -1.194059e-02 -3.817620e-02 1.000000e-01 + endloop + endfacet + facet normal 2.721035e-01 9.622680e-01 -0.000000e+00 + outer loop + vertex -9.819419e-03 -3.877601e-02 8.000000e-02 + vertex -1.194059e-02 -3.817620e-02 8.000000e-02 + vertex -1.194059e-02 -3.817620e-02 1.000000e-01 + endloop + endfacet + facet normal 2.721035e-01 9.622680e-01 0.000000e+00 + outer loop + vertex -9.819419e-03 -3.877601e-02 8.000000e-02 + vertex -1.194059e-02 -3.817620e-02 1.000000e-01 + vertex -9.819419e-03 -3.877601e-02 1.000000e-01 + endloop + endfacet + facet normal 2.186811e-01 9.757964e-01 -0.000000e+00 + outer loop + vertex -7.668425e-03 -3.925806e-02 8.000000e-02 + vertex -9.819419e-03 -3.877601e-02 8.000000e-02 + vertex -9.819419e-03 -3.877601e-02 1.000000e-01 + endloop + endfacet + facet normal 2.186811e-01 9.757964e-01 0.000000e+00 + outer loop + vertex -7.668425e-03 -3.925806e-02 8.000000e-02 + vertex -9.819419e-03 -3.877601e-02 1.000000e-01 + vertex -7.668425e-03 -3.925806e-02 1.000000e-01 + endloop + endfacet + facet normal 1.645946e-01 9.863613e-01 -0.000000e+00 + outer loop + vertex -5.494142e-03 -3.962088e-02 8.000000e-02 + vertex -7.668425e-03 -3.925806e-02 8.000000e-02 + vertex -7.668425e-03 -3.925806e-02 1.000000e-01 + endloop + endfacet + facet normal 1.645946e-01 9.863613e-01 0.000000e+00 + outer loop + vertex -5.494142e-03 -3.962088e-02 8.000000e-02 + vertex -7.668425e-03 -3.925806e-02 1.000000e-01 + vertex -5.494142e-03 -3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal 1.100082e-01 9.939307e-01 -0.000000e+00 + outer loop + vertex -3.303174e-03 -3.986338e-02 8.000000e-02 + vertex -5.494142e-03 -3.962088e-02 8.000000e-02 + vertex -5.494142e-03 -3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal 1.100082e-01 9.939307e-01 0.000000e+00 + outer loop + vertex -3.303174e-03 -3.986338e-02 8.000000e-02 + vertex -5.494142e-03 -3.962088e-02 1.000000e-01 + vertex -3.303174e-03 -3.986338e-02 1.000000e-01 + endloop + endfacet + facet normal 5.508776e-02 9.984815e-01 -0.000000e+00 + outer loop + vertex -1.102174e-03 -3.998481e-02 8.000000e-02 + vertex -3.303174e-03 -3.986338e-02 8.000000e-02 + vertex -3.303174e-03 -3.986338e-02 1.000000e-01 + endloop + endfacet + facet normal 5.508776e-02 9.984815e-01 0.000000e+00 + outer loop + vertex -1.102174e-03 -3.998481e-02 8.000000e-02 + vertex -3.303174e-03 -3.986338e-02 1.000000e-01 + vertex -1.102174e-03 -3.998481e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 1.000000e+00 -0.000000e+00 + outer loop + vertex 1.102174e-03 -3.998481e-02 8.000000e-02 + vertex -1.102174e-03 -3.998481e-02 8.000000e-02 + vertex -1.102174e-03 -3.998481e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 1.000000e+00 -0.000000e+00 + outer loop + vertex 1.102174e-03 -3.998481e-02 8.000000e-02 + vertex -1.102174e-03 -3.998481e-02 1.000000e-01 + vertex 1.102174e-03 -3.998481e-02 1.000000e-01 + endloop + endfacet + facet normal -5.508776e-02 9.984815e-01 0.000000e+00 + outer loop + vertex 3.303174e-03 -3.986338e-02 8.000000e-02 + vertex 1.102174e-03 -3.998481e-02 8.000000e-02 + vertex 1.102174e-03 -3.998481e-02 1.000000e-01 + endloop + endfacet + facet normal -5.508776e-02 9.984815e-01 0.000000e+00 + outer loop + vertex 3.303174e-03 -3.986338e-02 8.000000e-02 + vertex 1.102174e-03 -3.998481e-02 1.000000e-01 + vertex 3.303174e-03 -3.986338e-02 1.000000e-01 + endloop + endfacet + facet normal -1.100082e-01 9.939307e-01 0.000000e+00 + outer loop + vertex 5.494142e-03 -3.962088e-02 8.000000e-02 + vertex 3.303174e-03 -3.986338e-02 8.000000e-02 + vertex 3.303174e-03 -3.986338e-02 1.000000e-01 + endloop + endfacet + facet normal -1.100082e-01 9.939307e-01 0.000000e+00 + outer loop + vertex 5.494142e-03 -3.962088e-02 8.000000e-02 + vertex 3.303174e-03 -3.986338e-02 1.000000e-01 + vertex 5.494142e-03 -3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal -1.645946e-01 9.863613e-01 0.000000e+00 + outer loop + vertex 7.668425e-03 -3.925806e-02 8.000000e-02 + vertex 5.494142e-03 -3.962088e-02 8.000000e-02 + vertex 5.494142e-03 -3.962088e-02 1.000000e-01 + endloop + endfacet + facet normal -1.645946e-01 9.863613e-01 0.000000e+00 + outer loop + vertex 7.668425e-03 -3.925806e-02 8.000000e-02 + vertex 5.494142e-03 -3.962088e-02 1.000000e-01 + vertex 7.668425e-03 -3.925806e-02 1.000000e-01 + endloop + endfacet + facet normal -2.186811e-01 9.757964e-01 0.000000e+00 + outer loop + vertex 9.819419e-03 -3.877601e-02 8.000000e-02 + vertex 7.668425e-03 -3.925806e-02 8.000000e-02 + vertex 7.668425e-03 -3.925806e-02 1.000000e-01 + endloop + endfacet + facet normal -2.186811e-01 9.757964e-01 0.000000e+00 + outer loop + vertex 9.819419e-03 -3.877601e-02 8.000000e-02 + vertex 7.668425e-03 -3.925806e-02 1.000000e-01 + vertex 9.819419e-03 -3.877601e-02 1.000000e-01 + endloop + endfacet + facet normal -2.721035e-01 9.622680e-01 0.000000e+00 + outer loop + vertex 1.194059e-02 -3.817620e-02 8.000000e-02 + vertex 9.819419e-03 -3.877601e-02 1.000000e-01 + vertex 1.194059e-02 -3.817620e-02 1.000000e-01 + endloop + endfacet + facet normal -2.721035e-01 9.622680e-01 0.000000e+00 + outer loop + vertex 1.194059e-02 -3.817620e-02 8.000000e-02 + vertex 9.819419e-03 -3.877601e-02 8.000000e-02 + vertex 9.819419e-03 -3.877601e-02 1.000000e-01 + endloop + endfacet +endsolid diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r4.stl b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r4.stl new file mode 100644 index 00000000..75244f89 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r4.stl @@ -0,0 +1,7282 @@ +solid + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.608452e-02 2.472136e-02 8.000000e-02 + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + vertex -7.711703e-02 2.128295e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.601483e-02 2.150208e-02 8.000000e-02 + vertex 7.489879e-02 2.810999e-02 8.000000e-02 + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.601483e-02 2.150208e-02 8.000000e-02 + vertex 7.356222e-02 3.144200e-02 8.000000e-02 + vertex 7.489879e-02 2.810999e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.472136e-02 7.608452e-02 8.000000e-02 + vertex -2.128295e-02 7.711703e-02 8.000000e-02 + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.440420e-02 -5.481273e-02 8.000000e-02 + vertex -2.150208e-02 -5.601483e-02 8.000000e-02 + vertex -3.144200e-02 -7.356222e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.440420e-02 -5.481273e-02 8.000000e-02 + vertex -3.144200e-02 -7.356222e-02 8.000000e-02 + vertex -3.471070e-02 -7.207751e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.489879e-02 2.810999e-02 8.000000e-02 + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + vertex -7.608452e-02 2.472136e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.481273e-02 2.440420e-02 8.000000e-02 + vertex 7.356222e-02 3.144200e-02 8.000000e-02 + vertex 5.601483e-02 2.150208e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.481273e-02 2.440420e-02 8.000000e-02 + vertex 7.207751e-02 3.471070e-02 8.000000e-02 + vertex 7.356222e-02 3.144200e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.489879e-02 2.810999e-02 8.000000e-02 + vertex -5.601483e-02 2.150208e-02 8.000000e-02 + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.810999e-02 7.489879e-02 8.000000e-02 + vertex -2.472136e-02 7.608452e-02 8.000000e-02 + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.810999e-02 7.489879e-02 8.000000e-02 + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + vertex -2.150208e-02 5.601483e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.723943e-02 -5.346039e-02 8.000000e-02 + vertex -3.471070e-02 -7.207751e-02 8.000000e-02 + vertex -3.790949e-02 -7.044764e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.723943e-02 -5.346039e-02 8.000000e-02 + vertex -2.440420e-02 -5.481273e-02 8.000000e-02 + vertex -3.471070e-02 -7.207751e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.346039e-02 2.723943e-02 8.000000e-02 + vertex 7.044764e-02 3.790949e-02 8.000000e-02 + vertex 7.207751e-02 3.471070e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.144200e-02 7.356222e-02 8.000000e-02 + vertex -2.810999e-02 7.489879e-02 8.000000e-02 + vertex -2.150208e-02 5.601483e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.144200e-02 7.356222e-02 8.000000e-02 + vertex -2.150208e-02 5.601483e-02 8.000000e-02 + vertex -2.440420e-02 5.481273e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.346039e-02 2.723943e-02 8.000000e-02 + vertex 7.207751e-02 3.471070e-02 8.000000e-02 + vertex 5.481273e-02 2.440420e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.356222e-02 3.144200e-02 8.000000e-02 + vertex -5.601483e-02 2.150208e-02 8.000000e-02 + vertex -7.489879e-02 2.810999e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.000000e-02 -5.196152e-02 8.000000e-02 + vertex -3.790949e-02 -7.044764e-02 8.000000e-02 + vertex -4.103194e-02 -6.867590e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.000000e-02 -5.196152e-02 8.000000e-02 + vertex -2.723943e-02 -5.346039e-02 8.000000e-02 + vertex -3.790949e-02 -7.044764e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.356222e-02 3.144200e-02 8.000000e-02 + vertex -5.481273e-02 2.440420e-02 8.000000e-02 + vertex -5.601483e-02 2.150208e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.196152e-02 3.000000e-02 8.000000e-02 + vertex 6.867590e-02 4.103194e-02 8.000000e-02 + vertex 7.044764e-02 3.790949e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.207751e-02 3.471070e-02 8.000000e-02 + vertex -5.481273e-02 2.440420e-02 8.000000e-02 + vertex -7.356222e-02 3.144200e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.196152e-02 3.000000e-02 8.000000e-02 + vertex 7.044764e-02 3.790949e-02 8.000000e-02 + vertex 5.346039e-02 2.723943e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.207751e-02 3.471070e-02 8.000000e-02 + vertex -5.346039e-02 2.723943e-02 8.000000e-02 + vertex -5.481273e-02 2.440420e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.471070e-02 7.207751e-02 8.000000e-02 + vertex -3.144200e-02 7.356222e-02 8.000000e-02 + vertex -2.440420e-02 5.481273e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.471070e-02 7.207751e-02 8.000000e-02 + vertex -2.440420e-02 5.481273e-02 8.000000e-02 + vertex -2.723943e-02 5.346039e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.267834e-02 -5.032023e-02 8.000000e-02 + vertex -4.103194e-02 -6.867590e-02 8.000000e-02 + vertex -4.407176e-02 -6.676586e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.267834e-02 -5.032023e-02 8.000000e-02 + vertex -3.000000e-02 -5.196152e-02 8.000000e-02 + vertex -4.103194e-02 -6.867590e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.032023e-02 3.267834e-02 8.000000e-02 + vertex 6.676586e-02 4.407176e-02 8.000000e-02 + vertex 6.867590e-02 4.103194e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.032023e-02 3.267834e-02 8.000000e-02 + vertex 6.867590e-02 4.103194e-02 8.000000e-02 + vertex 5.196152e-02 3.000000e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.044764e-02 3.790949e-02 8.000000e-02 + vertex -5.346039e-02 2.723943e-02 8.000000e-02 + vertex -7.207751e-02 3.471070e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + vertex -4.407176e-02 -6.676586e-02 8.000000e-02 + vertex -4.702282e-02 -6.472136e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.044764e-02 3.790949e-02 8.000000e-02 + vertex -5.196152e-02 3.000000e-02 8.000000e-02 + vertex -5.346039e-02 2.723943e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.790949e-02 7.044764e-02 8.000000e-02 + vertex -2.723943e-02 5.346039e-02 8.000000e-02 + vertex -3.000000e-02 5.196152e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + vertex -3.267834e-02 -5.032023e-02 8.000000e-02 + vertex -4.407176e-02 -6.676586e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + vertex 6.472136e-02 4.702282e-02 8.000000e-02 + vertex 6.676586e-02 4.407176e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.790949e-02 7.044764e-02 8.000000e-02 + vertex -3.471070e-02 7.207751e-02 8.000000e-02 + vertex -2.723943e-02 5.346039e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.103194e-02 6.867590e-02 8.000000e-02 + vertex -3.000000e-02 5.196152e-02 8.000000e-02 + vertex -3.267834e-02 5.032023e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + vertex 6.676586e-02 4.407176e-02 8.000000e-02 + vertex 5.032023e-02 3.267834e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.254652e-02 4.987918e-02 8.000000e-02 + vertex 6.472136e-02 4.702282e-02 8.000000e-02 + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.103194e-02 6.867590e-02 8.000000e-02 + vertex -3.790949e-02 7.044764e-02 8.000000e-02 + vertex -3.000000e-02 5.196152e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.987918e-02 -6.254652e-02 8.000000e-02 + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + vertex -4.702282e-02 -6.472136e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.775922e-02 -4.662876e-02 8.000000e-02 + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + vertex -4.987918e-02 -6.254652e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.867590e-02 4.103194e-02 8.000000e-02 + vertex -5.196152e-02 3.000000e-02 8.000000e-02 + vertex -7.044764e-02 3.790949e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.867590e-02 4.103194e-02 8.000000e-02 + vertex -5.032023e-02 3.267834e-02 8.000000e-02 + vertex -5.196152e-02 3.000000e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.676586e-02 4.407176e-02 8.000000e-02 + vertex -5.032023e-02 3.267834e-02 8.000000e-02 + vertex -6.867590e-02 4.103194e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.662876e-02 3.775922e-02 8.000000e-02 + vertex 6.254652e-02 4.987918e-02 8.000000e-02 + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.676586e-02 4.407176e-02 8.000000e-02 + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + vertex -5.032023e-02 3.267834e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.407176e-02 6.676586e-02 8.000000e-02 + vertex -3.267834e-02 5.032023e-02 8.000000e-02 + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.263510e-02 -6.024572e-02 8.000000e-02 + vertex -3.775922e-02 -4.662876e-02 8.000000e-02 + vertex -4.987918e-02 -6.254652e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.407176e-02 6.676586e-02 8.000000e-02 + vertex -4.103194e-02 6.867590e-02 8.000000e-02 + vertex -3.267834e-02 5.032023e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.024572e-02 5.263510e-02 8.000000e-02 + vertex 6.254652e-02 4.987918e-02 8.000000e-02 + vertex 4.662876e-02 3.775922e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.014784e-02 -4.458869e-02 8.000000e-02 + vertex -3.775922e-02 -4.662876e-02 8.000000e-02 + vertex -5.263510e-02 -6.024572e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.702282e-02 6.472136e-02 8.000000e-02 + vertex -4.407176e-02 6.676586e-02 8.000000e-02 + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.458869e-02 4.014784e-02 8.000000e-02 + vertex 6.024572e-02 5.263510e-02 8.000000e-02 + vertex 4.662876e-02 3.775922e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.472136e-02 4.702282e-02 8.000000e-02 + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + vertex -6.676586e-02 4.407176e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.254652e-02 4.987918e-02 8.000000e-02 + vertex -4.662876e-02 3.775922e-02 8.000000e-02 + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.254652e-02 4.987918e-02 8.000000e-02 + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + vertex -6.472136e-02 4.702282e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.528501e-02 -5.782359e-02 8.000000e-02 + vertex -4.014784e-02 -4.458869e-02 8.000000e-02 + vertex -5.263510e-02 -6.024572e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.987918e-02 6.254652e-02 8.000000e-02 + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + vertex -3.775922e-02 4.662876e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.782359e-02 5.528501e-02 8.000000e-02 + vertex 6.024572e-02 5.263510e-02 8.000000e-02 + vertex 4.458869e-02 4.014784e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.987918e-02 6.254652e-02 8.000000e-02 + vertex -4.702282e-02 6.472136e-02 8.000000e-02 + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.242641e-02 -4.242641e-02 8.000000e-02 + vertex -4.014784e-02 -4.458869e-02 8.000000e-02 + vertex -5.528501e-02 -5.782359e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.024572e-02 5.263510e-02 8.000000e-02 + vertex -4.662876e-02 3.775922e-02 8.000000e-02 + vertex -6.254652e-02 4.987918e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.024572e-02 5.263510e-02 8.000000e-02 + vertex -4.458869e-02 4.014784e-02 8.000000e-02 + vertex -4.662876e-02 3.775922e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.263510e-02 6.024572e-02 8.000000e-02 + vertex -4.987918e-02 6.254652e-02 8.000000e-02 + vertex -3.775922e-02 4.662876e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.263510e-02 6.024572e-02 8.000000e-02 + vertex -3.775922e-02 4.662876e-02 8.000000e-02 + vertex -4.014784e-02 4.458869e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.242641e-02 4.242641e-02 8.000000e-02 + vertex 5.782359e-02 5.528501e-02 8.000000e-02 + vertex 4.458869e-02 4.014784e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.782359e-02 5.528501e-02 8.000000e-02 + vertex -4.458869e-02 4.014784e-02 8.000000e-02 + vertex -6.024572e-02 5.263510e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.782359e-02 5.528501e-02 8.000000e-02 + vertex -4.242641e-02 4.242641e-02 8.000000e-02 + vertex -4.458869e-02 4.014784e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.528501e-02 5.782359e-02 8.000000e-02 + vertex 5.782359e-02 5.528501e-02 8.000000e-02 + vertex 4.242641e-02 4.242641e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.528501e-02 5.782359e-02 8.000000e-02 + vertex -4.242641e-02 4.242641e-02 8.000000e-02 + vertex -5.782359e-02 5.528501e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.782359e-02 -5.528501e-02 8.000000e-02 + vertex -4.242641e-02 -4.242641e-02 8.000000e-02 + vertex -5.528501e-02 -5.782359e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.528501e-02 5.782359e-02 8.000000e-02 + vertex -4.014784e-02 4.458869e-02 8.000000e-02 + vertex -4.242641e-02 4.242641e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.528501e-02 5.782359e-02 8.000000e-02 + vertex -5.263510e-02 6.024572e-02 8.000000e-02 + vertex -4.014784e-02 4.458869e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.458869e-02 -4.014784e-02 8.000000e-02 + vertex -4.242641e-02 -4.242641e-02 8.000000e-02 + vertex -5.782359e-02 -5.528501e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.014784e-02 4.458869e-02 8.000000e-02 + vertex 5.528501e-02 5.782359e-02 8.000000e-02 + vertex 4.242641e-02 4.242641e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.263510e-02 6.024572e-02 8.000000e-02 + vertex 5.528501e-02 5.782359e-02 8.000000e-02 + vertex 4.014784e-02 4.458869e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.024572e-02 -5.263510e-02 8.000000e-02 + vertex -4.458869e-02 -4.014784e-02 8.000000e-02 + vertex -5.782359e-02 -5.528501e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.662876e-02 -3.775922e-02 8.000000e-02 + vertex -4.458869e-02 -4.014784e-02 8.000000e-02 + vertex -6.024572e-02 -5.263510e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.775922e-02 4.662876e-02 8.000000e-02 + vertex 5.263510e-02 6.024572e-02 8.000000e-02 + vertex 4.014784e-02 4.458869e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.242641e-02 -4.242641e-02 8.000000e-02 + vertex 5.782359e-02 -5.528501e-02 8.000000e-02 + vertex 5.528501e-02 -5.782359e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.987918e-02 6.254652e-02 8.000000e-02 + vertex 5.263510e-02 6.024572e-02 8.000000e-02 + vertex 3.775922e-02 4.662876e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.254652e-02 -4.987918e-02 8.000000e-02 + vertex -4.662876e-02 -3.775922e-02 8.000000e-02 + vertex -6.024572e-02 -5.263510e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + vertex -4.662876e-02 -3.775922e-02 8.000000e-02 + vertex -6.254652e-02 -4.987918e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.458869e-02 -4.014784e-02 8.000000e-02 + vertex 6.024572e-02 -5.263510e-02 8.000000e-02 + vertex 5.782359e-02 -5.528501e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + vertex 4.987918e-02 6.254652e-02 8.000000e-02 + vertex 3.775922e-02 4.662876e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.458869e-02 -4.014784e-02 8.000000e-02 + vertex 5.782359e-02 -5.528501e-02 8.000000e-02 + vertex 4.242641e-02 -4.242641e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.702282e-02 6.472136e-02 8.000000e-02 + vertex 4.987918e-02 6.254652e-02 8.000000e-02 + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.472136e-02 -4.702282e-02 8.000000e-02 + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + vertex -6.254652e-02 -4.987918e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.014784e-02 -4.458869e-02 8.000000e-02 + vertex 5.528501e-02 -5.782359e-02 8.000000e-02 + vertex 5.263510e-02 -6.024572e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.014784e-02 -4.458869e-02 8.000000e-02 + vertex 4.242641e-02 -4.242641e-02 8.000000e-02 + vertex 5.528501e-02 -5.782359e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.662876e-02 -3.775922e-02 8.000000e-02 + vertex 6.024572e-02 -5.263510e-02 8.000000e-02 + vertex 4.458869e-02 -4.014784e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.662876e-02 -3.775922e-02 8.000000e-02 + vertex 6.254652e-02 -4.987918e-02 8.000000e-02 + vertex 6.024572e-02 -5.263510e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.676586e-02 -4.407176e-02 8.000000e-02 + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + vertex -6.472136e-02 -4.702282e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -6.676586e-02 -4.407176e-02 8.000000e-02 + vertex -5.032023e-02 -3.267834e-02 8.000000e-02 + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.407176e-02 6.676586e-02 8.000000e-02 + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + vertex 3.267834e-02 5.032023e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.407176e-02 6.676586e-02 8.000000e-02 + vertex 4.702282e-02 6.472136e-02 8.000000e-02 + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.775922e-02 -4.662876e-02 8.000000e-02 + vertex 4.014784e-02 -4.458869e-02 8.000000e-02 + vertex 5.263510e-02 -6.024572e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.867590e-02 -4.103194e-02 8.000000e-02 + vertex -5.032023e-02 -3.267834e-02 8.000000e-02 + vertex -6.676586e-02 -4.407176e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -6.867590e-02 -4.103194e-02 8.000000e-02 + vertex -5.196152e-02 -3.000000e-02 8.000000e-02 + vertex -5.032023e-02 -3.267834e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.103194e-02 6.867590e-02 8.000000e-02 + vertex 3.267834e-02 5.032023e-02 8.000000e-02 + vertex 3.000000e-02 5.196152e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.775922e-02 -4.662876e-02 8.000000e-02 + vertex 5.263510e-02 -6.024572e-02 8.000000e-02 + vertex 4.987918e-02 -6.254652e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.103194e-02 6.867590e-02 8.000000e-02 + vertex 4.407176e-02 6.676586e-02 8.000000e-02 + vertex 3.267834e-02 5.032023e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + vertex 6.472136e-02 -4.702282e-02 8.000000e-02 + vertex 6.254652e-02 -4.987918e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + vertex 6.676586e-02 -4.407176e-02 8.000000e-02 + vertex 6.472136e-02 -4.702282e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.790949e-02 7.044764e-02 8.000000e-02 + vertex 3.000000e-02 5.196152e-02 8.000000e-02 + vertex 2.723943e-02 5.346039e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + vertex 6.254652e-02 -4.987918e-02 8.000000e-02 + vertex 4.662876e-02 -3.775922e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.790949e-02 7.044764e-02 8.000000e-02 + vertex 4.103194e-02 6.867590e-02 8.000000e-02 + vertex 3.000000e-02 5.196152e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.044764e-02 -3.790949e-02 8.000000e-02 + vertex -5.196152e-02 -3.000000e-02 8.000000e-02 + vertex -6.867590e-02 -4.103194e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.044764e-02 -3.790949e-02 8.000000e-02 + vertex -5.346039e-02 -2.723943e-02 8.000000e-02 + vertex -5.196152e-02 -3.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + vertex 3.775922e-02 -4.662876e-02 8.000000e-02 + vertex 4.987918e-02 -6.254652e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + vertex 4.702282e-02 -6.472136e-02 8.000000e-02 + vertex 4.407176e-02 -6.676586e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + vertex 4.987918e-02 -6.254652e-02 8.000000e-02 + vertex 4.702282e-02 -6.472136e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.207751e-02 -3.471070e-02 8.000000e-02 + vertex -5.481273e-02 -2.440420e-02 8.000000e-02 + vertex -5.346039e-02 -2.723943e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.207751e-02 -3.471070e-02 8.000000e-02 + vertex -5.346039e-02 -2.723943e-02 8.000000e-02 + vertex -7.044764e-02 -3.790949e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.471070e-02 7.207751e-02 8.000000e-02 + vertex 2.723943e-02 5.346039e-02 8.000000e-02 + vertex 2.440420e-02 5.481273e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.471070e-02 7.207751e-02 8.000000e-02 + vertex 3.790949e-02 7.044764e-02 8.000000e-02 + vertex 2.723943e-02 5.346039e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.032023e-02 -3.267834e-02 8.000000e-02 + vertex 6.867590e-02 -4.103194e-02 8.000000e-02 + vertex 6.676586e-02 -4.407176e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.032023e-02 -3.267834e-02 8.000000e-02 + vertex 6.676586e-02 -4.407176e-02 8.000000e-02 + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.144200e-02 7.356222e-02 8.000000e-02 + vertex 2.440420e-02 5.481273e-02 8.000000e-02 + vertex 2.150208e-02 5.601483e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.144200e-02 7.356222e-02 8.000000e-02 + vertex 3.471070e-02 7.207751e-02 8.000000e-02 + vertex 2.440420e-02 5.481273e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.356222e-02 -3.144200e-02 8.000000e-02 + vertex -5.601483e-02 -2.150208e-02 8.000000e-02 + vertex -5.481273e-02 -2.440420e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.356222e-02 -3.144200e-02 8.000000e-02 + vertex -5.481273e-02 -2.440420e-02 8.000000e-02 + vertex -7.207751e-02 -3.471070e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.267834e-02 -5.032023e-02 8.000000e-02 + vertex 4.407176e-02 -6.676586e-02 8.000000e-02 + vertex 4.103194e-02 -6.867590e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.267834e-02 -5.032023e-02 8.000000e-02 + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + vertex 4.407176e-02 -6.676586e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.196152e-02 -3.000000e-02 8.000000e-02 + vertex 6.867590e-02 -4.103194e-02 8.000000e-02 + vertex 5.032023e-02 -3.267834e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.196152e-02 -3.000000e-02 8.000000e-02 + vertex 7.044764e-02 -3.790949e-02 8.000000e-02 + vertex 6.867590e-02 -4.103194e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.810999e-02 7.489879e-02 8.000000e-02 + vertex 2.150208e-02 5.601483e-02 8.000000e-02 + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.810999e-02 7.489879e-02 8.000000e-02 + vertex 3.144200e-02 7.356222e-02 8.000000e-02 + vertex 2.150208e-02 5.601483e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.489879e-02 -2.810999e-02 8.000000e-02 + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + vertex -5.601483e-02 -2.150208e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.489879e-02 -2.810999e-02 8.000000e-02 + vertex -5.601483e-02 -2.150208e-02 8.000000e-02 + vertex -7.356222e-02 -3.144200e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.000000e-02 -5.196152e-02 8.000000e-02 + vertex 4.103194e-02 -6.867590e-02 8.000000e-02 + vertex 3.790949e-02 -7.044764e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.000000e-02 -5.196152e-02 8.000000e-02 + vertex 3.267834e-02 -5.032023e-02 8.000000e-02 + vertex 4.103194e-02 -6.867590e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.346039e-02 -2.723943e-02 8.000000e-02 + vertex 7.207751e-02 -3.471070e-02 8.000000e-02 + vertex 7.044764e-02 -3.790949e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.472136e-02 7.608452e-02 8.000000e-02 + vertex 2.810999e-02 7.489879e-02 8.000000e-02 + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.608452e-02 -2.472136e-02 8.000000e-02 + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + vertex -7.489879e-02 -2.810999e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.346039e-02 -2.723943e-02 8.000000e-02 + vertex 7.044764e-02 -3.790949e-02 8.000000e-02 + vertex 5.196152e-02 -3.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.723943e-02 -5.346039e-02 8.000000e-02 + vertex 3.790949e-02 -7.044764e-02 8.000000e-02 + vertex 3.471070e-02 -7.207751e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.723943e-02 -5.346039e-02 8.000000e-02 + vertex 3.000000e-02 -5.196152e-02 8.000000e-02 + vertex 3.790949e-02 -7.044764e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.711703e-02 -2.128295e-02 8.000000e-02 + vertex -5.795555e-02 -1.552914e-02 8.000000e-02 + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.711703e-02 -2.128295e-02 8.000000e-02 + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + vertex -7.608452e-02 -2.472136e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.128295e-02 7.711703e-02 8.000000e-02 + vertex 2.472136e-02 7.608452e-02 8.000000e-02 + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.481273e-02 -2.440420e-02 8.000000e-02 + vertex 7.207751e-02 -3.471070e-02 8.000000e-02 + vertex 5.346039e-02 -2.723943e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.128295e-02 7.711703e-02 8.000000e-02 + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + vertex 1.552914e-02 5.795555e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.481273e-02 -2.440420e-02 8.000000e-02 + vertex 7.356222e-02 -3.144200e-02 8.000000e-02 + vertex 7.207751e-02 -3.471070e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.440420e-02 -5.481273e-02 8.000000e-02 + vertex 2.723943e-02 -5.346039e-02 8.000000e-02 + vertex 3.471070e-02 -7.207751e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.440420e-02 -5.481273e-02 8.000000e-02 + vertex 3.471070e-02 -7.207751e-02 8.000000e-02 + vertex 3.144200e-02 -7.356222e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.799423e-02 -1.780167e-02 8.000000e-02 + vertex -5.795555e-02 -1.552914e-02 8.000000e-02 + vertex -7.711703e-02 -2.128295e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.601483e-02 -2.150208e-02 8.000000e-02 + vertex 7.356222e-02 -3.144200e-02 8.000000e-02 + vertex 5.481273e-02 -2.440420e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.601483e-02 -2.150208e-02 8.000000e-02 + vertex 7.489879e-02 -2.810999e-02 8.000000e-02 + vertex 7.356222e-02 -3.144200e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.799423e-02 -1.780167e-02 8.000000e-02 + vertex -5.868886e-02 -1.247470e-02 8.000000e-02 + vertex -5.795555e-02 -1.552914e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.780167e-02 7.799423e-02 8.000000e-02 + vertex 1.552914e-02 5.795555e-02 8.000000e-02 + vertex 1.247470e-02 5.868886e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.780167e-02 7.799423e-02 8.000000e-02 + vertex 2.128295e-02 7.711703e-02 8.000000e-02 + vertex 1.552914e-02 5.795555e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.150208e-02 -5.601483e-02 8.000000e-02 + vertex 3.144200e-02 -7.356222e-02 8.000000e-02 + vertex 2.810999e-02 -7.489879e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.150208e-02 -5.601483e-02 8.000000e-02 + vertex 2.440420e-02 -5.481273e-02 8.000000e-02 + vertex 3.144200e-02 -7.356222e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.871437e-02 -1.428455e-02 8.000000e-02 + vertex -5.868886e-02 -1.247470e-02 8.000000e-02 + vertex -7.799423e-02 -1.780167e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.871437e-02 -1.428455e-02 8.000000e-02 + vertex -5.926130e-02 -9.386068e-03 8.000000e-02 + vertex -5.868886e-02 -1.247470e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + vertex 7.608452e-02 -2.472136e-02 8.000000e-02 + vertex 7.489879e-02 -2.810999e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + vertex 7.711703e-02 -2.128295e-02 8.000000e-02 + vertex 7.608452e-02 -2.472136e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.428455e-02 7.871437e-02 8.000000e-02 + vertex 1.780167e-02 7.799423e-02 8.000000e-02 + vertex 1.247470e-02 5.868886e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.428455e-02 7.871437e-02 8.000000e-02 + vertex 1.247470e-02 5.868886e-02 8.000000e-02 + vertex 9.386068e-03 5.926130e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + vertex 7.489879e-02 -2.810999e-02 8.000000e-02 + vertex 5.601483e-02 -2.150208e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + vertex 2.150208e-02 -5.601483e-02 8.000000e-02 + vertex 2.810999e-02 -7.489879e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + vertex 2.472136e-02 -7.608452e-02 8.000000e-02 + vertex 2.128295e-02 -7.711703e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.073866e-02 7.927598e-02 8.000000e-02 + vertex 9.386068e-03 5.926130e-02 8.000000e-02 + vertex 6.271708e-03 5.967131e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + vertex 2.810999e-02 -7.489879e-02 8.000000e-02 + vertex 2.472136e-02 -7.608452e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.073866e-02 7.927598e-02 8.000000e-02 + vertex 1.428455e-02 7.871437e-02 8.000000e-02 + vertex 9.386068e-03 5.926130e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.927598e-02 -1.073866e-02 8.000000e-02 + vertex -5.926130e-02 -9.386068e-03 8.000000e-02 + vertex -7.871437e-02 -1.428455e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.795555e-02 -1.552914e-02 8.000000e-02 + vertex 7.799423e-02 -1.780167e-02 8.000000e-02 + vertex 7.711703e-02 -2.128295e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.927598e-02 -1.073866e-02 8.000000e-02 + vertex -5.967131e-02 -6.271708e-03 8.000000e-02 + vertex -5.926130e-02 -9.386068e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.795555e-02 -1.552914e-02 8.000000e-02 + vertex 7.711703e-02 -2.128295e-02 8.000000e-02 + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.552914e-02 -5.795555e-02 8.000000e-02 + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + vertex 2.128295e-02 -7.711703e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.552914e-02 -5.795555e-02 8.000000e-02 + vertex 2.128295e-02 -7.711703e-02 8.000000e-02 + vertex 1.780167e-02 -7.799423e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.171145e-03 7.967794e-02 8.000000e-02 + vertex 6.271708e-03 5.967131e-02 8.000000e-02 + vertex 3.140157e-03 5.991777e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.171145e-03 7.967794e-02 8.000000e-02 + vertex 1.073866e-02 7.927598e-02 8.000000e-02 + vertex 6.271708e-03 5.967131e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.868886e-02 -1.247470e-02 8.000000e-02 + vertex 7.871437e-02 -1.428455e-02 8.000000e-02 + vertex 7.799423e-02 -1.780167e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.967794e-02 -7.171145e-03 8.000000e-02 + vertex -5.967131e-02 -6.271708e-03 8.000000e-02 + vertex -7.927598e-02 -1.073866e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.967794e-02 -7.171145e-03 8.000000e-02 + vertex -5.991777e-02 -3.140157e-03 8.000000e-02 + vertex -5.967131e-02 -6.271708e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.868886e-02 -1.247470e-02 8.000000e-02 + vertex 7.799423e-02 -1.780167e-02 8.000000e-02 + vertex 5.795555e-02 -1.552914e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.247470e-02 -5.868886e-02 8.000000e-02 + vertex 1.552914e-02 -5.795555e-02 8.000000e-02 + vertex 1.780167e-02 -7.799423e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.247470e-02 -5.868886e-02 8.000000e-02 + vertex 1.780167e-02 -7.799423e-02 8.000000e-02 + vertex 1.428455e-02 -7.871437e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.926130e-02 -9.386068e-03 8.000000e-02 + vertex 7.927598e-02 -1.073866e-02 8.000000e-02 + vertex 7.871437e-02 -1.428455e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.926130e-02 -9.386068e-03 8.000000e-02 + vertex 7.871437e-02 -1.428455e-02 8.000000e-02 + vertex 5.868886e-02 -1.247470e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.589186e-03 7.991945e-02 8.000000e-02 + vertex 3.140157e-03 5.991777e-02 8.000000e-02 + vertex 1.699662e-17 6.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.589186e-03 7.991945e-02 8.000000e-02 + vertex 7.171145e-03 7.967794e-02 8.000000e-02 + vertex 3.140157e-03 5.991777e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 9.386068e-03 -5.926130e-02 8.000000e-02 + vertex 1.428455e-02 -7.871437e-02 8.000000e-02 + vertex 1.073866e-02 -7.927598e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 9.386068e-03 -5.926130e-02 8.000000e-02 + vertex 1.247470e-02 -5.868886e-02 8.000000e-02 + vertex 1.428455e-02 -7.871437e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.991945e-02 -3.589186e-03 8.000000e-02 + vertex -5.991777e-02 -3.140157e-03 8.000000e-02 + vertex -7.967794e-02 -7.171145e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.991945e-02 -3.589186e-03 8.000000e-02 + vertex -6.000000e-02 -4.594282e-17 8.000000e-02 + vertex -5.991777e-02 -3.140157e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.967131e-02 -6.271708e-03 8.000000e-02 + vertex 7.967794e-02 -7.171145e-03 8.000000e-02 + vertex 7.927598e-02 -1.073866e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.967131e-02 -6.271708e-03 8.000000e-02 + vertex 7.927598e-02 -1.073866e-02 8.000000e-02 + vertex 5.926130e-02 -9.386068e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.271708e-03 -5.967131e-02 8.000000e-02 + vertex 1.073866e-02 -7.927598e-02 8.000000e-02 + vertex 7.171145e-03 -7.967794e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 6.271708e-03 -5.967131e-02 8.000000e-02 + vertex 9.386068e-03 -5.926130e-02 8.000000e-02 + vertex 1.073866e-02 -7.927598e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.991777e-02 -3.140157e-03 8.000000e-02 + vertex 7.967794e-02 -7.171145e-03 8.000000e-02 + vertex 5.967131e-02 -6.271708e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.000000e-02 9.797174e-18 8.000000e-02 + vertex -6.000000e-02 -4.594282e-17 8.000000e-02 + vertex -7.991945e-02 -3.589186e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.991777e-02 -3.140157e-03 8.000000e-02 + vertex 7.991945e-02 -3.589186e-03 8.000000e-02 + vertex 7.967794e-02 -7.171145e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.898587e-18 8.000000e-02 8.000000e-02 + vertex 3.589186e-03 7.991945e-02 8.000000e-02 + vertex 1.699662e-17 6.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.140157e-03 -5.991777e-02 8.000000e-02 + vertex 7.171145e-03 -7.967794e-02 8.000000e-02 + vertex 3.589186e-03 -7.991945e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.140157e-03 -5.991777e-02 8.000000e-02 + vertex 6.271708e-03 -5.967131e-02 8.000000e-02 + vertex 7.171145e-03 -7.967794e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 6.000000e-02 0.000000e+00 8.000000e-02 + vertex 7.991945e-02 3.589186e-03 8.000000e-02 + vertex 8.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.000000e-02 0.000000e+00 8.000000e-02 + vertex 7.991945e-02 -3.589186e-03 8.000000e-02 + vertex 5.991777e-02 -3.140157e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.000000e-02 0.000000e+00 8.000000e-02 + vertex 8.000000e-02 0.000000e+00 8.000000e-02 + vertex 7.991945e-02 -3.589186e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + vertex -1.469576e-17 -8.000000e-02 8.000000e-02 + vertex -3.589186e-03 -7.991945e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.991945e-02 3.589186e-03 8.000000e-02 + vertex -5.991777e-02 3.140157e-03 8.000000e-02 + vertex -6.000000e-02 -4.594282e-17 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + vertex 3.589186e-03 -7.991945e-02 8.000000e-02 + vertex -1.469576e-17 -8.000000e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.991945e-02 3.589186e-03 8.000000e-02 + vertex -6.000000e-02 -4.594282e-17 8.000000e-02 + vertex -8.000000e-02 9.797174e-18 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + vertex 3.140157e-03 -5.991777e-02 8.000000e-02 + vertex 3.589186e-03 -7.991945e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.589186e-03 7.991945e-02 8.000000e-02 + vertex 1.699662e-17 6.000000e-02 8.000000e-02 + vertex -3.140157e-03 5.991777e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.991777e-02 3.140157e-03 8.000000e-02 + vertex 7.967794e-02 7.171145e-03 8.000000e-02 + vertex 7.991945e-02 3.589186e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.589186e-03 7.991945e-02 8.000000e-02 + vertex 4.898587e-18 8.000000e-02 8.000000e-02 + vertex 1.699662e-17 6.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.991777e-02 3.140157e-03 8.000000e-02 + vertex 7.991945e-02 3.589186e-03 8.000000e-02 + vertex 6.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.140157e-03 -5.991777e-02 8.000000e-02 + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + vertex -3.589186e-03 -7.991945e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.140157e-03 -5.991777e-02 8.000000e-02 + vertex -3.589186e-03 -7.991945e-02 8.000000e-02 + vertex -7.171145e-03 -7.967794e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -6.271708e-03 -5.967131e-02 8.000000e-02 + vertex -7.171145e-03 -7.967794e-02 8.000000e-02 + vertex -1.073866e-02 -7.927598e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.271708e-03 -5.967131e-02 8.000000e-02 + vertex -3.140157e-03 -5.991777e-02 8.000000e-02 + vertex -7.171145e-03 -7.967794e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.967794e-02 7.171145e-03 8.000000e-02 + vertex -5.991777e-02 3.140157e-03 8.000000e-02 + vertex -7.991945e-02 3.589186e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.967131e-02 6.271708e-03 8.000000e-02 + vertex 7.927598e-02 1.073866e-02 8.000000e-02 + vertex 7.967794e-02 7.171145e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.967131e-02 6.271708e-03 8.000000e-02 + vertex 7.967794e-02 7.171145e-03 8.000000e-02 + vertex 5.991777e-02 3.140157e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.967794e-02 7.171145e-03 8.000000e-02 + vertex -5.967131e-02 6.271708e-03 8.000000e-02 + vertex -5.991777e-02 3.140157e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.171145e-03 7.967794e-02 8.000000e-02 + vertex -3.140157e-03 5.991777e-02 8.000000e-02 + vertex -6.271708e-03 5.967131e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -9.386068e-03 -5.926130e-02 8.000000e-02 + vertex -1.073866e-02 -7.927598e-02 8.000000e-02 + vertex -1.428455e-02 -7.871437e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.386068e-03 -5.926130e-02 8.000000e-02 + vertex -6.271708e-03 -5.967131e-02 8.000000e-02 + vertex -1.073866e-02 -7.927598e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.171145e-03 7.967794e-02 8.000000e-02 + vertex -3.589186e-03 7.991945e-02 8.000000e-02 + vertex -3.140157e-03 5.991777e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.926130e-02 9.386068e-03 8.000000e-02 + vertex 7.871437e-02 1.428455e-02 8.000000e-02 + vertex 7.927598e-02 1.073866e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.927598e-02 1.073866e-02 8.000000e-02 + vertex -5.967131e-02 6.271708e-03 8.000000e-02 + vertex -7.967794e-02 7.171145e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.926130e-02 9.386068e-03 8.000000e-02 + vertex 7.927598e-02 1.073866e-02 8.000000e-02 + vertex 5.967131e-02 6.271708e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.927598e-02 1.073866e-02 8.000000e-02 + vertex -5.926130e-02 9.386068e-03 8.000000e-02 + vertex -5.967131e-02 6.271708e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.073866e-02 7.927598e-02 8.000000e-02 + vertex -6.271708e-03 5.967131e-02 8.000000e-02 + vertex -9.386068e-03 5.926130e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.247470e-02 -5.868886e-02 8.000000e-02 + vertex -1.428455e-02 -7.871437e-02 8.000000e-02 + vertex -1.780167e-02 -7.799423e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.247470e-02 -5.868886e-02 8.000000e-02 + vertex -9.386068e-03 -5.926130e-02 8.000000e-02 + vertex -1.428455e-02 -7.871437e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.073866e-02 7.927598e-02 8.000000e-02 + vertex -7.171145e-03 7.967794e-02 8.000000e-02 + vertex -6.271708e-03 5.967131e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.868886e-02 1.247470e-02 8.000000e-02 + vertex 7.871437e-02 1.428455e-02 8.000000e-02 + vertex 5.926130e-02 9.386068e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.871437e-02 1.428455e-02 8.000000e-02 + vertex -5.926130e-02 9.386068e-03 8.000000e-02 + vertex -7.927598e-02 1.073866e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.868886e-02 1.247470e-02 8.000000e-02 + vertex 7.799423e-02 1.780167e-02 8.000000e-02 + vertex 7.871437e-02 1.428455e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.871437e-02 1.428455e-02 8.000000e-02 + vertex -5.868886e-02 1.247470e-02 8.000000e-02 + vertex -5.926130e-02 9.386068e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.795555e-02 1.552914e-02 8.000000e-02 + vertex 7.711703e-02 2.128295e-02 8.000000e-02 + vertex 7.799423e-02 1.780167e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.428455e-02 7.871437e-02 8.000000e-02 + vertex -1.073866e-02 7.927598e-02 8.000000e-02 + vertex -9.386068e-03 5.926130e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.795555e-02 1.552914e-02 8.000000e-02 + vertex 7.799423e-02 1.780167e-02 8.000000e-02 + vertex 5.868886e-02 1.247470e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.428455e-02 7.871437e-02 8.000000e-02 + vertex -9.386068e-03 5.926130e-02 8.000000e-02 + vertex -1.247470e-02 5.868886e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.552914e-02 -5.795555e-02 8.000000e-02 + vertex -1.780167e-02 -7.799423e-02 8.000000e-02 + vertex -2.128295e-02 -7.711703e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.552914e-02 -5.795555e-02 8.000000e-02 + vertex -1.247470e-02 -5.868886e-02 8.000000e-02 + vertex -1.780167e-02 -7.799423e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.799423e-02 1.780167e-02 8.000000e-02 + vertex -5.868886e-02 1.247470e-02 8.000000e-02 + vertex -7.871437e-02 1.428455e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + vertex -2.472136e-02 -7.608452e-02 8.000000e-02 + vertex -2.810999e-02 -7.489879e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + vertex -2.128295e-02 -7.711703e-02 8.000000e-02 + vertex -2.472136e-02 -7.608452e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.799423e-02 1.780167e-02 8.000000e-02 + vertex -5.795555e-02 1.552914e-02 8.000000e-02 + vertex -5.868886e-02 1.247470e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.780167e-02 7.799423e-02 8.000000e-02 + vertex -1.428455e-02 7.871437e-02 8.000000e-02 + vertex -1.247470e-02 5.868886e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.780167e-02 7.799423e-02 8.000000e-02 + vertex -1.247470e-02 5.868886e-02 8.000000e-02 + vertex -1.552914e-02 5.795555e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + vertex -1.552914e-02 -5.795555e-02 8.000000e-02 + vertex -2.128295e-02 -7.711703e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + vertex 7.608452e-02 2.472136e-02 8.000000e-02 + vertex 7.711703e-02 2.128295e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + vertex 7.489879e-02 2.810999e-02 8.000000e-02 + vertex 7.608452e-02 2.472136e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.711703e-02 2.128295e-02 8.000000e-02 + vertex -5.795555e-02 1.552914e-02 8.000000e-02 + vertex -7.799423e-02 1.780167e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + vertex 7.711703e-02 2.128295e-02 8.000000e-02 + vertex 5.795555e-02 1.552914e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.711703e-02 2.128295e-02 8.000000e-02 + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + vertex -5.795555e-02 1.552914e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.128295e-02 7.711703e-02 8.000000e-02 + vertex -1.780167e-02 7.799423e-02 8.000000e-02 + vertex -1.552914e-02 5.795555e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.150208e-02 -5.601483e-02 8.000000e-02 + vertex -2.810999e-02 -7.489879e-02 8.000000e-02 + vertex -3.144200e-02 -7.356222e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.128295e-02 7.711703e-02 8.000000e-02 + vertex -1.552914e-02 5.795555e-02 8.000000e-02 + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.150208e-02 -5.601483e-02 8.000000e-02 + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + vertex -2.810999e-02 -7.489879e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 -7.956245e-01 -0.000000e+00 + outer loop + vertex -4.702282e-02 -6.472136e-02 1.000000e-01 + vertex -4.987918e-02 -6.254652e-02 1.000000e-01 + vertex -4.987918e-02 -6.254652e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex -4.702282e-02 -6.472136e-02 1.000000e-01 + vertex -4.987918e-02 -6.254652e-02 8.000000e-02 + vertex -4.702282e-02 -6.472136e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 -8.220021e-01 -0.000000e+00 + outer loop + vertex -4.407176e-02 -6.676586e-02 1.000000e-01 + vertex -4.702282e-02 -6.472136e-02 1.000000e-01 + vertex -4.702282e-02 -6.472136e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex -4.407176e-02 -6.676586e-02 1.000000e-01 + vertex -4.702282e-02 -6.472136e-02 8.000000e-02 + vertex -4.407176e-02 -6.676586e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 -8.467242e-01 -0.000000e+00 + outer loop + vertex -4.103194e-02 -6.867590e-02 1.000000e-01 + vertex -4.407176e-02 -6.676586e-02 1.000000e-01 + vertex -4.407176e-02 -6.676586e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex -4.103194e-02 -6.867590e-02 1.000000e-01 + vertex -4.407176e-02 -6.676586e-02 8.000000e-02 + vertex -4.103194e-02 -6.867590e-02 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex 7.991945e-02 3.589186e-03 1.000000e-01 + vertex 8.000000e-02 0.000000e+00 8.000000e-02 + vertex 7.991945e-02 3.589186e-03 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex 7.991945e-02 3.589186e-03 1.000000e-01 + vertex 8.000000e-02 0.000000e+00 1.000000e-01 + vertex 8.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 -8.697411e-01 -0.000000e+00 + outer loop + vertex -3.790949e-02 -7.044764e-02 1.000000e-01 + vertex -4.103194e-02 -6.867590e-02 1.000000e-01 + vertex -4.103194e-02 -6.867590e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex -3.790949e-02 -7.044764e-02 1.000000e-01 + vertex -4.103194e-02 -6.867590e-02 8.000000e-02 + vertex -3.790949e-02 -7.044764e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex 7.967794e-02 7.171145e-03 1.000000e-01 + vertex 7.991945e-02 3.589186e-03 8.000000e-02 + vertex 7.967794e-02 7.171145e-03 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex 7.967794e-02 7.171145e-03 1.000000e-01 + vertex 7.991945e-02 3.589186e-03 1.000000e-01 + vertex 7.991945e-02 3.589186e-03 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 -8.910065e-01 -0.000000e+00 + outer loop + vertex -3.471070e-02 -7.207751e-02 1.000000e-01 + vertex -3.790949e-02 -7.044764e-02 1.000000e-01 + vertex -3.790949e-02 -7.044764e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex -3.471070e-02 -7.207751e-02 1.000000e-01 + vertex -3.790949e-02 -7.044764e-02 8.000000e-02 + vertex -3.471070e-02 -7.207751e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex 7.927598e-02 1.073866e-02 1.000000e-01 + vertex 7.967794e-02 7.171145e-03 8.000000e-02 + vertex 7.927598e-02 1.073866e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex 7.927598e-02 1.073866e-02 1.000000e-01 + vertex 7.967794e-02 7.171145e-03 1.000000e-01 + vertex 7.967794e-02 7.171145e-03 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 -9.104775e-01 -0.000000e+00 + outer loop + vertex -3.144200e-02 -7.356222e-02 1.000000e-01 + vertex -3.471070e-02 -7.207751e-02 1.000000e-01 + vertex -3.471070e-02 -7.207751e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex -3.144200e-02 -7.356222e-02 1.000000e-01 + vertex -3.471070e-02 -7.207751e-02 8.000000e-02 + vertex -3.144200e-02 -7.356222e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex 7.871437e-02 1.428455e-02 1.000000e-01 + vertex 7.927598e-02 1.073866e-02 1.000000e-01 + vertex 7.927598e-02 1.073866e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex 7.871437e-02 1.428455e-02 1.000000e-01 + vertex 7.927598e-02 1.073866e-02 8.000000e-02 + vertex 7.871437e-02 1.428455e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 -9.281150e-01 -0.000000e+00 + outer loop + vertex -2.810999e-02 -7.489879e-02 1.000000e-01 + vertex -3.144200e-02 -7.356222e-02 1.000000e-01 + vertex -3.144200e-02 -7.356222e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex -2.810999e-02 -7.489879e-02 1.000000e-01 + vertex -3.144200e-02 -7.356222e-02 8.000000e-02 + vertex -2.810999e-02 -7.489879e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex 7.799423e-02 1.780167e-02 1.000000e-01 + vertex 7.871437e-02 1.428455e-02 1.000000e-01 + vertex 7.871437e-02 1.428455e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex 7.799423e-02 1.780167e-02 1.000000e-01 + vertex 7.871437e-02 1.428455e-02 8.000000e-02 + vertex 7.799423e-02 1.780167e-02 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 -9.438833e-01 -0.000000e+00 + outer loop + vertex -2.472136e-02 -7.608452e-02 1.000000e-01 + vertex -2.810999e-02 -7.489879e-02 1.000000e-01 + vertex -2.810999e-02 -7.489879e-02 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex -2.472136e-02 -7.608452e-02 1.000000e-01 + vertex -2.810999e-02 -7.489879e-02 8.000000e-02 + vertex -2.472136e-02 -7.608452e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex 7.711703e-02 2.128295e-02 1.000000e-01 + vertex 7.799423e-02 1.780167e-02 8.000000e-02 + vertex 7.711703e-02 2.128295e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex 7.711703e-02 2.128295e-02 1.000000e-01 + vertex 7.799423e-02 1.780167e-02 1.000000e-01 + vertex 7.799423e-02 1.780167e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 -9.577508e-01 -0.000000e+00 + outer loop + vertex -2.128295e-02 -7.711703e-02 1.000000e-01 + vertex -2.472136e-02 -7.608452e-02 1.000000e-01 + vertex -2.472136e-02 -7.608452e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex 7.608452e-02 2.472136e-02 1.000000e-01 + vertex 7.711703e-02 2.128295e-02 8.000000e-02 + vertex 7.608452e-02 2.472136e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex -2.128295e-02 -7.711703e-02 1.000000e-01 + vertex -2.472136e-02 -7.608452e-02 8.000000e-02 + vertex -2.128295e-02 -7.711703e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex 7.608452e-02 2.472136e-02 1.000000e-01 + vertex 7.711703e-02 2.128295e-02 1.000000e-01 + vertex 7.711703e-02 2.128295e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 -9.696895e-01 -0.000000e+00 + outer loop + vertex -1.780167e-02 -7.799423e-02 1.000000e-01 + vertex -2.128295e-02 -7.711703e-02 1.000000e-01 + vertex -2.128295e-02 -7.711703e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex 7.489879e-02 2.810999e-02 1.000000e-01 + vertex 7.608452e-02 2.472136e-02 1.000000e-01 + vertex 7.608452e-02 2.472136e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex -1.780167e-02 -7.799423e-02 1.000000e-01 + vertex -2.128295e-02 -7.711703e-02 8.000000e-02 + vertex -1.780167e-02 -7.799423e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex 7.489879e-02 2.810999e-02 1.000000e-01 + vertex 7.608452e-02 2.472136e-02 8.000000e-02 + vertex 7.489879e-02 2.810999e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex -1.428455e-02 -7.871437e-02 1.000000e-01 + vertex -1.780167e-02 -7.799423e-02 8.000000e-02 + vertex -1.428455e-02 -7.871437e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 -9.796754e-01 -0.000000e+00 + outer loop + vertex -1.428455e-02 -7.871437e-02 1.000000e-01 + vertex -1.780167e-02 -7.799423e-02 1.000000e-01 + vertex -1.780167e-02 -7.799423e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex 7.356222e-02 3.144200e-02 1.000000e-01 + vertex 7.489879e-02 2.810999e-02 8.000000e-02 + vertex 7.356222e-02 3.144200e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex 7.356222e-02 3.144200e-02 1.000000e-01 + vertex 7.489879e-02 2.810999e-02 1.000000e-01 + vertex 7.489879e-02 2.810999e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex -1.073866e-02 -7.927598e-02 1.000000e-01 + vertex -1.428455e-02 -7.871437e-02 8.000000e-02 + vertex -1.073866e-02 -7.927598e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 -9.876883e-01 -0.000000e+00 + outer loop + vertex -1.073866e-02 -7.927598e-02 1.000000e-01 + vertex -1.428455e-02 -7.871437e-02 1.000000e-01 + vertex -1.428455e-02 -7.871437e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex 7.207751e-02 3.471070e-02 1.000000e-01 + vertex 7.356222e-02 3.144200e-02 8.000000e-02 + vertex 7.207751e-02 3.471070e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex 7.207751e-02 3.471070e-02 1.000000e-01 + vertex 7.356222e-02 3.144200e-02 1.000000e-01 + vertex 7.356222e-02 3.144200e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex -7.171145e-03 -7.967794e-02 1.000000e-01 + vertex -1.073866e-02 -7.927598e-02 8.000000e-02 + vertex -7.171145e-03 -7.967794e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 -9.937122e-01 -0.000000e+00 + outer loop + vertex -7.171145e-03 -7.967794e-02 1.000000e-01 + vertex -1.073866e-02 -7.927598e-02 1.000000e-01 + vertex -1.073866e-02 -7.927598e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex 7.044764e-02 3.790949e-02 1.000000e-01 + vertex 7.207751e-02 3.471070e-02 8.000000e-02 + vertex 7.044764e-02 3.790949e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex 7.044764e-02 3.790949e-02 1.000000e-01 + vertex 7.207751e-02 3.471070e-02 1.000000e-01 + vertex 7.207751e-02 3.471070e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex -3.589186e-03 -7.991945e-02 1.000000e-01 + vertex -7.171145e-03 -7.967794e-02 8.000000e-02 + vertex -3.589186e-03 -7.991945e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 -9.977349e-01 -0.000000e+00 + outer loop + vertex -3.589186e-03 -7.991945e-02 1.000000e-01 + vertex -7.171145e-03 -7.967794e-02 1.000000e-01 + vertex -7.171145e-03 -7.967794e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex 6.867590e-02 4.103194e-02 1.000000e-01 + vertex 7.044764e-02 3.790949e-02 8.000000e-02 + vertex 6.867590e-02 4.103194e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex 6.867590e-02 4.103194e-02 1.000000e-01 + vertex 7.044764e-02 3.790949e-02 1.000000e-01 + vertex 7.044764e-02 3.790949e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex -1.469576e-17 -8.000000e-02 1.000000e-01 + vertex -3.589186e-03 -7.991945e-02 8.000000e-02 + vertex -1.469576e-17 -8.000000e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 -9.997482e-01 -0.000000e+00 + outer loop + vertex -1.469576e-17 -8.000000e-02 1.000000e-01 + vertex -3.589186e-03 -7.991945e-02 1.000000e-01 + vertex -3.589186e-03 -7.991945e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex 6.676586e-02 4.407176e-02 1.000000e-01 + vertex 6.867590e-02 4.103194e-02 8.000000e-02 + vertex 6.676586e-02 4.407176e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex 6.676586e-02 4.407176e-02 1.000000e-01 + vertex 6.867590e-02 4.103194e-02 1.000000e-01 + vertex 6.867590e-02 4.103194e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex 3.589186e-03 -7.991945e-02 1.000000e-01 + vertex -1.469576e-17 -8.000000e-02 8.000000e-02 + vertex 3.589186e-03 -7.991945e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex 3.589186e-03 -7.991945e-02 1.000000e-01 + vertex -1.469576e-17 -8.000000e-02 1.000000e-01 + vertex -1.469576e-17 -8.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex 6.472136e-02 4.702282e-02 1.000000e-01 + vertex 6.676586e-02 4.407176e-02 8.000000e-02 + vertex 6.472136e-02 4.702282e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex 7.171145e-03 -7.967794e-02 1.000000e-01 + vertex 3.589186e-03 -7.991945e-02 1.000000e-01 + vertex 3.589186e-03 -7.991945e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex 6.472136e-02 4.702282e-02 1.000000e-01 + vertex 6.676586e-02 4.407176e-02 1.000000e-01 + vertex 6.676586e-02 4.407176e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex 7.171145e-03 -7.967794e-02 1.000000e-01 + vertex 3.589186e-03 -7.991945e-02 8.000000e-02 + vertex 7.171145e-03 -7.967794e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex 6.254652e-02 4.987918e-02 1.000000e-01 + vertex 6.472136e-02 4.702282e-02 8.000000e-02 + vertex 6.254652e-02 4.987918e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex 1.073866e-02 -7.927598e-02 1.000000e-01 + vertex 7.171145e-03 -7.967794e-02 8.000000e-02 + vertex 1.073866e-02 -7.927598e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex 6.254652e-02 4.987918e-02 1.000000e-01 + vertex 6.472136e-02 4.702282e-02 1.000000e-01 + vertex 6.472136e-02 4.702282e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex 1.073866e-02 -7.927598e-02 1.000000e-01 + vertex 7.171145e-03 -7.967794e-02 1.000000e-01 + vertex 7.171145e-03 -7.967794e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex 6.024572e-02 5.263510e-02 1.000000e-01 + vertex 6.254652e-02 4.987918e-02 8.000000e-02 + vertex 6.024572e-02 5.263510e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex 1.428455e-02 -7.871437e-02 1.000000e-01 + vertex 1.073866e-02 -7.927598e-02 8.000000e-02 + vertex 1.428455e-02 -7.871437e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex 6.024572e-02 5.263510e-02 1.000000e-01 + vertex 6.254652e-02 4.987918e-02 1.000000e-01 + vertex 6.254652e-02 4.987918e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex 1.428455e-02 -7.871437e-02 1.000000e-01 + vertex 1.073866e-02 -7.927598e-02 1.000000e-01 + vertex 1.073866e-02 -7.927598e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex 1.780167e-02 -7.799423e-02 1.000000e-01 + vertex 1.428455e-02 -7.871437e-02 8.000000e-02 + vertex 1.780167e-02 -7.799423e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex 5.782359e-02 5.528501e-02 1.000000e-01 + vertex 6.024572e-02 5.263510e-02 8.000000e-02 + vertex 5.782359e-02 5.528501e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex 1.780167e-02 -7.799423e-02 1.000000e-01 + vertex 1.428455e-02 -7.871437e-02 1.000000e-01 + vertex 1.428455e-02 -7.871437e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex 5.782359e-02 5.528501e-02 1.000000e-01 + vertex 6.024572e-02 5.263510e-02 1.000000e-01 + vertex 6.024572e-02 5.263510e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex 2.128295e-02 -7.711703e-02 1.000000e-01 + vertex 1.780167e-02 -7.799423e-02 8.000000e-02 + vertex 2.128295e-02 -7.711703e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex 5.528501e-02 5.782359e-02 1.000000e-01 + vertex 5.782359e-02 5.528501e-02 8.000000e-02 + vertex 5.528501e-02 5.782359e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex 2.128295e-02 -7.711703e-02 1.000000e-01 + vertex 1.780167e-02 -7.799423e-02 1.000000e-01 + vertex 1.780167e-02 -7.799423e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex 5.528501e-02 5.782359e-02 1.000000e-01 + vertex 5.782359e-02 5.528501e-02 1.000000e-01 + vertex 5.782359e-02 5.528501e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex 2.472136e-02 -7.608452e-02 1.000000e-01 + vertex 2.128295e-02 -7.711703e-02 8.000000e-02 + vertex 2.472136e-02 -7.608452e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex 5.263510e-02 6.024572e-02 1.000000e-01 + vertex 5.528501e-02 5.782359e-02 8.000000e-02 + vertex 5.263510e-02 6.024572e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex 2.472136e-02 -7.608452e-02 1.000000e-01 + vertex 2.128295e-02 -7.711703e-02 1.000000e-01 + vertex 2.128295e-02 -7.711703e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex 5.263510e-02 6.024572e-02 1.000000e-01 + vertex 5.528501e-02 5.782359e-02 1.000000e-01 + vertex 5.528501e-02 5.782359e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex 2.810999e-02 -7.489879e-02 1.000000e-01 + vertex 2.472136e-02 -7.608452e-02 8.000000e-02 + vertex 2.810999e-02 -7.489879e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex 2.810999e-02 -7.489879e-02 1.000000e-01 + vertex 2.472136e-02 -7.608452e-02 1.000000e-01 + vertex 2.472136e-02 -7.608452e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex 4.987918e-02 6.254652e-02 1.000000e-01 + vertex 5.263510e-02 6.024572e-02 8.000000e-02 + vertex 4.987918e-02 6.254652e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex 4.987918e-02 6.254652e-02 1.000000e-01 + vertex 5.263510e-02 6.024572e-02 1.000000e-01 + vertex 5.263510e-02 6.024572e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex 3.144200e-02 -7.356222e-02 1.000000e-01 + vertex 2.810999e-02 -7.489879e-02 8.000000e-02 + vertex 3.144200e-02 -7.356222e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex 3.144200e-02 -7.356222e-02 1.000000e-01 + vertex 2.810999e-02 -7.489879e-02 1.000000e-01 + vertex 2.810999e-02 -7.489879e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex 4.702282e-02 6.472136e-02 1.000000e-01 + vertex 4.987918e-02 6.254652e-02 8.000000e-02 + vertex 4.702282e-02 6.472136e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex 4.702282e-02 6.472136e-02 1.000000e-01 + vertex 4.987918e-02 6.254652e-02 1.000000e-01 + vertex 4.987918e-02 6.254652e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex 3.471070e-02 -7.207751e-02 1.000000e-01 + vertex 3.144200e-02 -7.356222e-02 8.000000e-02 + vertex 3.471070e-02 -7.207751e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex 3.471070e-02 -7.207751e-02 1.000000e-01 + vertex 3.144200e-02 -7.356222e-02 1.000000e-01 + vertex 3.144200e-02 -7.356222e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex 4.407176e-02 6.676586e-02 1.000000e-01 + vertex 4.702282e-02 6.472136e-02 8.000000e-02 + vertex 4.407176e-02 6.676586e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex 4.407176e-02 6.676586e-02 1.000000e-01 + vertex 4.702282e-02 6.472136e-02 1.000000e-01 + vertex 4.702282e-02 6.472136e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex 3.790949e-02 -7.044764e-02 1.000000e-01 + vertex 3.471070e-02 -7.207751e-02 8.000000e-02 + vertex 3.790949e-02 -7.044764e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex 3.790949e-02 -7.044764e-02 1.000000e-01 + vertex 3.471070e-02 -7.207751e-02 1.000000e-01 + vertex 3.471070e-02 -7.207751e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex 4.103194e-02 6.867590e-02 1.000000e-01 + vertex 4.407176e-02 6.676586e-02 8.000000e-02 + vertex 4.103194e-02 6.867590e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex 4.103194e-02 6.867590e-02 1.000000e-01 + vertex 4.407176e-02 6.676586e-02 1.000000e-01 + vertex 4.407176e-02 6.676586e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex 4.103194e-02 -6.867590e-02 1.000000e-01 + vertex 3.790949e-02 -7.044764e-02 8.000000e-02 + vertex 4.103194e-02 -6.867590e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex 4.103194e-02 -6.867590e-02 1.000000e-01 + vertex 3.790949e-02 -7.044764e-02 1.000000e-01 + vertex 3.790949e-02 -7.044764e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex 3.790949e-02 7.044764e-02 1.000000e-01 + vertex 4.103194e-02 6.867590e-02 8.000000e-02 + vertex 3.790949e-02 7.044764e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex 4.407176e-02 -6.676586e-02 1.000000e-01 + vertex 4.103194e-02 -6.867590e-02 8.000000e-02 + vertex 4.407176e-02 -6.676586e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex 3.790949e-02 7.044764e-02 1.000000e-01 + vertex 4.103194e-02 6.867590e-02 1.000000e-01 + vertex 4.103194e-02 6.867590e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex 4.407176e-02 -6.676586e-02 1.000000e-01 + vertex 4.103194e-02 -6.867590e-02 1.000000e-01 + vertex 4.103194e-02 -6.867590e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex 3.471070e-02 7.207751e-02 1.000000e-01 + vertex 3.790949e-02 7.044764e-02 8.000000e-02 + vertex 3.471070e-02 7.207751e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex 4.702282e-02 -6.472136e-02 1.000000e-01 + vertex 4.407176e-02 -6.676586e-02 8.000000e-02 + vertex 4.702282e-02 -6.472136e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex 3.471070e-02 7.207751e-02 1.000000e-01 + vertex 3.790949e-02 7.044764e-02 1.000000e-01 + vertex 3.790949e-02 7.044764e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex 4.702282e-02 -6.472136e-02 1.000000e-01 + vertex 4.407176e-02 -6.676586e-02 1.000000e-01 + vertex 4.407176e-02 -6.676586e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex 3.144200e-02 7.356222e-02 1.000000e-01 + vertex 3.471070e-02 7.207751e-02 8.000000e-02 + vertex 3.144200e-02 7.356222e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex 4.987918e-02 -6.254652e-02 1.000000e-01 + vertex 4.702282e-02 -6.472136e-02 8.000000e-02 + vertex 4.987918e-02 -6.254652e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex 3.144200e-02 7.356222e-02 1.000000e-01 + vertex 3.471070e-02 7.207751e-02 1.000000e-01 + vertex 3.471070e-02 7.207751e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex 4.987918e-02 -6.254652e-02 1.000000e-01 + vertex 4.702282e-02 -6.472136e-02 1.000000e-01 + vertex 4.702282e-02 -6.472136e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex 5.263510e-02 -6.024572e-02 1.000000e-01 + vertex 4.987918e-02 -6.254652e-02 8.000000e-02 + vertex 5.263510e-02 -6.024572e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex 2.810999e-02 7.489879e-02 1.000000e-01 + vertex 3.144200e-02 7.356222e-02 8.000000e-02 + vertex 2.810999e-02 7.489879e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex 5.263510e-02 -6.024572e-02 1.000000e-01 + vertex 4.987918e-02 -6.254652e-02 1.000000e-01 + vertex 4.987918e-02 -6.254652e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex 2.810999e-02 7.489879e-02 1.000000e-01 + vertex 3.144200e-02 7.356222e-02 1.000000e-01 + vertex 3.144200e-02 7.356222e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex 5.528501e-02 -5.782359e-02 1.000000e-01 + vertex 5.263510e-02 -6.024572e-02 8.000000e-02 + vertex 5.528501e-02 -5.782359e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex 2.472136e-02 7.608452e-02 1.000000e-01 + vertex 2.810999e-02 7.489879e-02 8.000000e-02 + vertex 2.472136e-02 7.608452e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex 5.528501e-02 -5.782359e-02 1.000000e-01 + vertex 5.263510e-02 -6.024572e-02 1.000000e-01 + vertex 5.263510e-02 -6.024572e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex 2.472136e-02 7.608452e-02 1.000000e-01 + vertex 2.810999e-02 7.489879e-02 1.000000e-01 + vertex 2.810999e-02 7.489879e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex 5.782359e-02 -5.528501e-02 1.000000e-01 + vertex 5.528501e-02 -5.782359e-02 8.000000e-02 + vertex 5.782359e-02 -5.528501e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex 5.782359e-02 -5.528501e-02 1.000000e-01 + vertex 5.528501e-02 -5.782359e-02 1.000000e-01 + vertex 5.528501e-02 -5.782359e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex 2.128295e-02 7.711703e-02 1.000000e-01 + vertex 2.472136e-02 7.608452e-02 8.000000e-02 + vertex 2.128295e-02 7.711703e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex 2.128295e-02 7.711703e-02 1.000000e-01 + vertex 2.472136e-02 7.608452e-02 1.000000e-01 + vertex 2.472136e-02 7.608452e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex 6.024572e-02 -5.263510e-02 1.000000e-01 + vertex 5.782359e-02 -5.528501e-02 8.000000e-02 + vertex 6.024572e-02 -5.263510e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex 6.024572e-02 -5.263510e-02 1.000000e-01 + vertex 5.782359e-02 -5.528501e-02 1.000000e-01 + vertex 5.782359e-02 -5.528501e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex 1.780167e-02 7.799423e-02 1.000000e-01 + vertex 2.128295e-02 7.711703e-02 1.000000e-01 + vertex 2.128295e-02 7.711703e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex 1.780167e-02 7.799423e-02 1.000000e-01 + vertex 2.128295e-02 7.711703e-02 8.000000e-02 + vertex 1.780167e-02 7.799423e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex 6.254652e-02 -4.987918e-02 1.000000e-01 + vertex 6.024572e-02 -5.263510e-02 8.000000e-02 + vertex 6.254652e-02 -4.987918e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex 6.254652e-02 -4.987918e-02 1.000000e-01 + vertex 6.024572e-02 -5.263510e-02 1.000000e-01 + vertex 6.024572e-02 -5.263510e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex 1.428455e-02 7.871437e-02 1.000000e-01 + vertex 1.780167e-02 7.799423e-02 1.000000e-01 + vertex 1.780167e-02 7.799423e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex 1.428455e-02 7.871437e-02 1.000000e-01 + vertex 1.780167e-02 7.799423e-02 8.000000e-02 + vertex 1.428455e-02 7.871437e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex 6.472136e-02 -4.702282e-02 1.000000e-01 + vertex 6.254652e-02 -4.987918e-02 8.000000e-02 + vertex 6.472136e-02 -4.702282e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex 6.472136e-02 -4.702282e-02 1.000000e-01 + vertex 6.254652e-02 -4.987918e-02 1.000000e-01 + vertex 6.254652e-02 -4.987918e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex 1.073866e-02 7.927598e-02 1.000000e-01 + vertex 1.428455e-02 7.871437e-02 1.000000e-01 + vertex 1.428455e-02 7.871437e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex 1.073866e-02 7.927598e-02 1.000000e-01 + vertex 1.428455e-02 7.871437e-02 8.000000e-02 + vertex 1.073866e-02 7.927598e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex 6.676586e-02 -4.407176e-02 1.000000e-01 + vertex 6.472136e-02 -4.702282e-02 8.000000e-02 + vertex 6.676586e-02 -4.407176e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex 6.676586e-02 -4.407176e-02 1.000000e-01 + vertex 6.472136e-02 -4.702282e-02 1.000000e-01 + vertex 6.472136e-02 -4.702282e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex 7.171145e-03 7.967794e-02 1.000000e-01 + vertex 1.073866e-02 7.927598e-02 1.000000e-01 + vertex 1.073866e-02 7.927598e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex 7.171145e-03 7.967794e-02 1.000000e-01 + vertex 1.073866e-02 7.927598e-02 8.000000e-02 + vertex 7.171145e-03 7.967794e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex 6.867590e-02 -4.103194e-02 1.000000e-01 + vertex 6.676586e-02 -4.407176e-02 8.000000e-02 + vertex 6.867590e-02 -4.103194e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex 6.867590e-02 -4.103194e-02 1.000000e-01 + vertex 6.676586e-02 -4.407176e-02 1.000000e-01 + vertex 6.676586e-02 -4.407176e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex 3.589186e-03 7.991945e-02 1.000000e-01 + vertex 7.171145e-03 7.967794e-02 1.000000e-01 + vertex 7.171145e-03 7.967794e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex 3.589186e-03 7.991945e-02 1.000000e-01 + vertex 7.171145e-03 7.967794e-02 8.000000e-02 + vertex 3.589186e-03 7.991945e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex 7.044764e-02 -3.790949e-02 1.000000e-01 + vertex 6.867590e-02 -4.103194e-02 8.000000e-02 + vertex 7.044764e-02 -3.790949e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex 7.044764e-02 -3.790949e-02 1.000000e-01 + vertex 6.867590e-02 -4.103194e-02 1.000000e-01 + vertex 6.867590e-02 -4.103194e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex 4.898587e-18 8.000000e-02 1.000000e-01 + vertex 3.589186e-03 7.991945e-02 1.000000e-01 + vertex 3.589186e-03 7.991945e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex 4.898587e-18 8.000000e-02 1.000000e-01 + vertex 3.589186e-03 7.991945e-02 8.000000e-02 + vertex 4.898587e-18 8.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex 7.207751e-02 -3.471070e-02 1.000000e-01 + vertex 7.044764e-02 -3.790949e-02 1.000000e-01 + vertex 7.044764e-02 -3.790949e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex 7.207751e-02 -3.471070e-02 1.000000e-01 + vertex 7.044764e-02 -3.790949e-02 8.000000e-02 + vertex 7.207751e-02 -3.471070e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex 7.356222e-02 -3.144200e-02 1.000000e-01 + vertex 7.207751e-02 -3.471070e-02 1.000000e-01 + vertex 7.207751e-02 -3.471070e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex -3.589186e-03 7.991945e-02 1.000000e-01 + vertex 4.898587e-18 8.000000e-02 1.000000e-01 + vertex 4.898587e-18 8.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex 7.356222e-02 -3.144200e-02 1.000000e-01 + vertex 7.207751e-02 -3.471070e-02 8.000000e-02 + vertex 7.356222e-02 -3.144200e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex -3.589186e-03 7.991945e-02 1.000000e-01 + vertex 4.898587e-18 8.000000e-02 8.000000e-02 + vertex -3.589186e-03 7.991945e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex 7.489879e-02 -2.810999e-02 1.000000e-01 + vertex 7.356222e-02 -3.144200e-02 1.000000e-01 + vertex 7.356222e-02 -3.144200e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex -7.171145e-03 7.967794e-02 1.000000e-01 + vertex -3.589186e-03 7.991945e-02 1.000000e-01 + vertex -3.589186e-03 7.991945e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex 7.489879e-02 -2.810999e-02 1.000000e-01 + vertex 7.356222e-02 -3.144200e-02 8.000000e-02 + vertex 7.489879e-02 -2.810999e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex -7.171145e-03 7.967794e-02 1.000000e-01 + vertex -3.589186e-03 7.991945e-02 8.000000e-02 + vertex -7.171145e-03 7.967794e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex 7.608452e-02 -2.472136e-02 1.000000e-01 + vertex 7.489879e-02 -2.810999e-02 1.000000e-01 + vertex 7.489879e-02 -2.810999e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex 7.608452e-02 -2.472136e-02 1.000000e-01 + vertex 7.489879e-02 -2.810999e-02 8.000000e-02 + vertex 7.608452e-02 -2.472136e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex -1.073866e-02 7.927598e-02 1.000000e-01 + vertex -7.171145e-03 7.967794e-02 1.000000e-01 + vertex -7.171145e-03 7.967794e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex -1.073866e-02 7.927598e-02 1.000000e-01 + vertex -7.171145e-03 7.967794e-02 8.000000e-02 + vertex -1.073866e-02 7.927598e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex 7.711703e-02 -2.128295e-02 1.000000e-01 + vertex 7.608452e-02 -2.472136e-02 1.000000e-01 + vertex 7.608452e-02 -2.472136e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex 7.711703e-02 -2.128295e-02 1.000000e-01 + vertex 7.608452e-02 -2.472136e-02 8.000000e-02 + vertex 7.711703e-02 -2.128295e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex -1.428455e-02 7.871437e-02 1.000000e-01 + vertex -1.073866e-02 7.927598e-02 8.000000e-02 + vertex -1.428455e-02 7.871437e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex -1.428455e-02 7.871437e-02 1.000000e-01 + vertex -1.073866e-02 7.927598e-02 1.000000e-01 + vertex -1.073866e-02 7.927598e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex 7.799423e-02 -1.780167e-02 1.000000e-01 + vertex 7.711703e-02 -2.128295e-02 1.000000e-01 + vertex 7.711703e-02 -2.128295e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex 7.799423e-02 -1.780167e-02 1.000000e-01 + vertex 7.711703e-02 -2.128295e-02 8.000000e-02 + vertex 7.799423e-02 -1.780167e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex -1.780167e-02 7.799423e-02 1.000000e-01 + vertex -1.428455e-02 7.871437e-02 8.000000e-02 + vertex -1.780167e-02 7.799423e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex -1.780167e-02 7.799423e-02 1.000000e-01 + vertex -1.428455e-02 7.871437e-02 1.000000e-01 + vertex -1.428455e-02 7.871437e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex 7.871437e-02 -1.428455e-02 1.000000e-01 + vertex 7.799423e-02 -1.780167e-02 1.000000e-01 + vertex 7.799423e-02 -1.780167e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex 7.871437e-02 -1.428455e-02 1.000000e-01 + vertex 7.799423e-02 -1.780167e-02 8.000000e-02 + vertex 7.871437e-02 -1.428455e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex -2.128295e-02 7.711703e-02 1.000000e-01 + vertex -1.780167e-02 7.799423e-02 8.000000e-02 + vertex -2.128295e-02 7.711703e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex -2.128295e-02 7.711703e-02 1.000000e-01 + vertex -1.780167e-02 7.799423e-02 1.000000e-01 + vertex -1.780167e-02 7.799423e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex 7.927598e-02 -1.073866e-02 1.000000e-01 + vertex 7.871437e-02 -1.428455e-02 1.000000e-01 + vertex 7.871437e-02 -1.428455e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex 7.927598e-02 -1.073866e-02 1.000000e-01 + vertex 7.871437e-02 -1.428455e-02 8.000000e-02 + vertex 7.927598e-02 -1.073866e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex -2.472136e-02 7.608452e-02 1.000000e-01 + vertex -2.128295e-02 7.711703e-02 8.000000e-02 + vertex -2.472136e-02 7.608452e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex -2.472136e-02 7.608452e-02 1.000000e-01 + vertex -2.128295e-02 7.711703e-02 1.000000e-01 + vertex -2.128295e-02 7.711703e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex 7.967794e-02 -7.171145e-03 1.000000e-01 + vertex 7.927598e-02 -1.073866e-02 1.000000e-01 + vertex 7.927598e-02 -1.073866e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex 7.967794e-02 -7.171145e-03 1.000000e-01 + vertex 7.927598e-02 -1.073866e-02 8.000000e-02 + vertex 7.967794e-02 -7.171145e-03 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex -2.810999e-02 7.489879e-02 1.000000e-01 + vertex -2.472136e-02 7.608452e-02 8.000000e-02 + vertex -2.810999e-02 7.489879e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex 7.991945e-02 -3.589186e-03 1.000000e-01 + vertex 7.967794e-02 -7.171145e-03 1.000000e-01 + vertex 7.967794e-02 -7.171145e-03 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex -2.810999e-02 7.489879e-02 1.000000e-01 + vertex -2.472136e-02 7.608452e-02 1.000000e-01 + vertex -2.472136e-02 7.608452e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex 7.991945e-02 -3.589186e-03 1.000000e-01 + vertex 7.967794e-02 -7.171145e-03 8.000000e-02 + vertex 7.991945e-02 -3.589186e-03 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex 8.000000e-02 0.000000e+00 1.000000e-01 + vertex 7.991945e-02 -3.589186e-03 8.000000e-02 + vertex 8.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex 8.000000e-02 0.000000e+00 1.000000e-01 + vertex 7.991945e-02 -3.589186e-03 1.000000e-01 + vertex 7.991945e-02 -3.589186e-03 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex -3.144200e-02 7.356222e-02 1.000000e-01 + vertex -2.810999e-02 7.489879e-02 8.000000e-02 + vertex -3.144200e-02 7.356222e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex -3.144200e-02 7.356222e-02 1.000000e-01 + vertex -2.810999e-02 7.489879e-02 1.000000e-01 + vertex -2.810999e-02 7.489879e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex -3.471070e-02 7.207751e-02 1.000000e-01 + vertex -3.144200e-02 7.356222e-02 8.000000e-02 + vertex -3.471070e-02 7.207751e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex -3.471070e-02 7.207751e-02 1.000000e-01 + vertex -3.144200e-02 7.356222e-02 1.000000e-01 + vertex -3.144200e-02 7.356222e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex -3.790949e-02 7.044764e-02 1.000000e-01 + vertex -3.471070e-02 7.207751e-02 8.000000e-02 + vertex -3.790949e-02 7.044764e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex -3.790949e-02 7.044764e-02 1.000000e-01 + vertex -3.471070e-02 7.207751e-02 1.000000e-01 + vertex -3.471070e-02 7.207751e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex -4.103194e-02 6.867590e-02 1.000000e-01 + vertex -3.790949e-02 7.044764e-02 8.000000e-02 + vertex -4.103194e-02 6.867590e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex -4.103194e-02 6.867590e-02 1.000000e-01 + vertex -3.790949e-02 7.044764e-02 1.000000e-01 + vertex -3.790949e-02 7.044764e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex -4.407176e-02 6.676586e-02 1.000000e-01 + vertex -4.103194e-02 6.867590e-02 8.000000e-02 + vertex -4.407176e-02 6.676586e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex -4.407176e-02 6.676586e-02 1.000000e-01 + vertex -4.103194e-02 6.867590e-02 1.000000e-01 + vertex -4.103194e-02 6.867590e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex -4.702282e-02 6.472136e-02 1.000000e-01 + vertex -4.407176e-02 6.676586e-02 8.000000e-02 + vertex -4.702282e-02 6.472136e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex -4.702282e-02 6.472136e-02 1.000000e-01 + vertex -4.407176e-02 6.676586e-02 1.000000e-01 + vertex -4.407176e-02 6.676586e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex -4.987918e-02 6.254652e-02 1.000000e-01 + vertex -4.702282e-02 6.472136e-02 8.000000e-02 + vertex -4.987918e-02 6.254652e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex -4.987918e-02 6.254652e-02 1.000000e-01 + vertex -4.702282e-02 6.472136e-02 1.000000e-01 + vertex -4.702282e-02 6.472136e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex -5.263510e-02 6.024572e-02 1.000000e-01 + vertex -4.987918e-02 6.254652e-02 8.000000e-02 + vertex -5.263510e-02 6.024572e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex -5.263510e-02 6.024572e-02 1.000000e-01 + vertex -4.987918e-02 6.254652e-02 1.000000e-01 + vertex -4.987918e-02 6.254652e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex -5.528501e-02 5.782359e-02 1.000000e-01 + vertex -5.263510e-02 6.024572e-02 8.000000e-02 + vertex -5.528501e-02 5.782359e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex -5.528501e-02 5.782359e-02 1.000000e-01 + vertex -5.263510e-02 6.024572e-02 1.000000e-01 + vertex -5.263510e-02 6.024572e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex -5.782359e-02 5.528501e-02 1.000000e-01 + vertex -5.528501e-02 5.782359e-02 8.000000e-02 + vertex -5.782359e-02 5.528501e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex -5.782359e-02 5.528501e-02 1.000000e-01 + vertex -5.528501e-02 5.782359e-02 1.000000e-01 + vertex -5.528501e-02 5.782359e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex -6.024572e-02 5.263510e-02 1.000000e-01 + vertex -5.782359e-02 5.528501e-02 8.000000e-02 + vertex -6.024572e-02 5.263510e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex -6.024572e-02 5.263510e-02 1.000000e-01 + vertex -5.782359e-02 5.528501e-02 1.000000e-01 + vertex -5.782359e-02 5.528501e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex -6.254652e-02 4.987918e-02 1.000000e-01 + vertex -6.024572e-02 5.263510e-02 1.000000e-01 + vertex -6.024572e-02 5.263510e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex -6.254652e-02 4.987918e-02 1.000000e-01 + vertex -6.024572e-02 5.263510e-02 8.000000e-02 + vertex -6.254652e-02 4.987918e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex -6.472136e-02 4.702282e-02 1.000000e-01 + vertex -6.254652e-02 4.987918e-02 1.000000e-01 + vertex -6.254652e-02 4.987918e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex -6.472136e-02 4.702282e-02 1.000000e-01 + vertex -6.254652e-02 4.987918e-02 8.000000e-02 + vertex -6.472136e-02 4.702282e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex -6.676586e-02 4.407176e-02 1.000000e-01 + vertex -6.472136e-02 4.702282e-02 1.000000e-01 + vertex -6.472136e-02 4.702282e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex -6.676586e-02 4.407176e-02 1.000000e-01 + vertex -6.472136e-02 4.702282e-02 8.000000e-02 + vertex -6.676586e-02 4.407176e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex -6.867590e-02 4.103194e-02 1.000000e-01 + vertex -6.676586e-02 4.407176e-02 1.000000e-01 + vertex -6.676586e-02 4.407176e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex -6.867590e-02 4.103194e-02 1.000000e-01 + vertex -6.676586e-02 4.407176e-02 8.000000e-02 + vertex -6.867590e-02 4.103194e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex -7.044764e-02 3.790949e-02 1.000000e-01 + vertex -6.867590e-02 4.103194e-02 1.000000e-01 + vertex -6.867590e-02 4.103194e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex -7.044764e-02 3.790949e-02 1.000000e-01 + vertex -6.867590e-02 4.103194e-02 8.000000e-02 + vertex -7.044764e-02 3.790949e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex -7.207751e-02 3.471070e-02 1.000000e-01 + vertex -7.044764e-02 3.790949e-02 1.000000e-01 + vertex -7.044764e-02 3.790949e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex -7.207751e-02 3.471070e-02 1.000000e-01 + vertex -7.044764e-02 3.790949e-02 8.000000e-02 + vertex -7.207751e-02 3.471070e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex -7.356222e-02 3.144200e-02 1.000000e-01 + vertex -7.207751e-02 3.471070e-02 1.000000e-01 + vertex -7.207751e-02 3.471070e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex -7.356222e-02 3.144200e-02 1.000000e-01 + vertex -7.207751e-02 3.471070e-02 8.000000e-02 + vertex -7.356222e-02 3.144200e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex -7.489879e-02 2.810999e-02 1.000000e-01 + vertex -7.356222e-02 3.144200e-02 1.000000e-01 + vertex -7.356222e-02 3.144200e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex -7.489879e-02 2.810999e-02 1.000000e-01 + vertex -7.356222e-02 3.144200e-02 8.000000e-02 + vertex -7.489879e-02 2.810999e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex -7.608452e-02 2.472136e-02 1.000000e-01 + vertex -7.489879e-02 2.810999e-02 1.000000e-01 + vertex -7.489879e-02 2.810999e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex -7.608452e-02 2.472136e-02 1.000000e-01 + vertex -7.489879e-02 2.810999e-02 8.000000e-02 + vertex -7.608452e-02 2.472136e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex -7.711703e-02 2.128295e-02 1.000000e-01 + vertex -7.608452e-02 2.472136e-02 1.000000e-01 + vertex -7.608452e-02 2.472136e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex -7.711703e-02 2.128295e-02 1.000000e-01 + vertex -7.608452e-02 2.472136e-02 8.000000e-02 + vertex -7.711703e-02 2.128295e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex -7.799423e-02 1.780167e-02 1.000000e-01 + vertex -7.711703e-02 2.128295e-02 1.000000e-01 + vertex -7.711703e-02 2.128295e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex -7.799423e-02 1.780167e-02 1.000000e-01 + vertex -7.711703e-02 2.128295e-02 8.000000e-02 + vertex -7.799423e-02 1.780167e-02 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex -7.871437e-02 1.428455e-02 1.000000e-01 + vertex -7.799423e-02 1.780167e-02 1.000000e-01 + vertex -7.799423e-02 1.780167e-02 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex -7.871437e-02 1.428455e-02 1.000000e-01 + vertex -7.799423e-02 1.780167e-02 8.000000e-02 + vertex -7.871437e-02 1.428455e-02 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex -7.927598e-02 1.073866e-02 1.000000e-01 + vertex -7.871437e-02 1.428455e-02 1.000000e-01 + vertex -7.871437e-02 1.428455e-02 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex -7.927598e-02 1.073866e-02 1.000000e-01 + vertex -7.871437e-02 1.428455e-02 8.000000e-02 + vertex -7.927598e-02 1.073866e-02 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex -7.967794e-02 7.171145e-03 1.000000e-01 + vertex -7.927598e-02 1.073866e-02 1.000000e-01 + vertex -7.927598e-02 1.073866e-02 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex -7.967794e-02 7.171145e-03 1.000000e-01 + vertex -7.927598e-02 1.073866e-02 8.000000e-02 + vertex -7.967794e-02 7.171145e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex -7.991945e-02 3.589186e-03 1.000000e-01 + vertex -7.967794e-02 7.171145e-03 1.000000e-01 + vertex -7.967794e-02 7.171145e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex -7.991945e-02 3.589186e-03 1.000000e-01 + vertex -7.967794e-02 7.171145e-03 8.000000e-02 + vertex -7.991945e-02 3.589186e-03 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex -8.000000e-02 9.797174e-18 1.000000e-01 + vertex -7.991945e-02 3.589186e-03 1.000000e-01 + vertex -7.991945e-02 3.589186e-03 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex -8.000000e-02 9.797174e-18 1.000000e-01 + vertex -7.991945e-02 3.589186e-03 8.000000e-02 + vertex -8.000000e-02 9.797174e-18 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 -2.243806e-02 -0.000000e+00 + outer loop + vertex -7.991945e-02 -3.589186e-03 1.000000e-01 + vertex -8.000000e-02 9.797174e-18 1.000000e-01 + vertex -8.000000e-02 9.797174e-18 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex -7.991945e-02 -3.589186e-03 1.000000e-01 + vertex -8.000000e-02 9.797174e-18 8.000000e-02 + vertex -7.991945e-02 -3.589186e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex -7.967794e-02 -7.171145e-03 1.000000e-01 + vertex -7.991945e-02 -3.589186e-03 8.000000e-02 + vertex -7.967794e-02 -7.171145e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 -6.726901e-02 -0.000000e+00 + outer loop + vertex -7.967794e-02 -7.171145e-03 1.000000e-01 + vertex -7.991945e-02 -3.589186e-03 1.000000e-01 + vertex -7.991945e-02 -3.589186e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex -7.927598e-02 -1.073866e-02 1.000000e-01 + vertex -7.967794e-02 -7.171145e-03 8.000000e-02 + vertex -7.927598e-02 -1.073866e-02 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 -1.119645e-01 -0.000000e+00 + outer loop + vertex -7.927598e-02 -1.073866e-02 1.000000e-01 + vertex -7.967794e-02 -7.171145e-03 1.000000e-01 + vertex -7.967794e-02 -7.171145e-03 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 -1.564345e-01 -0.000000e+00 + outer loop + vertex -7.871437e-02 -1.428455e-02 1.000000e-01 + vertex -7.927598e-02 -1.073866e-02 1.000000e-01 + vertex -7.927598e-02 -1.073866e-02 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex -7.871437e-02 -1.428455e-02 1.000000e-01 + vertex -7.927598e-02 -1.073866e-02 8.000000e-02 + vertex -7.871437e-02 -1.428455e-02 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex -7.799423e-02 -1.780167e-02 1.000000e-01 + vertex -7.871437e-02 -1.428455e-02 8.000000e-02 + vertex -7.799423e-02 -1.780167e-02 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 -2.005894e-01 -0.000000e+00 + outer loop + vertex -7.799423e-02 -1.780167e-02 1.000000e-01 + vertex -7.871437e-02 -1.428455e-02 1.000000e-01 + vertex -7.871437e-02 -1.428455e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex -7.711703e-02 -2.128295e-02 1.000000e-01 + vertex -7.799423e-02 -1.780167e-02 8.000000e-02 + vertex -7.711703e-02 -2.128295e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 -2.443404e-01 -0.000000e+00 + outer loop + vertex -7.711703e-02 -2.128295e-02 1.000000e-01 + vertex -7.799423e-02 -1.780167e-02 1.000000e-01 + vertex -7.799423e-02 -1.780167e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex -7.608452e-02 -2.472136e-02 1.000000e-01 + vertex -7.711703e-02 -2.128295e-02 8.000000e-02 + vertex -7.608452e-02 -2.472136e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 -2.875993e-01 -0.000000e+00 + outer loop + vertex -7.608452e-02 -2.472136e-02 1.000000e-01 + vertex -7.711703e-02 -2.128295e-02 1.000000e-01 + vertex -7.711703e-02 -2.128295e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex -7.489879e-02 -2.810999e-02 1.000000e-01 + vertex -7.608452e-02 -2.472136e-02 8.000000e-02 + vertex -7.489879e-02 -2.810999e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 -3.302791e-01 -0.000000e+00 + outer loop + vertex -7.489879e-02 -2.810999e-02 1.000000e-01 + vertex -7.608452e-02 -2.472136e-02 1.000000e-01 + vertex -7.608452e-02 -2.472136e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex -7.356222e-02 -3.144200e-02 1.000000e-01 + vertex -7.489879e-02 -2.810999e-02 8.000000e-02 + vertex -7.356222e-02 -3.144200e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 -3.722937e-01 -0.000000e+00 + outer loop + vertex -7.356222e-02 -3.144200e-02 1.000000e-01 + vertex -7.489879e-02 -2.810999e-02 1.000000e-01 + vertex -7.489879e-02 -2.810999e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 -4.135585e-01 -0.000000e+00 + outer loop + vertex -7.207751e-02 -3.471070e-02 1.000000e-01 + vertex -7.356222e-02 -3.144200e-02 1.000000e-01 + vertex -7.356222e-02 -3.144200e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex -7.207751e-02 -3.471070e-02 1.000000e-01 + vertex -7.356222e-02 -3.144200e-02 8.000000e-02 + vertex -7.207751e-02 -3.471070e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 -4.539905e-01 -0.000000e+00 + outer loop + vertex -7.044764e-02 -3.790949e-02 1.000000e-01 + vertex -7.207751e-02 -3.471070e-02 1.000000e-01 + vertex -7.207751e-02 -3.471070e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex -7.044764e-02 -3.790949e-02 1.000000e-01 + vertex -7.207751e-02 -3.471070e-02 8.000000e-02 + vertex -7.044764e-02 -3.790949e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 -4.935082e-01 -0.000000e+00 + outer loop + vertex -6.867590e-02 -4.103194e-02 1.000000e-01 + vertex -7.044764e-02 -3.790949e-02 1.000000e-01 + vertex -7.044764e-02 -3.790949e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex -6.867590e-02 -4.103194e-02 1.000000e-01 + vertex -7.044764e-02 -3.790949e-02 8.000000e-02 + vertex -6.867590e-02 -4.103194e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 -5.320321e-01 -0.000000e+00 + outer loop + vertex -6.676586e-02 -4.407176e-02 1.000000e-01 + vertex -6.867590e-02 -4.103194e-02 1.000000e-01 + vertex -6.867590e-02 -4.103194e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex -6.676586e-02 -4.407176e-02 1.000000e-01 + vertex -6.867590e-02 -4.103194e-02 8.000000e-02 + vertex -6.676586e-02 -4.407176e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 -5.694845e-01 -0.000000e+00 + outer loop + vertex -6.472136e-02 -4.702282e-02 1.000000e-01 + vertex -6.676586e-02 -4.407176e-02 1.000000e-01 + vertex -6.676586e-02 -4.407176e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex -6.472136e-02 -4.702282e-02 1.000000e-01 + vertex -6.676586e-02 -4.407176e-02 8.000000e-02 + vertex -6.472136e-02 -4.702282e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 -6.057900e-01 -0.000000e+00 + outer loop + vertex -6.254652e-02 -4.987918e-02 1.000000e-01 + vertex -6.472136e-02 -4.702282e-02 1.000000e-01 + vertex -6.472136e-02 -4.702282e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex -6.254652e-02 -4.987918e-02 1.000000e-01 + vertex -6.472136e-02 -4.702282e-02 8.000000e-02 + vertex -6.254652e-02 -4.987918e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 -6.408756e-01 -0.000000e+00 + outer loop + vertex -6.024572e-02 -5.263510e-02 1.000000e-01 + vertex -6.254652e-02 -4.987918e-02 1.000000e-01 + vertex -6.254652e-02 -4.987918e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex -6.024572e-02 -5.263510e-02 1.000000e-01 + vertex -6.254652e-02 -4.987918e-02 8.000000e-02 + vertex -6.024572e-02 -5.263510e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 -6.746705e-01 -0.000000e+00 + outer loop + vertex -5.782359e-02 -5.528501e-02 1.000000e-01 + vertex -6.024572e-02 -5.263510e-02 1.000000e-01 + vertex -6.024572e-02 -5.263510e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex -5.782359e-02 -5.528501e-02 1.000000e-01 + vertex -6.024572e-02 -5.263510e-02 8.000000e-02 + vertex -5.782359e-02 -5.528501e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 -7.071068e-01 -0.000000e+00 + outer loop + vertex -5.528501e-02 -5.782359e-02 1.000000e-01 + vertex -5.782359e-02 -5.528501e-02 1.000000e-01 + vertex -5.782359e-02 -5.528501e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex -5.528501e-02 -5.782359e-02 1.000000e-01 + vertex -5.782359e-02 -5.528501e-02 8.000000e-02 + vertex -5.528501e-02 -5.782359e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 -7.381190e-01 -0.000000e+00 + outer loop + vertex -5.263510e-02 -6.024572e-02 1.000000e-01 + vertex -5.528501e-02 -5.782359e-02 1.000000e-01 + vertex -5.528501e-02 -5.782359e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex -5.263510e-02 -6.024572e-02 1.000000e-01 + vertex -5.528501e-02 -5.782359e-02 8.000000e-02 + vertex -5.263510e-02 -6.024572e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 -7.676447e-01 -0.000000e+00 + outer loop + vertex -4.987918e-02 -6.254652e-02 1.000000e-01 + vertex -5.263510e-02 -6.024572e-02 1.000000e-01 + vertex -5.263510e-02 -6.024572e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex -4.987918e-02 -6.254652e-02 1.000000e-01 + vertex -5.263510e-02 -6.024572e-02 8.000000e-02 + vertex -4.987918e-02 -6.254652e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.601483e-02 2.150208e-02 1.000000e-01 + vertex -7.489879e-02 2.810999e-02 1.000000e-01 + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.871437e-02 1.428455e-02 1.000000e-01 + vertex 5.926130e-02 9.386068e-03 1.000000e-01 + vertex 7.927598e-02 1.073866e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.601483e-02 2.150208e-02 1.000000e-01 + vertex -7.356222e-02 3.144200e-02 1.000000e-01 + vertex -7.489879e-02 2.810999e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.428455e-02 7.871437e-02 1.000000e-01 + vertex 1.073866e-02 7.927598e-02 1.000000e-01 + vertex 9.386068e-03 5.926130e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.428455e-02 7.871437e-02 1.000000e-01 + vertex 9.386068e-03 5.926130e-02 1.000000e-01 + vertex 1.247470e-02 5.868886e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.440420e-02 -5.481273e-02 1.000000e-01 + vertex 3.144200e-02 -7.356222e-02 1.000000e-01 + vertex 3.471070e-02 -7.207751e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.780167e-02 7.799423e-02 1.000000e-01 + vertex 1.428455e-02 7.871437e-02 1.000000e-01 + vertex 1.247470e-02 5.868886e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.440420e-02 -5.481273e-02 1.000000e-01 + vertex 2.150208e-02 -5.601483e-02 1.000000e-01 + vertex 3.144200e-02 -7.356222e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.780167e-02 7.799423e-02 1.000000e-01 + vertex 1.247470e-02 5.868886e-02 1.000000e-01 + vertex 1.552914e-02 5.795555e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.799423e-02 1.780167e-02 1.000000e-01 + vertex 5.868886e-02 1.247470e-02 1.000000e-01 + vertex 7.871437e-02 1.428455e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.481273e-02 2.440420e-02 1.000000e-01 + vertex -7.356222e-02 3.144200e-02 1.000000e-01 + vertex -5.601483e-02 2.150208e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.799423e-02 1.780167e-02 1.000000e-01 + vertex 5.795555e-02 1.552914e-02 1.000000e-01 + vertex 5.868886e-02 1.247470e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.481273e-02 2.440420e-02 1.000000e-01 + vertex -7.207751e-02 3.471070e-02 1.000000e-01 + vertex -7.356222e-02 3.144200e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.128295e-02 7.711703e-02 1.000000e-01 + vertex 1.780167e-02 7.799423e-02 1.000000e-01 + vertex 1.552914e-02 5.795555e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.723943e-02 -5.346039e-02 1.000000e-01 + vertex 3.471070e-02 -7.207751e-02 1.000000e-01 + vertex 3.790949e-02 -7.044764e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.128295e-02 7.711703e-02 1.000000e-01 + vertex 1.552914e-02 5.795555e-02 1.000000e-01 + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.711703e-02 2.128295e-02 1.000000e-01 + vertex 5.795555e-02 1.552914e-02 1.000000e-01 + vertex 7.799423e-02 1.780167e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.711703e-02 2.128295e-02 1.000000e-01 + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + vertex 5.795555e-02 1.552914e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.723943e-02 -5.346039e-02 1.000000e-01 + vertex 2.440420e-02 -5.481273e-02 1.000000e-01 + vertex 3.471070e-02 -7.207751e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.346039e-02 2.723943e-02 1.000000e-01 + vertex -7.044764e-02 3.790949e-02 1.000000e-01 + vertex -7.207751e-02 3.471070e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.472136e-02 7.608452e-02 1.000000e-01 + vertex 2.128295e-02 7.711703e-02 1.000000e-01 + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.346039e-02 2.723943e-02 1.000000e-01 + vertex -7.207751e-02 3.471070e-02 1.000000e-01 + vertex -5.481273e-02 2.440420e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.608452e-02 2.472136e-02 1.000000e-01 + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + vertex 7.711703e-02 2.128295e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.000000e-02 -5.196152e-02 1.000000e-01 + vertex 3.790949e-02 -7.044764e-02 1.000000e-01 + vertex 4.103194e-02 -6.867590e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.000000e-02 -5.196152e-02 1.000000e-01 + vertex 2.723943e-02 -5.346039e-02 1.000000e-01 + vertex 3.790949e-02 -7.044764e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.810999e-02 7.489879e-02 1.000000e-01 + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + vertex 2.150208e-02 5.601483e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.810999e-02 7.489879e-02 1.000000e-01 + vertex 2.472136e-02 7.608452e-02 1.000000e-01 + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.196152e-02 3.000000e-02 1.000000e-01 + vertex -7.044764e-02 3.790949e-02 1.000000e-01 + vertex -5.346039e-02 2.723943e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.489879e-02 2.810999e-02 1.000000e-01 + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + vertex 7.608452e-02 2.472136e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.489879e-02 2.810999e-02 1.000000e-01 + vertex 5.601483e-02 2.150208e-02 1.000000e-01 + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.196152e-02 3.000000e-02 1.000000e-01 + vertex -6.867590e-02 4.103194e-02 1.000000e-01 + vertex -7.044764e-02 3.790949e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.144200e-02 7.356222e-02 1.000000e-01 + vertex 2.810999e-02 7.489879e-02 1.000000e-01 + vertex 2.150208e-02 5.601483e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.267834e-02 -5.032023e-02 1.000000e-01 + vertex 4.103194e-02 -6.867590e-02 1.000000e-01 + vertex 4.407176e-02 -6.676586e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.267834e-02 -5.032023e-02 1.000000e-01 + vertex 3.000000e-02 -5.196152e-02 1.000000e-01 + vertex 4.103194e-02 -6.867590e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.144200e-02 7.356222e-02 1.000000e-01 + vertex 2.150208e-02 5.601483e-02 1.000000e-01 + vertex 2.440420e-02 5.481273e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.032023e-02 3.267834e-02 1.000000e-01 + vertex -6.867590e-02 4.103194e-02 1.000000e-01 + vertex -5.196152e-02 3.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.356222e-02 3.144200e-02 1.000000e-01 + vertex 5.481273e-02 2.440420e-02 1.000000e-01 + vertex 5.601483e-02 2.150208e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.032023e-02 3.267834e-02 1.000000e-01 + vertex -6.676586e-02 4.407176e-02 1.000000e-01 + vertex -6.867590e-02 4.103194e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + vertex 4.407176e-02 -6.676586e-02 1.000000e-01 + vertex 4.702282e-02 -6.472136e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.356222e-02 3.144200e-02 1.000000e-01 + vertex 5.601483e-02 2.150208e-02 1.000000e-01 + vertex 7.489879e-02 2.810999e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.471070e-02 7.207751e-02 1.000000e-01 + vertex 3.144200e-02 7.356222e-02 1.000000e-01 + vertex 2.440420e-02 5.481273e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.471070e-02 7.207751e-02 1.000000e-01 + vertex 2.440420e-02 5.481273e-02 1.000000e-01 + vertex 2.723943e-02 5.346039e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + vertex 3.267834e-02 -5.032023e-02 1.000000e-01 + vertex 4.407176e-02 -6.676586e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.207751e-02 3.471070e-02 1.000000e-01 + vertex 5.481273e-02 2.440420e-02 1.000000e-01 + vertex 7.356222e-02 3.144200e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.207751e-02 3.471070e-02 1.000000e-01 + vertex 5.346039e-02 2.723943e-02 1.000000e-01 + vertex 5.481273e-02 2.440420e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + vertex -6.472136e-02 4.702282e-02 1.000000e-01 + vertex -6.676586e-02 4.407176e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + vertex -6.676586e-02 4.407176e-02 1.000000e-01 + vertex -5.032023e-02 3.267834e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.790949e-02 7.044764e-02 1.000000e-01 + vertex 3.471070e-02 7.207751e-02 1.000000e-01 + vertex 2.723943e-02 5.346039e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.987918e-02 -6.254652e-02 1.000000e-01 + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + vertex 4.702282e-02 -6.472136e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.790949e-02 7.044764e-02 1.000000e-01 + vertex 2.723943e-02 5.346039e-02 1.000000e-01 + vertex 3.000000e-02 5.196152e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.254652e-02 4.987918e-02 1.000000e-01 + vertex -6.472136e-02 4.702282e-02 1.000000e-01 + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.044764e-02 3.790949e-02 1.000000e-01 + vertex 5.346039e-02 2.723943e-02 1.000000e-01 + vertex 7.207751e-02 3.471070e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.044764e-02 3.790949e-02 1.000000e-01 + vertex 5.196152e-02 3.000000e-02 1.000000e-01 + vertex 5.346039e-02 2.723943e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.867590e-02 4.103194e-02 1.000000e-01 + vertex 5.032023e-02 3.267834e-02 1.000000e-01 + vertex 5.196152e-02 3.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.775922e-02 -4.662876e-02 1.000000e-01 + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + vertex 4.987918e-02 -6.254652e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.867590e-02 4.103194e-02 1.000000e-01 + vertex 5.196152e-02 3.000000e-02 1.000000e-01 + vertex 7.044764e-02 3.790949e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.662876e-02 3.775922e-02 1.000000e-01 + vertex -6.254652e-02 4.987918e-02 1.000000e-01 + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.103194e-02 6.867590e-02 1.000000e-01 + vertex 3.790949e-02 7.044764e-02 1.000000e-01 + vertex 3.000000e-02 5.196152e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.103194e-02 6.867590e-02 1.000000e-01 + vertex 3.000000e-02 5.196152e-02 1.000000e-01 + vertex 3.267834e-02 5.032023e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.676586e-02 4.407176e-02 1.000000e-01 + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + vertex 5.032023e-02 3.267834e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.263510e-02 -6.024572e-02 1.000000e-01 + vertex 3.775922e-02 -4.662876e-02 1.000000e-01 + vertex 4.987918e-02 -6.254652e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.676586e-02 4.407176e-02 1.000000e-01 + vertex 5.032023e-02 3.267834e-02 1.000000e-01 + vertex 6.867590e-02 4.103194e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.242641e-02 -4.242641e-02 1.000000e-01 + vertex -5.782359e-02 -5.528501e-02 1.000000e-01 + vertex -5.528501e-02 -5.782359e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.024572e-02 5.263510e-02 1.000000e-01 + vertex -6.254652e-02 4.987918e-02 1.000000e-01 + vertex -4.662876e-02 3.775922e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.014784e-02 -4.458869e-02 1.000000e-01 + vertex 3.775922e-02 -4.662876e-02 1.000000e-01 + vertex 5.263510e-02 -6.024572e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.407176e-02 6.676586e-02 1.000000e-01 + vertex 4.103194e-02 6.867590e-02 1.000000e-01 + vertex 3.267834e-02 5.032023e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.458869e-02 4.014784e-02 1.000000e-01 + vertex -6.024572e-02 5.263510e-02 1.000000e-01 + vertex -4.662876e-02 3.775922e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.407176e-02 6.676586e-02 1.000000e-01 + vertex 3.267834e-02 5.032023e-02 1.000000e-01 + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.528501e-02 -5.782359e-02 1.000000e-01 + vertex 4.014784e-02 -4.458869e-02 1.000000e-01 + vertex 5.263510e-02 -6.024572e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.472136e-02 4.702282e-02 1.000000e-01 + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + vertex 6.676586e-02 4.407176e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.782359e-02 5.528501e-02 1.000000e-01 + vertex -6.024572e-02 5.263510e-02 1.000000e-01 + vertex -4.458869e-02 4.014784e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.242641e-02 -4.242641e-02 1.000000e-01 + vertex 4.014784e-02 -4.458869e-02 1.000000e-01 + vertex 5.528501e-02 -5.782359e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.702282e-02 6.472136e-02 1.000000e-01 + vertex 4.407176e-02 6.676586e-02 1.000000e-01 + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.458869e-02 -4.014784e-02 1.000000e-01 + vertex -5.782359e-02 -5.528501e-02 1.000000e-01 + vertex -4.242641e-02 -4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.987918e-02 6.254652e-02 1.000000e-01 + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + vertex 3.775922e-02 4.662876e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.458869e-02 -4.014784e-02 1.000000e-01 + vertex -6.024572e-02 -5.263510e-02 1.000000e-01 + vertex -5.782359e-02 -5.528501e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.987918e-02 6.254652e-02 1.000000e-01 + vertex 4.702282e-02 6.472136e-02 1.000000e-01 + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.254652e-02 4.987918e-02 1.000000e-01 + vertex 4.662876e-02 3.775922e-02 1.000000e-01 + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.014784e-02 -4.458869e-02 1.000000e-01 + vertex -4.242641e-02 -4.242641e-02 1.000000e-01 + vertex -5.528501e-02 -5.782359e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.254652e-02 4.987918e-02 1.000000e-01 + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + vertex 6.472136e-02 4.702282e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.014784e-02 -4.458869e-02 1.000000e-01 + vertex -5.528501e-02 -5.782359e-02 1.000000e-01 + vertex -5.263510e-02 -6.024572e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.242641e-02 4.242641e-02 1.000000e-01 + vertex -5.782359e-02 5.528501e-02 1.000000e-01 + vertex -4.458869e-02 4.014784e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.263510e-02 6.024572e-02 1.000000e-01 + vertex 3.775922e-02 4.662876e-02 1.000000e-01 + vertex 4.014784e-02 4.458869e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.263510e-02 6.024572e-02 1.000000e-01 + vertex 4.987918e-02 6.254652e-02 1.000000e-01 + vertex 3.775922e-02 4.662876e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.024572e-02 5.263510e-02 1.000000e-01 + vertex 4.458869e-02 4.014784e-02 1.000000e-01 + vertex 4.662876e-02 3.775922e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.024572e-02 5.263510e-02 1.000000e-01 + vertex 4.662876e-02 3.775922e-02 1.000000e-01 + vertex 6.254652e-02 4.987918e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.782359e-02 -5.528501e-02 1.000000e-01 + vertex 4.242641e-02 -4.242641e-02 1.000000e-01 + vertex 5.528501e-02 -5.782359e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.528501e-02 5.782359e-02 1.000000e-01 + vertex 5.263510e-02 6.024572e-02 1.000000e-01 + vertex 4.014784e-02 4.458869e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.528501e-02 5.782359e-02 1.000000e-01 + vertex 4.014784e-02 4.458869e-02 1.000000e-01 + vertex 4.242641e-02 4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.528501e-02 5.782359e-02 1.000000e-01 + vertex -5.782359e-02 5.528501e-02 1.000000e-01 + vertex -4.242641e-02 4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.662876e-02 -3.775922e-02 1.000000e-01 + vertex -6.024572e-02 -5.263510e-02 1.000000e-01 + vertex -4.458869e-02 -4.014784e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.782359e-02 5.528501e-02 1.000000e-01 + vertex 4.242641e-02 4.242641e-02 1.000000e-01 + vertex 4.458869e-02 4.014784e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.458869e-02 -4.014784e-02 1.000000e-01 + vertex 4.242641e-02 -4.242641e-02 1.000000e-01 + vertex 5.782359e-02 -5.528501e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.782359e-02 5.528501e-02 1.000000e-01 + vertex 4.458869e-02 4.014784e-02 1.000000e-01 + vertex 6.024572e-02 5.263510e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.782359e-02 5.528501e-02 1.000000e-01 + vertex 5.528501e-02 5.782359e-02 1.000000e-01 + vertex 4.242641e-02 4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.014784e-02 4.458869e-02 1.000000e-01 + vertex -5.528501e-02 5.782359e-02 1.000000e-01 + vertex -4.242641e-02 4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.662876e-02 -3.775922e-02 1.000000e-01 + vertex -6.254652e-02 -4.987918e-02 1.000000e-01 + vertex -6.024572e-02 -5.263510e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.024572e-02 -5.263510e-02 1.000000e-01 + vertex 4.458869e-02 -4.014784e-02 1.000000e-01 + vertex 5.782359e-02 -5.528501e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.263510e-02 6.024572e-02 1.000000e-01 + vertex -5.528501e-02 5.782359e-02 1.000000e-01 + vertex -4.014784e-02 4.458869e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.775922e-02 -4.662876e-02 1.000000e-01 + vertex -4.014784e-02 -4.458869e-02 1.000000e-01 + vertex -5.263510e-02 -6.024572e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.775922e-02 -4.662876e-02 1.000000e-01 + vertex -5.263510e-02 -6.024572e-02 1.000000e-01 + vertex -4.987918e-02 -6.254652e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.662876e-02 -3.775922e-02 1.000000e-01 + vertex 4.458869e-02 -4.014784e-02 1.000000e-01 + vertex 6.024572e-02 -5.263510e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.775922e-02 4.662876e-02 1.000000e-01 + vertex -5.263510e-02 6.024572e-02 1.000000e-01 + vertex -4.014784e-02 4.458869e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.254652e-02 -4.987918e-02 1.000000e-01 + vertex 4.662876e-02 -3.775922e-02 1.000000e-01 + vertex 6.024572e-02 -5.263510e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + vertex -6.254652e-02 -4.987918e-02 1.000000e-01 + vertex -4.662876e-02 -3.775922e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.987918e-02 6.254652e-02 1.000000e-01 + vertex -5.263510e-02 6.024572e-02 1.000000e-01 + vertex -3.775922e-02 4.662876e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + vertex 4.662876e-02 -3.775922e-02 1.000000e-01 + vertex 6.254652e-02 -4.987918e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + vertex -4.987918e-02 6.254652e-02 1.000000e-01 + vertex -3.775922e-02 4.662876e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + vertex -6.676586e-02 -4.407176e-02 1.000000e-01 + vertex -6.472136e-02 -4.702282e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + vertex -6.472136e-02 -4.702282e-02 1.000000e-01 + vertex -6.254652e-02 -4.987918e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + vertex -4.987918e-02 -6.254652e-02 1.000000e-01 + vertex -4.702282e-02 -6.472136e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + vertex -4.702282e-02 -6.472136e-02 1.000000e-01 + vertex -4.407176e-02 -6.676586e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + vertex -3.775922e-02 -4.662876e-02 1.000000e-01 + vertex -4.987918e-02 -6.254652e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.702282e-02 6.472136e-02 1.000000e-01 + vertex -4.987918e-02 6.254652e-02 1.000000e-01 + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.472136e-02 -4.702282e-02 1.000000e-01 + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + vertex 6.254652e-02 -4.987918e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.032023e-02 -3.267834e-02 1.000000e-01 + vertex -6.676586e-02 -4.407176e-02 1.000000e-01 + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.676586e-02 -4.407176e-02 1.000000e-01 + vertex 5.032023e-02 -3.267834e-02 1.000000e-01 + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.676586e-02 -4.407176e-02 1.000000e-01 + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + vertex 6.472136e-02 -4.702282e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.407176e-02 6.676586e-02 1.000000e-01 + vertex -4.702282e-02 6.472136e-02 1.000000e-01 + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.032023e-02 -3.267834e-02 1.000000e-01 + vertex -6.867590e-02 -4.103194e-02 1.000000e-01 + vertex -6.676586e-02 -4.407176e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.407176e-02 6.676586e-02 1.000000e-01 + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + vertex -3.267834e-02 5.032023e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.267834e-02 -5.032023e-02 1.000000e-01 + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + vertex -4.407176e-02 -6.676586e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.267834e-02 -5.032023e-02 1.000000e-01 + vertex -4.407176e-02 -6.676586e-02 1.000000e-01 + vertex -4.103194e-02 -6.867590e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.867590e-02 -4.103194e-02 1.000000e-01 + vertex 5.032023e-02 -3.267834e-02 1.000000e-01 + vertex 6.676586e-02 -4.407176e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.867590e-02 -4.103194e-02 1.000000e-01 + vertex 5.196152e-02 -3.000000e-02 1.000000e-01 + vertex 5.032023e-02 -3.267834e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.196152e-02 -3.000000e-02 1.000000e-01 + vertex -6.867590e-02 -4.103194e-02 1.000000e-01 + vertex -5.032023e-02 -3.267834e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.103194e-02 6.867590e-02 1.000000e-01 + vertex -4.407176e-02 6.676586e-02 1.000000e-01 + vertex -3.267834e-02 5.032023e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.103194e-02 6.867590e-02 1.000000e-01 + vertex -3.267834e-02 5.032023e-02 1.000000e-01 + vertex -3.000000e-02 5.196152e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.196152e-02 -3.000000e-02 1.000000e-01 + vertex -7.044764e-02 -3.790949e-02 1.000000e-01 + vertex -6.867590e-02 -4.103194e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.000000e-02 -5.196152e-02 1.000000e-01 + vertex -3.267834e-02 -5.032023e-02 1.000000e-01 + vertex -4.103194e-02 -6.867590e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.000000e-02 -5.196152e-02 1.000000e-01 + vertex -4.103194e-02 -6.867590e-02 1.000000e-01 + vertex -3.790949e-02 -7.044764e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.790949e-02 7.044764e-02 1.000000e-01 + vertex -4.103194e-02 6.867590e-02 1.000000e-01 + vertex -3.000000e-02 5.196152e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.790949e-02 7.044764e-02 1.000000e-01 + vertex -3.000000e-02 5.196152e-02 1.000000e-01 + vertex -2.723943e-02 5.346039e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.044764e-02 -3.790949e-02 1.000000e-01 + vertex 5.346039e-02 -2.723943e-02 1.000000e-01 + vertex 5.196152e-02 -3.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.044764e-02 -3.790949e-02 1.000000e-01 + vertex 5.196152e-02 -3.000000e-02 1.000000e-01 + vertex 6.867590e-02 -4.103194e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.346039e-02 -2.723943e-02 1.000000e-01 + vertex -7.044764e-02 -3.790949e-02 1.000000e-01 + vertex -5.196152e-02 -3.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.207751e-02 -3.471070e-02 1.000000e-01 + vertex 5.346039e-02 -2.723943e-02 1.000000e-01 + vertex 7.044764e-02 -3.790949e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.346039e-02 -2.723943e-02 1.000000e-01 + vertex -7.207751e-02 -3.471070e-02 1.000000e-01 + vertex -7.044764e-02 -3.790949e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.207751e-02 -3.471070e-02 1.000000e-01 + vertex 5.481273e-02 -2.440420e-02 1.000000e-01 + vertex 5.346039e-02 -2.723943e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.471070e-02 7.207751e-02 1.000000e-01 + vertex -3.790949e-02 7.044764e-02 1.000000e-01 + vertex -2.723943e-02 5.346039e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.471070e-02 7.207751e-02 1.000000e-01 + vertex -2.723943e-02 5.346039e-02 1.000000e-01 + vertex -2.440420e-02 5.481273e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.723943e-02 -5.346039e-02 1.000000e-01 + vertex -3.000000e-02 -5.196152e-02 1.000000e-01 + vertex -3.790949e-02 -7.044764e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.723943e-02 -5.346039e-02 1.000000e-01 + vertex -3.790949e-02 -7.044764e-02 1.000000e-01 + vertex -3.471070e-02 -7.207751e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.144200e-02 7.356222e-02 1.000000e-01 + vertex -2.440420e-02 5.481273e-02 1.000000e-01 + vertex -2.150208e-02 5.601483e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.144200e-02 7.356222e-02 1.000000e-01 + vertex -3.471070e-02 7.207751e-02 1.000000e-01 + vertex -2.440420e-02 5.481273e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.356222e-02 -3.144200e-02 1.000000e-01 + vertex 5.601483e-02 -2.150208e-02 1.000000e-01 + vertex 5.481273e-02 -2.440420e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.356222e-02 -3.144200e-02 1.000000e-01 + vertex 5.481273e-02 -2.440420e-02 1.000000e-01 + vertex 7.207751e-02 -3.471070e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.481273e-02 -2.440420e-02 1.000000e-01 + vertex -7.207751e-02 -3.471070e-02 1.000000e-01 + vertex -5.346039e-02 -2.723943e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.481273e-02 -2.440420e-02 1.000000e-01 + vertex -7.356222e-02 -3.144200e-02 1.000000e-01 + vertex -7.207751e-02 -3.471070e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.440420e-02 -5.481273e-02 1.000000e-01 + vertex -2.723943e-02 -5.346039e-02 1.000000e-01 + vertex -3.471070e-02 -7.207751e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.440420e-02 -5.481273e-02 1.000000e-01 + vertex -3.471070e-02 -7.207751e-02 1.000000e-01 + vertex -3.144200e-02 -7.356222e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.810999e-02 7.489879e-02 1.000000e-01 + vertex -2.150208e-02 5.601483e-02 1.000000e-01 + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.810999e-02 7.489879e-02 1.000000e-01 + vertex -3.144200e-02 7.356222e-02 1.000000e-01 + vertex -2.150208e-02 5.601483e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.601483e-02 -2.150208e-02 1.000000e-01 + vertex -7.356222e-02 -3.144200e-02 1.000000e-01 + vertex -5.481273e-02 -2.440420e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.489879e-02 -2.810999e-02 1.000000e-01 + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + vertex 5.601483e-02 -2.150208e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.489879e-02 -2.810999e-02 1.000000e-01 + vertex 5.601483e-02 -2.150208e-02 1.000000e-01 + vertex 7.356222e-02 -3.144200e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.601483e-02 -2.150208e-02 1.000000e-01 + vertex -7.489879e-02 -2.810999e-02 1.000000e-01 + vertex -7.356222e-02 -3.144200e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.150208e-02 -5.601483e-02 1.000000e-01 + vertex -2.440420e-02 -5.481273e-02 1.000000e-01 + vertex -3.144200e-02 -7.356222e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.150208e-02 -5.601483e-02 1.000000e-01 + vertex -3.144200e-02 -7.356222e-02 1.000000e-01 + vertex -2.810999e-02 -7.489879e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.608452e-02 -2.472136e-02 1.000000e-01 + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + vertex 7.489879e-02 -2.810999e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.472136e-02 7.608452e-02 1.000000e-01 + vertex -2.810999e-02 7.489879e-02 1.000000e-01 + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + vertex -7.489879e-02 -2.810999e-02 1.000000e-01 + vertex -5.601483e-02 -2.150208e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + vertex -7.711703e-02 -2.128295e-02 1.000000e-01 + vertex -7.608452e-02 -2.472136e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.711703e-02 -2.128295e-02 1.000000e-01 + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + vertex 7.608452e-02 -2.472136e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + vertex -7.608452e-02 -2.472136e-02 1.000000e-01 + vertex -7.489879e-02 -2.810999e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.711703e-02 -2.128295e-02 1.000000e-01 + vertex 5.795555e-02 -1.552914e-02 1.000000e-01 + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.128295e-02 7.711703e-02 1.000000e-01 + vertex -2.472136e-02 7.608452e-02 1.000000e-01 + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.128295e-02 7.711703e-02 1.000000e-01 + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + vertex -1.552914e-02 5.795555e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + vertex -2.150208e-02 -5.601483e-02 1.000000e-01 + vertex -2.810999e-02 -7.489879e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + vertex -2.810999e-02 -7.489879e-02 1.000000e-01 + vertex -2.472136e-02 -7.608452e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + vertex -2.472136e-02 -7.608452e-02 1.000000e-01 + vertex -2.128295e-02 -7.711703e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.795555e-02 -1.552914e-02 1.000000e-01 + vertex -7.711703e-02 -2.128295e-02 1.000000e-01 + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.795555e-02 -1.552914e-02 1.000000e-01 + vertex -7.799423e-02 -1.780167e-02 1.000000e-01 + vertex -7.711703e-02 -2.128295e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.780167e-02 7.799423e-02 1.000000e-01 + vertex -2.128295e-02 7.711703e-02 1.000000e-01 + vertex -1.552914e-02 5.795555e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.780167e-02 7.799423e-02 1.000000e-01 + vertex -1.552914e-02 5.795555e-02 1.000000e-01 + vertex -1.247470e-02 5.868886e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.552914e-02 -5.795555e-02 1.000000e-01 + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + vertex -2.128295e-02 -7.711703e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.799423e-02 -1.780167e-02 1.000000e-01 + vertex 5.868886e-02 -1.247470e-02 1.000000e-01 + vertex 5.795555e-02 -1.552914e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.552914e-02 -5.795555e-02 1.000000e-01 + vertex -2.128295e-02 -7.711703e-02 1.000000e-01 + vertex -1.780167e-02 -7.799423e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.799423e-02 -1.780167e-02 1.000000e-01 + vertex 5.795555e-02 -1.552914e-02 1.000000e-01 + vertex 7.711703e-02 -2.128295e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.868886e-02 -1.247470e-02 1.000000e-01 + vertex -7.871437e-02 -1.428455e-02 1.000000e-01 + vertex -7.799423e-02 -1.780167e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.868886e-02 -1.247470e-02 1.000000e-01 + vertex -7.799423e-02 -1.780167e-02 1.000000e-01 + vertex -5.795555e-02 -1.552914e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.247470e-02 -5.868886e-02 1.000000e-01 + vertex -1.780167e-02 -7.799423e-02 1.000000e-01 + vertex -1.428455e-02 -7.871437e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.871437e-02 -1.428455e-02 1.000000e-01 + vertex 5.868886e-02 -1.247470e-02 1.000000e-01 + vertex 7.799423e-02 -1.780167e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.871437e-02 -1.428455e-02 1.000000e-01 + vertex 5.926130e-02 -9.386068e-03 1.000000e-01 + vertex 5.868886e-02 -1.247470e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.428455e-02 7.871437e-02 1.000000e-01 + vertex -1.780167e-02 7.799423e-02 1.000000e-01 + vertex -1.247470e-02 5.868886e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.247470e-02 -5.868886e-02 1.000000e-01 + vertex -1.552914e-02 -5.795555e-02 1.000000e-01 + vertex -1.780167e-02 -7.799423e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.428455e-02 7.871437e-02 1.000000e-01 + vertex -1.247470e-02 5.868886e-02 1.000000e-01 + vertex -9.386068e-03 5.926130e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.927598e-02 -1.073866e-02 1.000000e-01 + vertex 5.926130e-02 -9.386068e-03 1.000000e-01 + vertex 7.871437e-02 -1.428455e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.926130e-02 -9.386068e-03 1.000000e-01 + vertex -7.927598e-02 -1.073866e-02 1.000000e-01 + vertex -7.871437e-02 -1.428455e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.927598e-02 -1.073866e-02 1.000000e-01 + vertex 5.967131e-02 -6.271708e-03 1.000000e-01 + vertex 5.926130e-02 -9.386068e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.926130e-02 -9.386068e-03 1.000000e-01 + vertex -7.871437e-02 -1.428455e-02 1.000000e-01 + vertex -5.868886e-02 -1.247470e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -9.386068e-03 -5.926130e-02 1.000000e-01 + vertex -1.428455e-02 -7.871437e-02 1.000000e-01 + vertex -1.073866e-02 -7.927598e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.073866e-02 7.927598e-02 1.000000e-01 + vertex -1.428455e-02 7.871437e-02 1.000000e-01 + vertex -9.386068e-03 5.926130e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -9.386068e-03 -5.926130e-02 1.000000e-01 + vertex -1.247470e-02 -5.868886e-02 1.000000e-01 + vertex -1.428455e-02 -7.871437e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.073866e-02 7.927598e-02 1.000000e-01 + vertex -9.386068e-03 5.926130e-02 1.000000e-01 + vertex -6.271708e-03 5.967131e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.967131e-02 -6.271708e-03 1.000000e-01 + vertex -7.967794e-02 -7.171145e-03 1.000000e-01 + vertex -7.927598e-02 -1.073866e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.967131e-02 -6.271708e-03 1.000000e-01 + vertex -7.927598e-02 -1.073866e-02 1.000000e-01 + vertex -5.926130e-02 -9.386068e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.271708e-03 -5.967131e-02 1.000000e-01 + vertex -1.073866e-02 -7.927598e-02 1.000000e-01 + vertex -7.171145e-03 -7.967794e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.271708e-03 -5.967131e-02 1.000000e-01 + vertex -9.386068e-03 -5.926130e-02 1.000000e-01 + vertex -1.073866e-02 -7.927598e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.967794e-02 -7.171145e-03 1.000000e-01 + vertex 5.967131e-02 -6.271708e-03 1.000000e-01 + vertex 7.927598e-02 -1.073866e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.967794e-02 -7.171145e-03 1.000000e-01 + vertex 5.991777e-02 -3.140157e-03 1.000000e-01 + vertex 5.967131e-02 -6.271708e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.171145e-03 7.967794e-02 1.000000e-01 + vertex -1.073866e-02 7.927598e-02 1.000000e-01 + vertex -6.271708e-03 5.967131e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.171145e-03 7.967794e-02 1.000000e-01 + vertex -6.271708e-03 5.967131e-02 1.000000e-01 + vertex -3.140157e-03 5.991777e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.991777e-02 -3.140157e-03 1.000000e-01 + vertex -7.991945e-02 -3.589186e-03 1.000000e-01 + vertex -7.967794e-02 -7.171145e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.991777e-02 -3.140157e-03 1.000000e-01 + vertex -7.967794e-02 -7.171145e-03 1.000000e-01 + vertex -5.967131e-02 -6.271708e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.140157e-03 -5.991777e-02 1.000000e-01 + vertex -7.171145e-03 -7.967794e-02 1.000000e-01 + vertex -3.589186e-03 -7.991945e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.991945e-02 -3.589186e-03 1.000000e-01 + vertex 6.000000e-02 0.000000e+00 1.000000e-01 + vertex 5.991777e-02 -3.140157e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.991945e-02 -3.589186e-03 1.000000e-01 + vertex 5.991777e-02 -3.140157e-03 1.000000e-01 + vertex 7.967794e-02 -7.171145e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.589186e-03 7.991945e-02 1.000000e-01 + vertex -7.171145e-03 7.967794e-02 1.000000e-01 + vertex -3.140157e-03 5.991777e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.140157e-03 -5.991777e-02 1.000000e-01 + vertex -6.271708e-03 -5.967131e-02 1.000000e-01 + vertex -7.171145e-03 -7.967794e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.589186e-03 7.991945e-02 1.000000e-01 + vertex -3.140157e-03 5.991777e-02 1.000000e-01 + vertex 1.699662e-17 6.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.000000e-02 -4.594282e-17 1.000000e-01 + vertex -7.991945e-02 3.589186e-03 1.000000e-01 + vertex -8.000000e-02 9.797174e-18 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.000000e-02 -4.594282e-17 1.000000e-01 + vertex -8.000000e-02 9.797174e-18 1.000000e-01 + vertex -7.991945e-02 -3.589186e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.000000e-02 -4.594282e-17 1.000000e-01 + vertex -7.991945e-02 -3.589186e-03 1.000000e-01 + vertex -5.991777e-02 -3.140157e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + vertex -3.589186e-03 -7.991945e-02 1.000000e-01 + vertex -1.469576e-17 -8.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + vertex -1.469576e-17 -8.000000e-02 1.000000e-01 + vertex 3.589186e-03 -7.991945e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + vertex -3.140157e-03 -5.991777e-02 1.000000e-01 + vertex -3.589186e-03 -7.991945e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.898587e-18 8.000000e-02 1.000000e-01 + vertex -3.589186e-03 7.991945e-02 1.000000e-01 + vertex 1.699662e-17 6.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.991777e-02 3.140157e-03 1.000000e-01 + vertex -7.967794e-02 7.171145e-03 1.000000e-01 + vertex -7.991945e-02 3.589186e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.000000e-02 0.000000e+00 1.000000e-01 + vertex 6.000000e-02 0.000000e+00 1.000000e-01 + vertex 7.991945e-02 -3.589186e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.991777e-02 3.140157e-03 1.000000e-01 + vertex -7.991945e-02 3.589186e-03 1.000000e-01 + vertex -6.000000e-02 -4.594282e-17 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.140157e-03 -5.991777e-02 1.000000e-01 + vertex 3.589186e-03 -7.991945e-02 1.000000e-01 + vertex 7.171145e-03 -7.967794e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.140157e-03 -5.991777e-02 1.000000e-01 + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + vertex 3.589186e-03 -7.991945e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.967131e-02 6.271708e-03 1.000000e-01 + vertex -7.967794e-02 7.171145e-03 1.000000e-01 + vertex -5.991777e-02 3.140157e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.967131e-02 6.271708e-03 1.000000e-01 + vertex -7.927598e-02 1.073866e-02 1.000000e-01 + vertex -7.967794e-02 7.171145e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.271708e-03 -5.967131e-02 1.000000e-01 + vertex 7.171145e-03 -7.967794e-02 1.000000e-01 + vertex 1.073866e-02 -7.927598e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.271708e-03 -5.967131e-02 1.000000e-01 + vertex 3.140157e-03 -5.991777e-02 1.000000e-01 + vertex 7.171145e-03 -7.967794e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.991945e-02 3.589186e-03 1.000000e-01 + vertex 5.991777e-02 3.140157e-03 1.000000e-01 + vertex 6.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.386068e-03 -5.926130e-02 1.000000e-01 + vertex 1.073866e-02 -7.927598e-02 1.000000e-01 + vertex 1.428455e-02 -7.871437e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.991945e-02 3.589186e-03 1.000000e-01 + vertex 6.000000e-02 0.000000e+00 1.000000e-01 + vertex 8.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.386068e-03 -5.926130e-02 1.000000e-01 + vertex 6.271708e-03 -5.967131e-02 1.000000e-01 + vertex 1.073866e-02 -7.927598e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.926130e-02 9.386068e-03 1.000000e-01 + vertex -7.927598e-02 1.073866e-02 1.000000e-01 + vertex -5.967131e-02 6.271708e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.589186e-03 7.991945e-02 1.000000e-01 + vertex 1.699662e-17 6.000000e-02 1.000000e-01 + vertex 3.140157e-03 5.991777e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.926130e-02 9.386068e-03 1.000000e-01 + vertex -7.871437e-02 1.428455e-02 1.000000e-01 + vertex -7.927598e-02 1.073866e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.589186e-03 7.991945e-02 1.000000e-01 + vertex 4.898587e-18 8.000000e-02 1.000000e-01 + vertex 1.699662e-17 6.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.247470e-02 -5.868886e-02 1.000000e-01 + vertex 1.428455e-02 -7.871437e-02 1.000000e-01 + vertex 1.780167e-02 -7.799423e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.247470e-02 -5.868886e-02 1.000000e-01 + vertex 9.386068e-03 -5.926130e-02 1.000000e-01 + vertex 1.428455e-02 -7.871437e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.868886e-02 1.247470e-02 1.000000e-01 + vertex -7.871437e-02 1.428455e-02 1.000000e-01 + vertex -5.926130e-02 9.386068e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.868886e-02 1.247470e-02 1.000000e-01 + vertex -7.799423e-02 1.780167e-02 1.000000e-01 + vertex -7.871437e-02 1.428455e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.552914e-02 -5.795555e-02 1.000000e-01 + vertex 1.780167e-02 -7.799423e-02 1.000000e-01 + vertex 2.128295e-02 -7.711703e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.967794e-02 7.171145e-03 1.000000e-01 + vertex 5.967131e-02 6.271708e-03 1.000000e-01 + vertex 5.991777e-02 3.140157e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.552914e-02 -5.795555e-02 1.000000e-01 + vertex 1.247470e-02 -5.868886e-02 1.000000e-01 + vertex 1.780167e-02 -7.799423e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.795555e-02 1.552914e-02 1.000000e-01 + vertex -7.799423e-02 1.780167e-02 1.000000e-01 + vertex -5.868886e-02 1.247470e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.967794e-02 7.171145e-03 1.000000e-01 + vertex 5.991777e-02 3.140157e-03 1.000000e-01 + vertex 7.991945e-02 3.589186e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.795555e-02 1.552914e-02 1.000000e-01 + vertex -7.711703e-02 2.128295e-02 1.000000e-01 + vertex -7.799423e-02 1.780167e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + vertex 2.128295e-02 -7.711703e-02 1.000000e-01 + vertex 2.472136e-02 -7.608452e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + vertex 2.472136e-02 -7.608452e-02 1.000000e-01 + vertex 2.810999e-02 -7.489879e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.171145e-03 7.967794e-02 1.000000e-01 + vertex 3.140157e-03 5.991777e-02 1.000000e-01 + vertex 6.271708e-03 5.967131e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.171145e-03 7.967794e-02 1.000000e-01 + vertex 3.589186e-03 7.991945e-02 1.000000e-01 + vertex 3.140157e-03 5.991777e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.927598e-02 1.073866e-02 1.000000e-01 + vertex 5.967131e-02 6.271708e-03 1.000000e-01 + vertex 7.967794e-02 7.171145e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.927598e-02 1.073866e-02 1.000000e-01 + vertex 5.926130e-02 9.386068e-03 1.000000e-01 + vertex 5.967131e-02 6.271708e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + vertex 1.552914e-02 -5.795555e-02 1.000000e-01 + vertex 2.128295e-02 -7.711703e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + vertex -7.711703e-02 2.128295e-02 1.000000e-01 + vertex -5.795555e-02 1.552914e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.073866e-02 7.927598e-02 1.000000e-01 + vertex 7.171145e-03 7.967794e-02 1.000000e-01 + vertex 6.271708e-03 5.967131e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + vertex -7.489879e-02 2.810999e-02 1.000000e-01 + vertex -7.608452e-02 2.472136e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + vertex -7.608452e-02 2.472136e-02 1.000000e-01 + vertex -7.711703e-02 2.128295e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.073866e-02 7.927598e-02 1.000000e-01 + vertex 6.271708e-03 5.967131e-02 1.000000e-01 + vertex 9.386068e-03 5.926130e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.150208e-02 -5.601483e-02 1.000000e-01 + vertex 2.810999e-02 -7.489879e-02 1.000000e-01 + vertex 3.144200e-02 -7.356222e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.871437e-02 1.428455e-02 1.000000e-01 + vertex 5.868886e-02 1.247470e-02 1.000000e-01 + vertex 5.926130e-02 9.386068e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.150208e-02 -5.601483e-02 1.000000e-01 + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + vertex 2.810999e-02 -7.489879e-02 1.000000e-01 + endloop + endfacet + facet normal -7.845910e-02 9.969173e-01 0.000000e+00 + outer loop + vertex 6.271708e-03 -5.967131e-02 8.000000e-02 + vertex 3.140157e-03 -5.991777e-02 8.000000e-02 + vertex 3.140157e-03 -5.991777e-02 1.000000e-01 + endloop + endfacet + facet normal -7.845910e-02 9.969173e-01 0.000000e+00 + outer loop + vertex 6.271708e-03 -5.967131e-02 8.000000e-02 + vertex 3.140157e-03 -5.991777e-02 1.000000e-01 + vertex 6.271708e-03 -5.967131e-02 1.000000e-01 + endloop + endfacet + facet normal -1.305262e-01 9.914449e-01 0.000000e+00 + outer loop + vertex 9.386068e-03 -5.926130e-02 8.000000e-02 + vertex 6.271708e-03 -5.967131e-02 8.000000e-02 + vertex 6.271708e-03 -5.967131e-02 1.000000e-01 + endloop + endfacet + facet normal -1.305262e-01 9.914449e-01 0.000000e+00 + outer loop + vertex 9.386068e-03 -5.926130e-02 8.000000e-02 + vertex 6.271708e-03 -5.967131e-02 1.000000e-01 + vertex 9.386068e-03 -5.926130e-02 1.000000e-01 + endloop + endfacet + facet normal -9.996573e-01 -2.617695e-02 0.000000e+00 + outer loop + vertex 5.991777e-02 3.140157e-03 8.000000e-02 + vertex 6.000000e-02 0.000000e+00 1.000000e-01 + vertex 5.991777e-02 3.140157e-03 1.000000e-01 + endloop + endfacet + facet normal -9.996573e-01 -2.617695e-02 0.000000e+00 + outer loop + vertex 5.991777e-02 3.140157e-03 8.000000e-02 + vertex 6.000000e-02 0.000000e+00 8.000000e-02 + vertex 6.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal -1.822355e-01 9.832549e-01 0.000000e+00 + outer loop + vertex 1.247470e-02 -5.868886e-02 8.000000e-02 + vertex 9.386068e-03 -5.926130e-02 8.000000e-02 + vertex 9.386068e-03 -5.926130e-02 1.000000e-01 + endloop + endfacet + facet normal -1.822355e-01 9.832549e-01 0.000000e+00 + outer loop + vertex 1.247470e-02 -5.868886e-02 8.000000e-02 + vertex 9.386068e-03 -5.926130e-02 1.000000e-01 + vertex 1.247470e-02 -5.868886e-02 1.000000e-01 + endloop + endfacet + facet normal -9.969173e-01 -7.845910e-02 0.000000e+00 + outer loop + vertex 5.967131e-02 6.271708e-03 8.000000e-02 + vertex 5.991777e-02 3.140157e-03 1.000000e-01 + vertex 5.967131e-02 6.271708e-03 1.000000e-01 + endloop + endfacet + facet normal -2.334454e-01 9.723699e-01 0.000000e+00 + outer loop + vertex 1.552914e-02 -5.795555e-02 8.000000e-02 + vertex 1.247470e-02 -5.868886e-02 8.000000e-02 + vertex 1.247470e-02 -5.868886e-02 1.000000e-01 + endloop + endfacet + facet normal -9.969173e-01 -7.845910e-02 0.000000e+00 + outer loop + vertex 5.967131e-02 6.271708e-03 8.000000e-02 + vertex 5.991777e-02 3.140157e-03 8.000000e-02 + vertex 5.991777e-02 3.140157e-03 1.000000e-01 + endloop + endfacet + facet normal -2.334454e-01 9.723699e-01 0.000000e+00 + outer loop + vertex 1.552914e-02 -5.795555e-02 8.000000e-02 + vertex 1.247470e-02 -5.868886e-02 1.000000e-01 + vertex 1.552914e-02 -5.795555e-02 1.000000e-01 + endloop + endfacet + facet normal -9.914449e-01 -1.305262e-01 0.000000e+00 + outer loop + vertex 5.926130e-02 9.386068e-03 8.000000e-02 + vertex 5.967131e-02 6.271708e-03 1.000000e-01 + vertex 5.926130e-02 9.386068e-03 1.000000e-01 + endloop + endfacet + facet normal -2.840153e-01 9.588197e-01 0.000000e+00 + outer loop + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + vertex 1.552914e-02 -5.795555e-02 8.000000e-02 + vertex 1.552914e-02 -5.795555e-02 1.000000e-01 + endloop + endfacet + facet normal -9.914449e-01 -1.305262e-01 0.000000e+00 + outer loop + vertex 5.926130e-02 9.386068e-03 8.000000e-02 + vertex 5.967131e-02 6.271708e-03 8.000000e-02 + vertex 5.967131e-02 6.271708e-03 1.000000e-01 + endloop + endfacet + facet normal -2.840153e-01 9.588197e-01 0.000000e+00 + outer loop + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + vertex 1.552914e-02 -5.795555e-02 1.000000e-01 + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal -9.832549e-01 -1.822355e-01 0.000000e+00 + outer loop + vertex 5.868886e-02 1.247470e-02 8.000000e-02 + vertex 5.926130e-02 9.386068e-03 1.000000e-01 + vertex 5.868886e-02 1.247470e-02 1.000000e-01 + endloop + endfacet + facet normal -3.338069e-01 9.426415e-01 0.000000e+00 + outer loop + vertex 2.150208e-02 -5.601483e-02 8.000000e-02 + vertex 1.854102e-02 -5.706339e-02 8.000000e-02 + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal -9.832549e-01 -1.822355e-01 0.000000e+00 + outer loop + vertex 5.868886e-02 1.247470e-02 8.000000e-02 + vertex 5.926130e-02 9.386068e-03 8.000000e-02 + vertex 5.926130e-02 9.386068e-03 1.000000e-01 + endloop + endfacet + facet normal -3.338069e-01 9.426415e-01 0.000000e+00 + outer loop + vertex 2.150208e-02 -5.601483e-02 8.000000e-02 + vertex 1.854102e-02 -5.706339e-02 1.000000e-01 + vertex 2.150208e-02 -5.601483e-02 1.000000e-01 + endloop + endfacet + facet normal -3.826834e-01 9.238795e-01 0.000000e+00 + outer loop + vertex 2.440420e-02 -5.481273e-02 8.000000e-02 + vertex 2.150208e-02 -5.601483e-02 8.000000e-02 + vertex 2.150208e-02 -5.601483e-02 1.000000e-01 + endloop + endfacet + facet normal -9.723699e-01 -2.334454e-01 0.000000e+00 + outer loop + vertex 5.795555e-02 1.552914e-02 8.000000e-02 + vertex 5.868886e-02 1.247470e-02 1.000000e-01 + vertex 5.795555e-02 1.552914e-02 1.000000e-01 + endloop + endfacet + facet normal -3.826834e-01 9.238795e-01 0.000000e+00 + outer loop + vertex 2.440420e-02 -5.481273e-02 8.000000e-02 + vertex 2.150208e-02 -5.601483e-02 1.000000e-01 + vertex 2.440420e-02 -5.481273e-02 1.000000e-01 + endloop + endfacet + facet normal -9.723699e-01 -2.334454e-01 0.000000e+00 + outer loop + vertex 5.795555e-02 1.552914e-02 8.000000e-02 + vertex 5.868886e-02 1.247470e-02 8.000000e-02 + vertex 5.868886e-02 1.247470e-02 1.000000e-01 + endloop + endfacet + facet normal -4.305111e-01 9.025853e-01 0.000000e+00 + outer loop + vertex 2.723943e-02 -5.346039e-02 8.000000e-02 + vertex 2.440420e-02 -5.481273e-02 8.000000e-02 + vertex 2.440420e-02 -5.481273e-02 1.000000e-01 + endloop + endfacet + facet normal -9.588197e-01 -2.840153e-01 0.000000e+00 + outer loop + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + vertex 5.795555e-02 1.552914e-02 1.000000e-01 + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal -4.305111e-01 9.025853e-01 0.000000e+00 + outer loop + vertex 2.723943e-02 -5.346039e-02 8.000000e-02 + vertex 2.440420e-02 -5.481273e-02 1.000000e-01 + vertex 2.723943e-02 -5.346039e-02 1.000000e-01 + endloop + endfacet + facet normal -9.588197e-01 -2.840153e-01 0.000000e+00 + outer loop + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + vertex 5.795555e-02 1.552914e-02 8.000000e-02 + vertex 5.795555e-02 1.552914e-02 1.000000e-01 + endloop + endfacet + facet normal -9.426415e-01 -3.338069e-01 0.000000e+00 + outer loop + vertex 5.601483e-02 2.150208e-02 8.000000e-02 + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + vertex 5.601483e-02 2.150208e-02 1.000000e-01 + endloop + endfacet + facet normal -4.771588e-01 8.788171e-01 0.000000e+00 + outer loop + vertex 3.000000e-02 -5.196152e-02 8.000000e-02 + vertex 2.723943e-02 -5.346039e-02 8.000000e-02 + vertex 2.723943e-02 -5.346039e-02 1.000000e-01 + endloop + endfacet + facet normal -4.771588e-01 8.788171e-01 0.000000e+00 + outer loop + vertex 3.000000e-02 -5.196152e-02 8.000000e-02 + vertex 2.723943e-02 -5.346039e-02 1.000000e-01 + vertex 3.000000e-02 -5.196152e-02 1.000000e-01 + endloop + endfacet + facet normal -9.426415e-01 -3.338069e-01 0.000000e+00 + outer loop + vertex 5.601483e-02 2.150208e-02 8.000000e-02 + vertex 5.706339e-02 1.854102e-02 8.000000e-02 + vertex 5.706339e-02 1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal -5.224986e-01 8.526402e-01 0.000000e+00 + outer loop + vertex 3.267834e-02 -5.032023e-02 8.000000e-02 + vertex 3.000000e-02 -5.196152e-02 1.000000e-01 + vertex 3.267834e-02 -5.032023e-02 1.000000e-01 + endloop + endfacet + facet normal -5.224986e-01 8.526402e-01 0.000000e+00 + outer loop + vertex 3.267834e-02 -5.032023e-02 8.000000e-02 + vertex 3.000000e-02 -5.196152e-02 8.000000e-02 + vertex 3.000000e-02 -5.196152e-02 1.000000e-01 + endloop + endfacet + facet normal -9.238795e-01 -3.826834e-01 0.000000e+00 + outer loop + vertex 5.481273e-02 2.440420e-02 8.000000e-02 + vertex 5.601483e-02 2.150208e-02 1.000000e-01 + vertex 5.481273e-02 2.440420e-02 1.000000e-01 + endloop + endfacet + facet normal -9.238795e-01 -3.826834e-01 0.000000e+00 + outer loop + vertex 5.481273e-02 2.440420e-02 8.000000e-02 + vertex 5.601483e-02 2.150208e-02 8.000000e-02 + vertex 5.601483e-02 2.150208e-02 1.000000e-01 + endloop + endfacet + facet normal -5.664062e-01 8.241262e-01 0.000000e+00 + outer loop + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + vertex 3.267834e-02 -5.032023e-02 1.000000e-01 + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal -5.664062e-01 8.241262e-01 0.000000e+00 + outer loop + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + vertex 3.267834e-02 -5.032023e-02 8.000000e-02 + vertex 3.267834e-02 -5.032023e-02 1.000000e-01 + endloop + endfacet + facet normal -9.025853e-01 -4.305111e-01 0.000000e+00 + outer loop + vertex 5.346039e-02 2.723943e-02 8.000000e-02 + vertex 5.481273e-02 2.440420e-02 1.000000e-01 + vertex 5.346039e-02 2.723943e-02 1.000000e-01 + endloop + endfacet + facet normal -9.025853e-01 -4.305111e-01 0.000000e+00 + outer loop + vertex 5.346039e-02 2.723943e-02 8.000000e-02 + vertex 5.481273e-02 2.440420e-02 8.000000e-02 + vertex 5.481273e-02 2.440420e-02 1.000000e-01 + endloop + endfacet + facet normal -6.087614e-01 7.933533e-01 0.000000e+00 + outer loop + vertex 3.775922e-02 -4.662876e-02 8.000000e-02 + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + vertex 3.775922e-02 -4.662876e-02 1.000000e-01 + endloop + endfacet + facet normal -6.087614e-01 7.933533e-01 0.000000e+00 + outer loop + vertex 3.775922e-02 -4.662876e-02 8.000000e-02 + vertex 3.526712e-02 -4.854102e-02 8.000000e-02 + vertex 3.526712e-02 -4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal -8.788171e-01 -4.771588e-01 0.000000e+00 + outer loop + vertex 5.196152e-02 3.000000e-02 8.000000e-02 + vertex 5.346039e-02 2.723943e-02 1.000000e-01 + vertex 5.196152e-02 3.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -8.788171e-01 -4.771588e-01 0.000000e+00 + outer loop + vertex 5.196152e-02 3.000000e-02 8.000000e-02 + vertex 5.346039e-02 2.723943e-02 8.000000e-02 + vertex 5.346039e-02 2.723943e-02 1.000000e-01 + endloop + endfacet + facet normal -6.494480e-01 7.604060e-01 0.000000e+00 + outer loop + vertex 4.014784e-02 -4.458869e-02 8.000000e-02 + vertex 3.775922e-02 -4.662876e-02 1.000000e-01 + vertex 4.014784e-02 -4.458869e-02 1.000000e-01 + endloop + endfacet + facet normal -6.494480e-01 7.604060e-01 0.000000e+00 + outer loop + vertex 4.014784e-02 -4.458869e-02 8.000000e-02 + vertex 3.775922e-02 -4.662876e-02 8.000000e-02 + vertex 3.775922e-02 -4.662876e-02 1.000000e-01 + endloop + endfacet + facet normal -8.526402e-01 -5.224986e-01 0.000000e+00 + outer loop + vertex 5.032023e-02 3.267834e-02 8.000000e-02 + vertex 5.196152e-02 3.000000e-02 1.000000e-01 + vertex 5.032023e-02 3.267834e-02 1.000000e-01 + endloop + endfacet + facet normal -6.883546e-01 7.253744e-01 0.000000e+00 + outer loop + vertex 4.242641e-02 -4.242641e-02 8.000000e-02 + vertex 4.014784e-02 -4.458869e-02 1.000000e-01 + vertex 4.242641e-02 -4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal -8.526402e-01 -5.224986e-01 0.000000e+00 + outer loop + vertex 5.032023e-02 3.267834e-02 8.000000e-02 + vertex 5.196152e-02 3.000000e-02 8.000000e-02 + vertex 5.196152e-02 3.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -6.883546e-01 7.253744e-01 0.000000e+00 + outer loop + vertex 4.242641e-02 -4.242641e-02 8.000000e-02 + vertex 4.014784e-02 -4.458869e-02 8.000000e-02 + vertex 4.014784e-02 -4.458869e-02 1.000000e-01 + endloop + endfacet + facet normal -8.241262e-01 -5.664062e-01 0.000000e+00 + outer loop + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + vertex 5.032023e-02 3.267834e-02 1.000000e-01 + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal -7.253744e-01 6.883546e-01 0.000000e+00 + outer loop + vertex 4.458869e-02 -4.014784e-02 8.000000e-02 + vertex 4.242641e-02 -4.242641e-02 1.000000e-01 + vertex 4.458869e-02 -4.014784e-02 1.000000e-01 + endloop + endfacet + facet normal -8.241262e-01 -5.664062e-01 0.000000e+00 + outer loop + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + vertex 5.032023e-02 3.267834e-02 8.000000e-02 + vertex 5.032023e-02 3.267834e-02 1.000000e-01 + endloop + endfacet + facet normal -7.253744e-01 6.883546e-01 0.000000e+00 + outer loop + vertex 4.458869e-02 -4.014784e-02 8.000000e-02 + vertex 4.242641e-02 -4.242641e-02 8.000000e-02 + vertex 4.242641e-02 -4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal -7.604060e-01 6.494480e-01 0.000000e+00 + outer loop + vertex 4.662876e-02 -3.775922e-02 8.000000e-02 + vertex 4.458869e-02 -4.014784e-02 1.000000e-01 + vertex 4.662876e-02 -3.775922e-02 1.000000e-01 + endloop + endfacet + facet normal -7.933533e-01 -6.087614e-01 0.000000e+00 + outer loop + vertex 4.662876e-02 3.775922e-02 8.000000e-02 + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + vertex 4.662876e-02 3.775922e-02 1.000000e-01 + endloop + endfacet + facet normal -7.933533e-01 -6.087614e-01 0.000000e+00 + outer loop + vertex 4.662876e-02 3.775922e-02 8.000000e-02 + vertex 4.854102e-02 3.526712e-02 8.000000e-02 + vertex 4.854102e-02 3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal -7.604060e-01 6.494480e-01 0.000000e+00 + outer loop + vertex 4.662876e-02 -3.775922e-02 8.000000e-02 + vertex 4.458869e-02 -4.014784e-02 8.000000e-02 + vertex 4.458869e-02 -4.014784e-02 1.000000e-01 + endloop + endfacet + facet normal -7.933533e-01 6.087614e-01 0.000000e+00 + outer loop + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + vertex 4.662876e-02 -3.775922e-02 1.000000e-01 + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal -7.604060e-01 -6.494480e-01 0.000000e+00 + outer loop + vertex 4.458869e-02 4.014784e-02 8.000000e-02 + vertex 4.662876e-02 3.775922e-02 8.000000e-02 + vertex 4.662876e-02 3.775922e-02 1.000000e-01 + endloop + endfacet + facet normal -7.604060e-01 -6.494480e-01 0.000000e+00 + outer loop + vertex 4.458869e-02 4.014784e-02 8.000000e-02 + vertex 4.662876e-02 3.775922e-02 1.000000e-01 + vertex 4.458869e-02 4.014784e-02 1.000000e-01 + endloop + endfacet + facet normal -7.933533e-01 6.087614e-01 0.000000e+00 + outer loop + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + vertex 4.662876e-02 -3.775922e-02 8.000000e-02 + vertex 4.662876e-02 -3.775922e-02 1.000000e-01 + endloop + endfacet + facet normal -8.241262e-01 5.664062e-01 0.000000e+00 + outer loop + vertex 5.032023e-02 -3.267834e-02 8.000000e-02 + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + vertex 5.032023e-02 -3.267834e-02 1.000000e-01 + endloop + endfacet + facet normal -7.253744e-01 -6.883546e-01 0.000000e+00 + outer loop + vertex 4.242641e-02 4.242641e-02 8.000000e-02 + vertex 4.458869e-02 4.014784e-02 8.000000e-02 + vertex 4.458869e-02 4.014784e-02 1.000000e-01 + endloop + endfacet + facet normal -8.241262e-01 5.664062e-01 0.000000e+00 + outer loop + vertex 5.032023e-02 -3.267834e-02 8.000000e-02 + vertex 4.854102e-02 -3.526712e-02 8.000000e-02 + vertex 4.854102e-02 -3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal -7.253744e-01 -6.883546e-01 0.000000e+00 + outer loop + vertex 4.242641e-02 4.242641e-02 8.000000e-02 + vertex 4.458869e-02 4.014784e-02 1.000000e-01 + vertex 4.242641e-02 4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal -8.526402e-01 5.224986e-01 0.000000e+00 + outer loop + vertex 5.196152e-02 -3.000000e-02 8.000000e-02 + vertex 5.032023e-02 -3.267834e-02 1.000000e-01 + vertex 5.196152e-02 -3.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -8.526402e-01 5.224986e-01 0.000000e+00 + outer loop + vertex 5.196152e-02 -3.000000e-02 8.000000e-02 + vertex 5.032023e-02 -3.267834e-02 8.000000e-02 + vertex 5.032023e-02 -3.267834e-02 1.000000e-01 + endloop + endfacet + facet normal -6.883546e-01 -7.253744e-01 0.000000e+00 + outer loop + vertex 4.014784e-02 4.458869e-02 8.000000e-02 + vertex 4.242641e-02 4.242641e-02 8.000000e-02 + vertex 4.242641e-02 4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal -6.883546e-01 -7.253744e-01 0.000000e+00 + outer loop + vertex 4.014784e-02 4.458869e-02 8.000000e-02 + vertex 4.242641e-02 4.242641e-02 1.000000e-01 + vertex 4.014784e-02 4.458869e-02 1.000000e-01 + endloop + endfacet + facet normal -8.788171e-01 4.771588e-01 0.000000e+00 + outer loop + vertex 5.346039e-02 -2.723943e-02 8.000000e-02 + vertex 5.196152e-02 -3.000000e-02 1.000000e-01 + vertex 5.346039e-02 -2.723943e-02 1.000000e-01 + endloop + endfacet + facet normal -8.788171e-01 4.771588e-01 0.000000e+00 + outer loop + vertex 5.346039e-02 -2.723943e-02 8.000000e-02 + vertex 5.196152e-02 -3.000000e-02 8.000000e-02 + vertex 5.196152e-02 -3.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -6.494480e-01 -7.604060e-01 0.000000e+00 + outer loop + vertex 3.775922e-02 4.662876e-02 8.000000e-02 + vertex 4.014784e-02 4.458869e-02 8.000000e-02 + vertex 4.014784e-02 4.458869e-02 1.000000e-01 + endloop + endfacet + facet normal -6.494480e-01 -7.604060e-01 0.000000e+00 + outer loop + vertex 3.775922e-02 4.662876e-02 8.000000e-02 + vertex 4.014784e-02 4.458869e-02 1.000000e-01 + vertex 3.775922e-02 4.662876e-02 1.000000e-01 + endloop + endfacet + facet normal -9.025853e-01 4.305111e-01 0.000000e+00 + outer loop + vertex 5.481273e-02 -2.440420e-02 8.000000e-02 + vertex 5.346039e-02 -2.723943e-02 1.000000e-01 + vertex 5.481273e-02 -2.440420e-02 1.000000e-01 + endloop + endfacet + facet normal -9.025853e-01 4.305111e-01 0.000000e+00 + outer loop + vertex 5.481273e-02 -2.440420e-02 8.000000e-02 + vertex 5.346039e-02 -2.723943e-02 8.000000e-02 + vertex 5.346039e-02 -2.723943e-02 1.000000e-01 + endloop + endfacet + facet normal -6.087614e-01 -7.933533e-01 0.000000e+00 + outer loop + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + vertex 3.775922e-02 4.662876e-02 1.000000e-01 + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal -6.087614e-01 -7.933533e-01 0.000000e+00 + outer loop + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + vertex 3.775922e-02 4.662876e-02 8.000000e-02 + vertex 3.775922e-02 4.662876e-02 1.000000e-01 + endloop + endfacet + facet normal -9.238795e-01 3.826834e-01 0.000000e+00 + outer loop + vertex 5.601483e-02 -2.150208e-02 8.000000e-02 + vertex 5.481273e-02 -2.440420e-02 1.000000e-01 + vertex 5.601483e-02 -2.150208e-02 1.000000e-01 + endloop + endfacet + facet normal -9.238795e-01 3.826834e-01 0.000000e+00 + outer loop + vertex 5.601483e-02 -2.150208e-02 8.000000e-02 + vertex 5.481273e-02 -2.440420e-02 8.000000e-02 + vertex 5.481273e-02 -2.440420e-02 1.000000e-01 + endloop + endfacet + facet normal -5.664062e-01 -8.241262e-01 0.000000e+00 + outer loop + vertex 3.267834e-02 5.032023e-02 8.000000e-02 + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + vertex 3.267834e-02 5.032023e-02 1.000000e-01 + endloop + endfacet + facet normal -5.664062e-01 -8.241262e-01 0.000000e+00 + outer loop + vertex 3.267834e-02 5.032023e-02 8.000000e-02 + vertex 3.526712e-02 4.854102e-02 8.000000e-02 + vertex 3.526712e-02 4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal -9.426415e-01 3.338069e-01 0.000000e+00 + outer loop + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + vertex 5.601483e-02 -2.150208e-02 1.000000e-01 + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal -9.426415e-01 3.338069e-01 0.000000e+00 + outer loop + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + vertex 5.601483e-02 -2.150208e-02 8.000000e-02 + vertex 5.601483e-02 -2.150208e-02 1.000000e-01 + endloop + endfacet + facet normal -5.224986e-01 -8.526402e-01 0.000000e+00 + outer loop + vertex 3.000000e-02 5.196152e-02 8.000000e-02 + vertex 3.267834e-02 5.032023e-02 1.000000e-01 + vertex 3.000000e-02 5.196152e-02 1.000000e-01 + endloop + endfacet + facet normal -5.224986e-01 -8.526402e-01 0.000000e+00 + outer loop + vertex 3.000000e-02 5.196152e-02 8.000000e-02 + vertex 3.267834e-02 5.032023e-02 8.000000e-02 + vertex 3.267834e-02 5.032023e-02 1.000000e-01 + endloop + endfacet + facet normal -9.588197e-01 2.840153e-01 0.000000e+00 + outer loop + vertex 5.795555e-02 -1.552914e-02 8.000000e-02 + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + vertex 5.795555e-02 -1.552914e-02 1.000000e-01 + endloop + endfacet + facet normal -9.588197e-01 2.840153e-01 0.000000e+00 + outer loop + vertex 5.795555e-02 -1.552914e-02 8.000000e-02 + vertex 5.706339e-02 -1.854102e-02 8.000000e-02 + vertex 5.706339e-02 -1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal -4.771588e-01 -8.788171e-01 0.000000e+00 + outer loop + vertex 2.723943e-02 5.346039e-02 8.000000e-02 + vertex 3.000000e-02 5.196152e-02 1.000000e-01 + vertex 2.723943e-02 5.346039e-02 1.000000e-01 + endloop + endfacet + facet normal -9.723699e-01 2.334454e-01 0.000000e+00 + outer loop + vertex 5.868886e-02 -1.247470e-02 8.000000e-02 + vertex 5.795555e-02 -1.552914e-02 8.000000e-02 + vertex 5.795555e-02 -1.552914e-02 1.000000e-01 + endloop + endfacet + facet normal -4.771588e-01 -8.788171e-01 0.000000e+00 + outer loop + vertex 2.723943e-02 5.346039e-02 8.000000e-02 + vertex 3.000000e-02 5.196152e-02 8.000000e-02 + vertex 3.000000e-02 5.196152e-02 1.000000e-01 + endloop + endfacet + facet normal -9.723699e-01 2.334454e-01 0.000000e+00 + outer loop + vertex 5.868886e-02 -1.247470e-02 8.000000e-02 + vertex 5.795555e-02 -1.552914e-02 1.000000e-01 + vertex 5.868886e-02 -1.247470e-02 1.000000e-01 + endloop + endfacet + facet normal -4.305111e-01 -9.025853e-01 0.000000e+00 + outer loop + vertex 2.440420e-02 5.481273e-02 8.000000e-02 + vertex 2.723943e-02 5.346039e-02 1.000000e-01 + vertex 2.440420e-02 5.481273e-02 1.000000e-01 + endloop + endfacet + facet normal -9.832549e-01 1.822355e-01 0.000000e+00 + outer loop + vertex 5.926130e-02 -9.386068e-03 8.000000e-02 + vertex 5.868886e-02 -1.247470e-02 8.000000e-02 + vertex 5.868886e-02 -1.247470e-02 1.000000e-01 + endloop + endfacet + facet normal -4.305111e-01 -9.025853e-01 0.000000e+00 + outer loop + vertex 2.440420e-02 5.481273e-02 8.000000e-02 + vertex 2.723943e-02 5.346039e-02 8.000000e-02 + vertex 2.723943e-02 5.346039e-02 1.000000e-01 + endloop + endfacet + facet normal -9.832549e-01 1.822355e-01 0.000000e+00 + outer loop + vertex 5.926130e-02 -9.386068e-03 8.000000e-02 + vertex 5.868886e-02 -1.247470e-02 1.000000e-01 + vertex 5.926130e-02 -9.386068e-03 1.000000e-01 + endloop + endfacet + facet normal -3.826834e-01 -9.238795e-01 0.000000e+00 + outer loop + vertex 2.150208e-02 5.601483e-02 8.000000e-02 + vertex 2.440420e-02 5.481273e-02 1.000000e-01 + vertex 2.150208e-02 5.601483e-02 1.000000e-01 + endloop + endfacet + facet normal -9.914449e-01 1.305262e-01 0.000000e+00 + outer loop + vertex 5.967131e-02 -6.271708e-03 8.000000e-02 + vertex 5.926130e-02 -9.386068e-03 8.000000e-02 + vertex 5.926130e-02 -9.386068e-03 1.000000e-01 + endloop + endfacet + facet normal -3.826834e-01 -9.238795e-01 0.000000e+00 + outer loop + vertex 2.150208e-02 5.601483e-02 8.000000e-02 + vertex 2.440420e-02 5.481273e-02 8.000000e-02 + vertex 2.440420e-02 5.481273e-02 1.000000e-01 + endloop + endfacet + facet normal -9.914449e-01 1.305262e-01 0.000000e+00 + outer loop + vertex 5.967131e-02 -6.271708e-03 8.000000e-02 + vertex 5.926130e-02 -9.386068e-03 1.000000e-01 + vertex 5.967131e-02 -6.271708e-03 1.000000e-01 + endloop + endfacet + facet normal -9.969173e-01 7.845910e-02 0.000000e+00 + outer loop + vertex 5.991777e-02 -3.140157e-03 8.000000e-02 + vertex 5.967131e-02 -6.271708e-03 1.000000e-01 + vertex 5.991777e-02 -3.140157e-03 1.000000e-01 + endloop + endfacet + facet normal -9.969173e-01 7.845910e-02 0.000000e+00 + outer loop + vertex 5.991777e-02 -3.140157e-03 8.000000e-02 + vertex 5.967131e-02 -6.271708e-03 8.000000e-02 + vertex 5.967131e-02 -6.271708e-03 1.000000e-01 + endloop + endfacet + facet normal -3.338069e-01 -9.426415e-01 0.000000e+00 + outer loop + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + vertex 2.150208e-02 5.601483e-02 1.000000e-01 + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal -3.338069e-01 -9.426415e-01 0.000000e+00 + outer loop + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + vertex 2.150208e-02 5.601483e-02 8.000000e-02 + vertex 2.150208e-02 5.601483e-02 1.000000e-01 + endloop + endfacet + facet normal -9.996573e-01 2.617695e-02 0.000000e+00 + outer loop + vertex 6.000000e-02 0.000000e+00 8.000000e-02 + vertex 5.991777e-02 -3.140157e-03 1.000000e-01 + vertex 6.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal -9.996573e-01 2.617695e-02 0.000000e+00 + outer loop + vertex 6.000000e-02 0.000000e+00 8.000000e-02 + vertex 5.991777e-02 -3.140157e-03 8.000000e-02 + vertex 5.991777e-02 -3.140157e-03 1.000000e-01 + endloop + endfacet + facet normal -2.840153e-01 -9.588197e-01 0.000000e+00 + outer loop + vertex 1.552914e-02 5.795555e-02 8.000000e-02 + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + vertex 1.552914e-02 5.795555e-02 1.000000e-01 + endloop + endfacet + facet normal -2.840153e-01 -9.588197e-01 0.000000e+00 + outer loop + vertex 1.552914e-02 5.795555e-02 8.000000e-02 + vertex 1.854102e-02 5.706339e-02 8.000000e-02 + vertex 1.854102e-02 5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal -2.334454e-01 -9.723699e-01 0.000000e+00 + outer loop + vertex 1.247470e-02 5.868886e-02 8.000000e-02 + vertex 1.552914e-02 5.795555e-02 1.000000e-01 + vertex 1.247470e-02 5.868886e-02 1.000000e-01 + endloop + endfacet + facet normal -2.334454e-01 -9.723699e-01 0.000000e+00 + outer loop + vertex 1.247470e-02 5.868886e-02 8.000000e-02 + vertex 1.552914e-02 5.795555e-02 8.000000e-02 + vertex 1.552914e-02 5.795555e-02 1.000000e-01 + endloop + endfacet + facet normal -1.822355e-01 -9.832549e-01 0.000000e+00 + outer loop + vertex 9.386068e-03 5.926130e-02 8.000000e-02 + vertex 1.247470e-02 5.868886e-02 1.000000e-01 + vertex 9.386068e-03 5.926130e-02 1.000000e-01 + endloop + endfacet + facet normal -1.822355e-01 -9.832549e-01 0.000000e+00 + outer loop + vertex 9.386068e-03 5.926130e-02 8.000000e-02 + vertex 1.247470e-02 5.868886e-02 8.000000e-02 + vertex 1.247470e-02 5.868886e-02 1.000000e-01 + endloop + endfacet + facet normal -1.305262e-01 -9.914449e-01 0.000000e+00 + outer loop + vertex 6.271708e-03 5.967131e-02 8.000000e-02 + vertex 9.386068e-03 5.926130e-02 1.000000e-01 + vertex 6.271708e-03 5.967131e-02 1.000000e-01 + endloop + endfacet + facet normal -1.305262e-01 -9.914449e-01 0.000000e+00 + outer loop + vertex 6.271708e-03 5.967131e-02 8.000000e-02 + vertex 9.386068e-03 5.926130e-02 8.000000e-02 + vertex 9.386068e-03 5.926130e-02 1.000000e-01 + endloop + endfacet + facet normal -7.845910e-02 -9.969173e-01 0.000000e+00 + outer loop + vertex 3.140157e-03 5.991777e-02 8.000000e-02 + vertex 6.271708e-03 5.967131e-02 1.000000e-01 + vertex 3.140157e-03 5.991777e-02 1.000000e-01 + endloop + endfacet + facet normal -7.845910e-02 -9.969173e-01 0.000000e+00 + outer loop + vertex 3.140157e-03 5.991777e-02 8.000000e-02 + vertex 6.271708e-03 5.967131e-02 8.000000e-02 + vertex 6.271708e-03 5.967131e-02 1.000000e-01 + endloop + endfacet + facet normal -2.617695e-02 -9.996573e-01 0.000000e+00 + outer loop + vertex 1.699662e-17 6.000000e-02 8.000000e-02 + vertex 3.140157e-03 5.991777e-02 1.000000e-01 + vertex 1.699662e-17 6.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -2.617695e-02 -9.996573e-01 0.000000e+00 + outer loop + vertex 1.699662e-17 6.000000e-02 8.000000e-02 + vertex 3.140157e-03 5.991777e-02 8.000000e-02 + vertex 3.140157e-03 5.991777e-02 1.000000e-01 + endloop + endfacet + facet normal 2.617695e-02 -9.996573e-01 0.000000e+00 + outer loop + vertex -3.140157e-03 5.991777e-02 8.000000e-02 + vertex 1.699662e-17 6.000000e-02 1.000000e-01 + vertex -3.140157e-03 5.991777e-02 1.000000e-01 + endloop + endfacet + facet normal 2.617695e-02 -9.996573e-01 0.000000e+00 + outer loop + vertex -3.140157e-03 5.991777e-02 8.000000e-02 + vertex 1.699662e-17 6.000000e-02 8.000000e-02 + vertex 1.699662e-17 6.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 7.845910e-02 -9.969173e-01 0.000000e+00 + outer loop + vertex -6.271708e-03 5.967131e-02 8.000000e-02 + vertex -3.140157e-03 5.991777e-02 1.000000e-01 + vertex -6.271708e-03 5.967131e-02 1.000000e-01 + endloop + endfacet + facet normal 7.845910e-02 -9.969173e-01 0.000000e+00 + outer loop + vertex -6.271708e-03 5.967131e-02 8.000000e-02 + vertex -3.140157e-03 5.991777e-02 8.000000e-02 + vertex -3.140157e-03 5.991777e-02 1.000000e-01 + endloop + endfacet + facet normal 1.305262e-01 -9.914449e-01 0.000000e+00 + outer loop + vertex -9.386068e-03 5.926130e-02 8.000000e-02 + vertex -6.271708e-03 5.967131e-02 1.000000e-01 + vertex -9.386068e-03 5.926130e-02 1.000000e-01 + endloop + endfacet + facet normal 1.305262e-01 -9.914449e-01 0.000000e+00 + outer loop + vertex -9.386068e-03 5.926130e-02 8.000000e-02 + vertex -6.271708e-03 5.967131e-02 8.000000e-02 + vertex -6.271708e-03 5.967131e-02 1.000000e-01 + endloop + endfacet + facet normal 1.822355e-01 -9.832549e-01 0.000000e+00 + outer loop + vertex -1.247470e-02 5.868886e-02 8.000000e-02 + vertex -9.386068e-03 5.926130e-02 1.000000e-01 + vertex -1.247470e-02 5.868886e-02 1.000000e-01 + endloop + endfacet + facet normal 1.822355e-01 -9.832549e-01 0.000000e+00 + outer loop + vertex -1.247470e-02 5.868886e-02 8.000000e-02 + vertex -9.386068e-03 5.926130e-02 8.000000e-02 + vertex -9.386068e-03 5.926130e-02 1.000000e-01 + endloop + endfacet + facet normal 2.334454e-01 -9.723699e-01 0.000000e+00 + outer loop + vertex -1.552914e-02 5.795555e-02 8.000000e-02 + vertex -1.247470e-02 5.868886e-02 1.000000e-01 + vertex -1.552914e-02 5.795555e-02 1.000000e-01 + endloop + endfacet + facet normal 2.334454e-01 -9.723699e-01 0.000000e+00 + outer loop + vertex -1.552914e-02 5.795555e-02 8.000000e-02 + vertex -1.247470e-02 5.868886e-02 8.000000e-02 + vertex -1.247470e-02 5.868886e-02 1.000000e-01 + endloop + endfacet + facet normal 2.840153e-01 -9.588197e-01 0.000000e+00 + outer loop + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + vertex -1.552914e-02 5.795555e-02 1.000000e-01 + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal 2.840153e-01 -9.588197e-01 0.000000e+00 + outer loop + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + vertex -1.552914e-02 5.795555e-02 8.000000e-02 + vertex -1.552914e-02 5.795555e-02 1.000000e-01 + endloop + endfacet + facet normal 3.338069e-01 -9.426415e-01 0.000000e+00 + outer loop + vertex -2.150208e-02 5.601483e-02 8.000000e-02 + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + vertex -2.150208e-02 5.601483e-02 1.000000e-01 + endloop + endfacet + facet normal 3.338069e-01 -9.426415e-01 0.000000e+00 + outer loop + vertex -2.150208e-02 5.601483e-02 8.000000e-02 + vertex -1.854102e-02 5.706339e-02 8.000000e-02 + vertex -1.854102e-02 5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal 3.826834e-01 -9.238795e-01 0.000000e+00 + outer loop + vertex -2.440420e-02 5.481273e-02 8.000000e-02 + vertex -2.150208e-02 5.601483e-02 1.000000e-01 + vertex -2.440420e-02 5.481273e-02 1.000000e-01 + endloop + endfacet + facet normal 3.826834e-01 -9.238795e-01 0.000000e+00 + outer loop + vertex -2.440420e-02 5.481273e-02 8.000000e-02 + vertex -2.150208e-02 5.601483e-02 8.000000e-02 + vertex -2.150208e-02 5.601483e-02 1.000000e-01 + endloop + endfacet + facet normal 4.305111e-01 -9.025853e-01 0.000000e+00 + outer loop + vertex -2.723943e-02 5.346039e-02 8.000000e-02 + vertex -2.440420e-02 5.481273e-02 1.000000e-01 + vertex -2.723943e-02 5.346039e-02 1.000000e-01 + endloop + endfacet + facet normal 4.305111e-01 -9.025853e-01 0.000000e+00 + outer loop + vertex -2.723943e-02 5.346039e-02 8.000000e-02 + vertex -2.440420e-02 5.481273e-02 8.000000e-02 + vertex -2.440420e-02 5.481273e-02 1.000000e-01 + endloop + endfacet + facet normal 4.771588e-01 -8.788171e-01 0.000000e+00 + outer loop + vertex -3.000000e-02 5.196152e-02 8.000000e-02 + vertex -2.723943e-02 5.346039e-02 8.000000e-02 + vertex -2.723943e-02 5.346039e-02 1.000000e-01 + endloop + endfacet + facet normal 4.771588e-01 -8.788171e-01 0.000000e+00 + outer loop + vertex -3.000000e-02 5.196152e-02 8.000000e-02 + vertex -2.723943e-02 5.346039e-02 1.000000e-01 + vertex -3.000000e-02 5.196152e-02 1.000000e-01 + endloop + endfacet + facet normal 5.224986e-01 -8.526402e-01 0.000000e+00 + outer loop + vertex -3.267834e-02 5.032023e-02 8.000000e-02 + vertex -3.000000e-02 5.196152e-02 8.000000e-02 + vertex -3.000000e-02 5.196152e-02 1.000000e-01 + endloop + endfacet + facet normal 5.224986e-01 -8.526402e-01 0.000000e+00 + outer loop + vertex -3.267834e-02 5.032023e-02 8.000000e-02 + vertex -3.000000e-02 5.196152e-02 1.000000e-01 + vertex -3.267834e-02 5.032023e-02 1.000000e-01 + endloop + endfacet + facet normal 5.664062e-01 -8.241262e-01 0.000000e+00 + outer loop + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + vertex -3.267834e-02 5.032023e-02 8.000000e-02 + vertex -3.267834e-02 5.032023e-02 1.000000e-01 + endloop + endfacet + facet normal 5.664062e-01 -8.241262e-01 0.000000e+00 + outer loop + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + vertex -3.267834e-02 5.032023e-02 1.000000e-01 + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 6.087614e-01 -7.933533e-01 0.000000e+00 + outer loop + vertex -3.775922e-02 4.662876e-02 8.000000e-02 + vertex -3.526712e-02 4.854102e-02 8.000000e-02 + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 6.087614e-01 -7.933533e-01 0.000000e+00 + outer loop + vertex -3.775922e-02 4.662876e-02 8.000000e-02 + vertex -3.526712e-02 4.854102e-02 1.000000e-01 + vertex -3.775922e-02 4.662876e-02 1.000000e-01 + endloop + endfacet + facet normal 6.494480e-01 -7.604060e-01 0.000000e+00 + outer loop + vertex -4.014784e-02 4.458869e-02 8.000000e-02 + vertex -3.775922e-02 4.662876e-02 8.000000e-02 + vertex -3.775922e-02 4.662876e-02 1.000000e-01 + endloop + endfacet + facet normal 6.494480e-01 -7.604060e-01 0.000000e+00 + outer loop + vertex -4.014784e-02 4.458869e-02 8.000000e-02 + vertex -3.775922e-02 4.662876e-02 1.000000e-01 + vertex -4.014784e-02 4.458869e-02 1.000000e-01 + endloop + endfacet + facet normal 6.883546e-01 -7.253744e-01 0.000000e+00 + outer loop + vertex -4.242641e-02 4.242641e-02 8.000000e-02 + vertex -4.014784e-02 4.458869e-02 8.000000e-02 + vertex -4.014784e-02 4.458869e-02 1.000000e-01 + endloop + endfacet + facet normal 6.883546e-01 -7.253744e-01 0.000000e+00 + outer loop + vertex -4.242641e-02 4.242641e-02 8.000000e-02 + vertex -4.014784e-02 4.458869e-02 1.000000e-01 + vertex -4.242641e-02 4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal 7.253744e-01 -6.883546e-01 0.000000e+00 + outer loop + vertex -4.458869e-02 4.014784e-02 8.000000e-02 + vertex -4.242641e-02 4.242641e-02 8.000000e-02 + vertex -4.242641e-02 4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal 7.253744e-01 -6.883546e-01 0.000000e+00 + outer loop + vertex -4.458869e-02 4.014784e-02 8.000000e-02 + vertex -4.242641e-02 4.242641e-02 1.000000e-01 + vertex -4.458869e-02 4.014784e-02 1.000000e-01 + endloop + endfacet + facet normal 7.604060e-01 -6.494480e-01 0.000000e+00 + outer loop + vertex -4.662876e-02 3.775922e-02 8.000000e-02 + vertex -4.458869e-02 4.014784e-02 8.000000e-02 + vertex -4.458869e-02 4.014784e-02 1.000000e-01 + endloop + endfacet + facet normal 7.604060e-01 -6.494480e-01 0.000000e+00 + outer loop + vertex -4.662876e-02 3.775922e-02 8.000000e-02 + vertex -4.458869e-02 4.014784e-02 1.000000e-01 + vertex -4.662876e-02 3.775922e-02 1.000000e-01 + endloop + endfacet + facet normal 7.933533e-01 -6.087614e-01 0.000000e+00 + outer loop + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + vertex -4.662876e-02 3.775922e-02 8.000000e-02 + vertex -4.662876e-02 3.775922e-02 1.000000e-01 + endloop + endfacet + facet normal 7.933533e-01 -6.087614e-01 0.000000e+00 + outer loop + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + vertex -4.662876e-02 3.775922e-02 1.000000e-01 + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal 8.241262e-01 -5.664062e-01 0.000000e+00 + outer loop + vertex -5.032023e-02 3.267834e-02 8.000000e-02 + vertex -4.854102e-02 3.526712e-02 8.000000e-02 + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal 8.241262e-01 -5.664062e-01 0.000000e+00 + outer loop + vertex -5.032023e-02 3.267834e-02 8.000000e-02 + vertex -4.854102e-02 3.526712e-02 1.000000e-01 + vertex -5.032023e-02 3.267834e-02 1.000000e-01 + endloop + endfacet + facet normal 8.526402e-01 -5.224986e-01 0.000000e+00 + outer loop + vertex -5.196152e-02 3.000000e-02 8.000000e-02 + vertex -5.032023e-02 3.267834e-02 8.000000e-02 + vertex -5.032023e-02 3.267834e-02 1.000000e-01 + endloop + endfacet + facet normal 8.526402e-01 -5.224986e-01 0.000000e+00 + outer loop + vertex -5.196152e-02 3.000000e-02 8.000000e-02 + vertex -5.032023e-02 3.267834e-02 1.000000e-01 + vertex -5.196152e-02 3.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 8.788171e-01 -4.771588e-01 0.000000e+00 + outer loop + vertex -5.346039e-02 2.723943e-02 8.000000e-02 + vertex -5.196152e-02 3.000000e-02 8.000000e-02 + vertex -5.196152e-02 3.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 8.788171e-01 -4.771588e-01 0.000000e+00 + outer loop + vertex -5.346039e-02 2.723943e-02 8.000000e-02 + vertex -5.196152e-02 3.000000e-02 1.000000e-01 + vertex -5.346039e-02 2.723943e-02 1.000000e-01 + endloop + endfacet + facet normal 9.025853e-01 -4.305111e-01 0.000000e+00 + outer loop + vertex -5.481273e-02 2.440420e-02 8.000000e-02 + vertex -5.346039e-02 2.723943e-02 1.000000e-01 + vertex -5.481273e-02 2.440420e-02 1.000000e-01 + endloop + endfacet + facet normal 9.025853e-01 -4.305111e-01 0.000000e+00 + outer loop + vertex -5.481273e-02 2.440420e-02 8.000000e-02 + vertex -5.346039e-02 2.723943e-02 8.000000e-02 + vertex -5.346039e-02 2.723943e-02 1.000000e-01 + endloop + endfacet + facet normal 9.238795e-01 -3.826834e-01 0.000000e+00 + outer loop + vertex -5.601483e-02 2.150208e-02 8.000000e-02 + vertex -5.481273e-02 2.440420e-02 1.000000e-01 + vertex -5.601483e-02 2.150208e-02 1.000000e-01 + endloop + endfacet + facet normal 9.238795e-01 -3.826834e-01 0.000000e+00 + outer loop + vertex -5.601483e-02 2.150208e-02 8.000000e-02 + vertex -5.481273e-02 2.440420e-02 8.000000e-02 + vertex -5.481273e-02 2.440420e-02 1.000000e-01 + endloop + endfacet + facet normal 9.426415e-01 -3.338069e-01 0.000000e+00 + outer loop + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + vertex -5.601483e-02 2.150208e-02 1.000000e-01 + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 9.426415e-01 -3.338069e-01 0.000000e+00 + outer loop + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + vertex -5.601483e-02 2.150208e-02 8.000000e-02 + vertex -5.601483e-02 2.150208e-02 1.000000e-01 + endloop + endfacet + facet normal 9.588197e-01 -2.840153e-01 0.000000e+00 + outer loop + vertex -5.795555e-02 1.552914e-02 8.000000e-02 + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + vertex -5.795555e-02 1.552914e-02 1.000000e-01 + endloop + endfacet + facet normal 9.588197e-01 -2.840153e-01 0.000000e+00 + outer loop + vertex -5.795555e-02 1.552914e-02 8.000000e-02 + vertex -5.706339e-02 1.854102e-02 8.000000e-02 + vertex -5.706339e-02 1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 9.723699e-01 -2.334454e-01 0.000000e+00 + outer loop + vertex -5.868886e-02 1.247470e-02 8.000000e-02 + vertex -5.795555e-02 1.552914e-02 1.000000e-01 + vertex -5.868886e-02 1.247470e-02 1.000000e-01 + endloop + endfacet + facet normal 9.723699e-01 -2.334454e-01 0.000000e+00 + outer loop + vertex -5.868886e-02 1.247470e-02 8.000000e-02 + vertex -5.795555e-02 1.552914e-02 8.000000e-02 + vertex -5.795555e-02 1.552914e-02 1.000000e-01 + endloop + endfacet + facet normal 9.832549e-01 -1.822355e-01 0.000000e+00 + outer loop + vertex -5.926130e-02 9.386068e-03 8.000000e-02 + vertex -5.868886e-02 1.247470e-02 1.000000e-01 + vertex -5.926130e-02 9.386068e-03 1.000000e-01 + endloop + endfacet + facet normal 9.832549e-01 -1.822355e-01 0.000000e+00 + outer loop + vertex -5.926130e-02 9.386068e-03 8.000000e-02 + vertex -5.868886e-02 1.247470e-02 8.000000e-02 + vertex -5.868886e-02 1.247470e-02 1.000000e-01 + endloop + endfacet + facet normal 9.914449e-01 -1.305262e-01 0.000000e+00 + outer loop + vertex -5.967131e-02 6.271708e-03 8.000000e-02 + vertex -5.926130e-02 9.386068e-03 1.000000e-01 + vertex -5.967131e-02 6.271708e-03 1.000000e-01 + endloop + endfacet + facet normal 9.914449e-01 -1.305262e-01 0.000000e+00 + outer loop + vertex -5.967131e-02 6.271708e-03 8.000000e-02 + vertex -5.926130e-02 9.386068e-03 8.000000e-02 + vertex -5.926130e-02 9.386068e-03 1.000000e-01 + endloop + endfacet + facet normal 9.969173e-01 -7.845910e-02 0.000000e+00 + outer loop + vertex -5.991777e-02 3.140157e-03 8.000000e-02 + vertex -5.967131e-02 6.271708e-03 1.000000e-01 + vertex -5.991777e-02 3.140157e-03 1.000000e-01 + endloop + endfacet + facet normal 9.969173e-01 -7.845910e-02 0.000000e+00 + outer loop + vertex -5.991777e-02 3.140157e-03 8.000000e-02 + vertex -5.967131e-02 6.271708e-03 8.000000e-02 + vertex -5.967131e-02 6.271708e-03 1.000000e-01 + endloop + endfacet + facet normal 9.996573e-01 -2.617695e-02 0.000000e+00 + outer loop + vertex -6.000000e-02 -4.594282e-17 8.000000e-02 + vertex -5.991777e-02 3.140157e-03 1.000000e-01 + vertex -6.000000e-02 -4.594282e-17 1.000000e-01 + endloop + endfacet + facet normal 9.996573e-01 -2.617695e-02 0.000000e+00 + outer loop + vertex -6.000000e-02 -4.594282e-17 8.000000e-02 + vertex -5.991777e-02 3.140157e-03 8.000000e-02 + vertex -5.991777e-02 3.140157e-03 1.000000e-01 + endloop + endfacet + facet normal 9.996573e-01 2.617695e-02 0.000000e+00 + outer loop + vertex -5.991777e-02 -3.140157e-03 8.000000e-02 + vertex -6.000000e-02 -4.594282e-17 1.000000e-01 + vertex -5.991777e-02 -3.140157e-03 1.000000e-01 + endloop + endfacet + facet normal 9.996573e-01 2.617695e-02 -0.000000e+00 + outer loop + vertex -5.991777e-02 -3.140157e-03 8.000000e-02 + vertex -6.000000e-02 -4.594282e-17 8.000000e-02 + vertex -6.000000e-02 -4.594282e-17 1.000000e-01 + endloop + endfacet + facet normal 9.969173e-01 7.845910e-02 0.000000e+00 + outer loop + vertex -5.967131e-02 -6.271708e-03 8.000000e-02 + vertex -5.991777e-02 -3.140157e-03 1.000000e-01 + vertex -5.967131e-02 -6.271708e-03 1.000000e-01 + endloop + endfacet + facet normal 9.969173e-01 7.845910e-02 -0.000000e+00 + outer loop + vertex -5.967131e-02 -6.271708e-03 8.000000e-02 + vertex -5.991777e-02 -3.140157e-03 8.000000e-02 + vertex -5.991777e-02 -3.140157e-03 1.000000e-01 + endloop + endfacet + facet normal 9.914449e-01 1.305262e-01 0.000000e+00 + outer loop + vertex -5.926130e-02 -9.386068e-03 8.000000e-02 + vertex -5.967131e-02 -6.271708e-03 1.000000e-01 + vertex -5.926130e-02 -9.386068e-03 1.000000e-01 + endloop + endfacet + facet normal 9.914449e-01 1.305262e-01 -0.000000e+00 + outer loop + vertex -5.926130e-02 -9.386068e-03 8.000000e-02 + vertex -5.967131e-02 -6.271708e-03 8.000000e-02 + vertex -5.967131e-02 -6.271708e-03 1.000000e-01 + endloop + endfacet + facet normal 9.832549e-01 1.822355e-01 0.000000e+00 + outer loop + vertex -5.868886e-02 -1.247470e-02 8.000000e-02 + vertex -5.926130e-02 -9.386068e-03 1.000000e-01 + vertex -5.868886e-02 -1.247470e-02 1.000000e-01 + endloop + endfacet + facet normal 9.832549e-01 1.822355e-01 -0.000000e+00 + outer loop + vertex -5.868886e-02 -1.247470e-02 8.000000e-02 + vertex -5.926130e-02 -9.386068e-03 8.000000e-02 + vertex -5.926130e-02 -9.386068e-03 1.000000e-01 + endloop + endfacet + facet normal 9.723699e-01 2.334454e-01 -0.000000e+00 + outer loop + vertex -5.795555e-02 -1.552914e-02 8.000000e-02 + vertex -5.868886e-02 -1.247470e-02 8.000000e-02 + vertex -5.868886e-02 -1.247470e-02 1.000000e-01 + endloop + endfacet + facet normal 9.723699e-01 2.334454e-01 0.000000e+00 + outer loop + vertex -5.795555e-02 -1.552914e-02 8.000000e-02 + vertex -5.868886e-02 -1.247470e-02 1.000000e-01 + vertex -5.795555e-02 -1.552914e-02 1.000000e-01 + endloop + endfacet + facet normal 9.588197e-01 2.840153e-01 -0.000000e+00 + outer loop + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + vertex -5.795555e-02 -1.552914e-02 8.000000e-02 + vertex -5.795555e-02 -1.552914e-02 1.000000e-01 + endloop + endfacet + facet normal 9.588197e-01 2.840153e-01 0.000000e+00 + outer loop + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + vertex -5.795555e-02 -1.552914e-02 1.000000e-01 + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 9.426415e-01 3.338069e-01 -0.000000e+00 + outer loop + vertex -5.601483e-02 -2.150208e-02 8.000000e-02 + vertex -5.706339e-02 -1.854102e-02 8.000000e-02 + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 9.426415e-01 3.338069e-01 0.000000e+00 + outer loop + vertex -5.601483e-02 -2.150208e-02 8.000000e-02 + vertex -5.706339e-02 -1.854102e-02 1.000000e-01 + vertex -5.601483e-02 -2.150208e-02 1.000000e-01 + endloop + endfacet + facet normal 9.238795e-01 3.826834e-01 -0.000000e+00 + outer loop + vertex -5.481273e-02 -2.440420e-02 8.000000e-02 + vertex -5.601483e-02 -2.150208e-02 8.000000e-02 + vertex -5.601483e-02 -2.150208e-02 1.000000e-01 + endloop + endfacet + facet normal 9.238795e-01 3.826834e-01 0.000000e+00 + outer loop + vertex -5.481273e-02 -2.440420e-02 8.000000e-02 + vertex -5.601483e-02 -2.150208e-02 1.000000e-01 + vertex -5.481273e-02 -2.440420e-02 1.000000e-01 + endloop + endfacet + facet normal 9.025853e-01 4.305111e-01 -0.000000e+00 + outer loop + vertex -5.346039e-02 -2.723943e-02 8.000000e-02 + vertex -5.481273e-02 -2.440420e-02 8.000000e-02 + vertex -5.481273e-02 -2.440420e-02 1.000000e-01 + endloop + endfacet + facet normal 9.025853e-01 4.305111e-01 0.000000e+00 + outer loop + vertex -5.346039e-02 -2.723943e-02 8.000000e-02 + vertex -5.481273e-02 -2.440420e-02 1.000000e-01 + vertex -5.346039e-02 -2.723943e-02 1.000000e-01 + endloop + endfacet + facet normal 8.788171e-01 4.771588e-01 -0.000000e+00 + outer loop + vertex -5.196152e-02 -3.000000e-02 8.000000e-02 + vertex -5.346039e-02 -2.723943e-02 8.000000e-02 + vertex -5.346039e-02 -2.723943e-02 1.000000e-01 + endloop + endfacet + facet normal 8.788171e-01 4.771588e-01 0.000000e+00 + outer loop + vertex -5.196152e-02 -3.000000e-02 8.000000e-02 + vertex -5.346039e-02 -2.723943e-02 1.000000e-01 + vertex -5.196152e-02 -3.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 8.526402e-01 5.224986e-01 -0.000000e+00 + outer loop + vertex -5.032023e-02 -3.267834e-02 8.000000e-02 + vertex -5.196152e-02 -3.000000e-02 8.000000e-02 + vertex -5.196152e-02 -3.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 8.526402e-01 5.224986e-01 0.000000e+00 + outer loop + vertex -5.032023e-02 -3.267834e-02 8.000000e-02 + vertex -5.196152e-02 -3.000000e-02 1.000000e-01 + vertex -5.032023e-02 -3.267834e-02 1.000000e-01 + endloop + endfacet + facet normal 8.241262e-01 5.664062e-01 -0.000000e+00 + outer loop + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + vertex -5.032023e-02 -3.267834e-02 8.000000e-02 + vertex -5.032023e-02 -3.267834e-02 1.000000e-01 + endloop + endfacet + facet normal 8.241262e-01 5.664062e-01 0.000000e+00 + outer loop + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + vertex -5.032023e-02 -3.267834e-02 1.000000e-01 + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal 7.933533e-01 6.087614e-01 -0.000000e+00 + outer loop + vertex -4.662876e-02 -3.775922e-02 8.000000e-02 + vertex -4.854102e-02 -3.526712e-02 8.000000e-02 + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + endloop + endfacet + facet normal 7.933533e-01 6.087614e-01 0.000000e+00 + outer loop + vertex -4.662876e-02 -3.775922e-02 8.000000e-02 + vertex -4.854102e-02 -3.526712e-02 1.000000e-01 + vertex -4.662876e-02 -3.775922e-02 1.000000e-01 + endloop + endfacet + facet normal 7.604060e-01 6.494480e-01 -0.000000e+00 + outer loop + vertex -4.458869e-02 -4.014784e-02 8.000000e-02 + vertex -4.662876e-02 -3.775922e-02 8.000000e-02 + vertex -4.662876e-02 -3.775922e-02 1.000000e-01 + endloop + endfacet + facet normal 7.604060e-01 6.494480e-01 0.000000e+00 + outer loop + vertex -4.458869e-02 -4.014784e-02 8.000000e-02 + vertex -4.662876e-02 -3.775922e-02 1.000000e-01 + vertex -4.458869e-02 -4.014784e-02 1.000000e-01 + endloop + endfacet + facet normal 7.253744e-01 6.883546e-01 -0.000000e+00 + outer loop + vertex -4.242641e-02 -4.242641e-02 8.000000e-02 + vertex -4.458869e-02 -4.014784e-02 8.000000e-02 + vertex -4.458869e-02 -4.014784e-02 1.000000e-01 + endloop + endfacet + facet normal 7.253744e-01 6.883546e-01 0.000000e+00 + outer loop + vertex -4.242641e-02 -4.242641e-02 8.000000e-02 + vertex -4.458869e-02 -4.014784e-02 1.000000e-01 + vertex -4.242641e-02 -4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal 6.883546e-01 7.253744e-01 -0.000000e+00 + outer loop + vertex -4.014784e-02 -4.458869e-02 8.000000e-02 + vertex -4.242641e-02 -4.242641e-02 8.000000e-02 + vertex -4.242641e-02 -4.242641e-02 1.000000e-01 + endloop + endfacet + facet normal 6.883546e-01 7.253744e-01 0.000000e+00 + outer loop + vertex -4.014784e-02 -4.458869e-02 8.000000e-02 + vertex -4.242641e-02 -4.242641e-02 1.000000e-01 + vertex -4.014784e-02 -4.458869e-02 1.000000e-01 + endloop + endfacet + facet normal 6.494480e-01 7.604060e-01 -0.000000e+00 + outer loop + vertex -3.775922e-02 -4.662876e-02 8.000000e-02 + vertex -4.014784e-02 -4.458869e-02 8.000000e-02 + vertex -4.014784e-02 -4.458869e-02 1.000000e-01 + endloop + endfacet + facet normal 6.494480e-01 7.604060e-01 0.000000e+00 + outer loop + vertex -3.775922e-02 -4.662876e-02 8.000000e-02 + vertex -4.014784e-02 -4.458869e-02 1.000000e-01 + vertex -3.775922e-02 -4.662876e-02 1.000000e-01 + endloop + endfacet + facet normal 6.087614e-01 7.933533e-01 -0.000000e+00 + outer loop + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + vertex -3.775922e-02 -4.662876e-02 8.000000e-02 + vertex -3.775922e-02 -4.662876e-02 1.000000e-01 + endloop + endfacet + facet normal 6.087614e-01 7.933533e-01 0.000000e+00 + outer loop + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + vertex -3.775922e-02 -4.662876e-02 1.000000e-01 + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 5.664062e-01 8.241262e-01 -0.000000e+00 + outer loop + vertex -3.267834e-02 -5.032023e-02 8.000000e-02 + vertex -3.526712e-02 -4.854102e-02 8.000000e-02 + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + endloop + endfacet + facet normal 5.664062e-01 8.241262e-01 0.000000e+00 + outer loop + vertex -3.267834e-02 -5.032023e-02 8.000000e-02 + vertex -3.526712e-02 -4.854102e-02 1.000000e-01 + vertex -3.267834e-02 -5.032023e-02 1.000000e-01 + endloop + endfacet + facet normal 5.224986e-01 8.526402e-01 -0.000000e+00 + outer loop + vertex -3.000000e-02 -5.196152e-02 8.000000e-02 + vertex -3.267834e-02 -5.032023e-02 8.000000e-02 + vertex -3.267834e-02 -5.032023e-02 1.000000e-01 + endloop + endfacet + facet normal 5.224986e-01 8.526402e-01 0.000000e+00 + outer loop + vertex -3.000000e-02 -5.196152e-02 8.000000e-02 + vertex -3.267834e-02 -5.032023e-02 1.000000e-01 + vertex -3.000000e-02 -5.196152e-02 1.000000e-01 + endloop + endfacet + facet normal 4.771588e-01 8.788171e-01 -0.000000e+00 + outer loop + vertex -2.723943e-02 -5.346039e-02 8.000000e-02 + vertex -3.000000e-02 -5.196152e-02 8.000000e-02 + vertex -3.000000e-02 -5.196152e-02 1.000000e-01 + endloop + endfacet + facet normal 4.771588e-01 8.788171e-01 0.000000e+00 + outer loop + vertex -2.723943e-02 -5.346039e-02 8.000000e-02 + vertex -3.000000e-02 -5.196152e-02 1.000000e-01 + vertex -2.723943e-02 -5.346039e-02 1.000000e-01 + endloop + endfacet + facet normal 4.305111e-01 9.025853e-01 -0.000000e+00 + outer loop + vertex -2.440420e-02 -5.481273e-02 8.000000e-02 + vertex -2.723943e-02 -5.346039e-02 8.000000e-02 + vertex -2.723943e-02 -5.346039e-02 1.000000e-01 + endloop + endfacet + facet normal 4.305111e-01 9.025853e-01 0.000000e+00 + outer loop + vertex -2.440420e-02 -5.481273e-02 8.000000e-02 + vertex -2.723943e-02 -5.346039e-02 1.000000e-01 + vertex -2.440420e-02 -5.481273e-02 1.000000e-01 + endloop + endfacet + facet normal 3.826834e-01 9.238795e-01 -0.000000e+00 + outer loop + vertex -2.150208e-02 -5.601483e-02 8.000000e-02 + vertex -2.440420e-02 -5.481273e-02 8.000000e-02 + vertex -2.440420e-02 -5.481273e-02 1.000000e-01 + endloop + endfacet + facet normal 3.826834e-01 9.238795e-01 0.000000e+00 + outer loop + vertex -2.150208e-02 -5.601483e-02 8.000000e-02 + vertex -2.440420e-02 -5.481273e-02 1.000000e-01 + vertex -2.150208e-02 -5.601483e-02 1.000000e-01 + endloop + endfacet + facet normal 3.338069e-01 9.426415e-01 -0.000000e+00 + outer loop + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + vertex -2.150208e-02 -5.601483e-02 8.000000e-02 + vertex -2.150208e-02 -5.601483e-02 1.000000e-01 + endloop + endfacet + facet normal 3.338069e-01 9.426415e-01 0.000000e+00 + outer loop + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + vertex -2.150208e-02 -5.601483e-02 1.000000e-01 + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal 2.840153e-01 9.588197e-01 -0.000000e+00 + outer loop + vertex -1.552914e-02 -5.795555e-02 8.000000e-02 + vertex -1.854102e-02 -5.706339e-02 8.000000e-02 + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + endloop + endfacet + facet normal 2.840153e-01 9.588197e-01 0.000000e+00 + outer loop + vertex -1.552914e-02 -5.795555e-02 8.000000e-02 + vertex -1.854102e-02 -5.706339e-02 1.000000e-01 + vertex -1.552914e-02 -5.795555e-02 1.000000e-01 + endloop + endfacet + facet normal 2.334454e-01 9.723699e-01 0.000000e+00 + outer loop + vertex -1.247470e-02 -5.868886e-02 8.000000e-02 + vertex -1.552914e-02 -5.795555e-02 1.000000e-01 + vertex -1.247470e-02 -5.868886e-02 1.000000e-01 + endloop + endfacet + facet normal 2.334454e-01 9.723699e-01 -0.000000e+00 + outer loop + vertex -1.247470e-02 -5.868886e-02 8.000000e-02 + vertex -1.552914e-02 -5.795555e-02 8.000000e-02 + vertex -1.552914e-02 -5.795555e-02 1.000000e-01 + endloop + endfacet + facet normal 1.822355e-01 9.832549e-01 0.000000e+00 + outer loop + vertex -9.386068e-03 -5.926130e-02 8.000000e-02 + vertex -1.247470e-02 -5.868886e-02 1.000000e-01 + vertex -9.386068e-03 -5.926130e-02 1.000000e-01 + endloop + endfacet + facet normal 1.822355e-01 9.832549e-01 -0.000000e+00 + outer loop + vertex -9.386068e-03 -5.926130e-02 8.000000e-02 + vertex -1.247470e-02 -5.868886e-02 8.000000e-02 + vertex -1.247470e-02 -5.868886e-02 1.000000e-01 + endloop + endfacet + facet normal 1.305262e-01 9.914449e-01 0.000000e+00 + outer loop + vertex -6.271708e-03 -5.967131e-02 8.000000e-02 + vertex -9.386068e-03 -5.926130e-02 1.000000e-01 + vertex -6.271708e-03 -5.967131e-02 1.000000e-01 + endloop + endfacet + facet normal 1.305262e-01 9.914449e-01 -0.000000e+00 + outer loop + vertex -6.271708e-03 -5.967131e-02 8.000000e-02 + vertex -9.386068e-03 -5.926130e-02 8.000000e-02 + vertex -9.386068e-03 -5.926130e-02 1.000000e-01 + endloop + endfacet + facet normal 7.845910e-02 9.969173e-01 0.000000e+00 + outer loop + vertex -3.140157e-03 -5.991777e-02 8.000000e-02 + vertex -6.271708e-03 -5.967131e-02 1.000000e-01 + vertex -3.140157e-03 -5.991777e-02 1.000000e-01 + endloop + endfacet + facet normal 7.845910e-02 9.969173e-01 -0.000000e+00 + outer loop + vertex -3.140157e-03 -5.991777e-02 8.000000e-02 + vertex -6.271708e-03 -5.967131e-02 8.000000e-02 + vertex -6.271708e-03 -5.967131e-02 1.000000e-01 + endloop + endfacet + facet normal 2.617695e-02 9.996573e-01 -0.000000e+00 + outer loop + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + vertex -3.140157e-03 -5.991777e-02 8.000000e-02 + vertex -3.140157e-03 -5.991777e-02 1.000000e-01 + endloop + endfacet + facet normal 2.617695e-02 9.996573e-01 0.000000e+00 + outer loop + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + vertex -3.140157e-03 -5.991777e-02 1.000000e-01 + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -2.617695e-02 9.996573e-01 0.000000e+00 + outer loop + vertex 3.140157e-03 -5.991777e-02 8.000000e-02 + vertex -1.102182e-17 -6.000000e-02 8.000000e-02 + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -2.617695e-02 9.996573e-01 0.000000e+00 + outer loop + vertex 3.140157e-03 -5.991777e-02 8.000000e-02 + vertex -1.102182e-17 -6.000000e-02 1.000000e-01 + vertex 3.140157e-03 -5.991777e-02 1.000000e-01 + endloop + endfacet +endsolid diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r5.stl b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r5.stl new file mode 100644 index 00000000..e9850e6b --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/DEM/stls/r5.stl @@ -0,0 +1,7394 @@ +solid + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.530715e-02 6.579387e-02 8.000000e-02 + vertex -6.070065e-02 5.210980e-02 8.000000e-02 + vertex -7.818315e-02 6.234898e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.530715e-02 6.579387e-02 8.000000e-02 + vertex -5.798342e-02 5.511735e-02 8.000000e-02 + vertex -6.070065e-02 5.210980e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.070065e-02 5.210980e-02 8.000000e-02 + vertex 7.818315e-02 6.234898e-02 8.000000e-02 + vertex 6.326206e-02 4.896848e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -6.579387e-02 7.530715e-02 8.000000e-02 + vertex -6.234898e-02 7.818315e-02 8.000000e-02 + vertex -5.210980e-02 6.070065e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.579387e-02 7.530715e-02 8.000000e-02 + vertex -5.210980e-02 6.070065e-02 8.000000e-02 + vertex -5.511735e-02 5.798342e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 6.070065e-02 5.210980e-02 8.000000e-02 + vertex 7.530715e-02 6.579387e-02 8.000000e-02 + vertex 7.818315e-02 6.234898e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.210980e-02 -6.070065e-02 8.000000e-02 + vertex -6.234898e-02 -7.818315e-02 8.000000e-02 + vertex -6.579387e-02 -7.530715e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.227949e-02 6.910626e-02 8.000000e-02 + vertex -5.798342e-02 5.511735e-02 8.000000e-02 + vertex -7.530715e-02 6.579387e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.910626e-02 7.227949e-02 8.000000e-02 + vertex -5.798342e-02 5.511735e-02 8.000000e-02 + vertex -7.227949e-02 6.910626e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.910626e-02 7.227949e-02 8.000000e-02 + vertex -5.511735e-02 5.798342e-02 8.000000e-02 + vertex -5.798342e-02 5.511735e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -6.910626e-02 7.227949e-02 8.000000e-02 + vertex -6.579387e-02 7.530715e-02 8.000000e-02 + vertex -5.511735e-02 5.798342e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.210980e-02 -6.070065e-02 8.000000e-02 + vertex -4.896848e-02 -6.326206e-02 8.000000e-02 + vertex -6.234898e-02 -7.818315e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.798342e-02 5.511735e-02 8.000000e-02 + vertex 7.530715e-02 6.579387e-02 8.000000e-02 + vertex 6.070065e-02 5.210980e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.798342e-02 5.511735e-02 8.000000e-02 + vertex 7.227949e-02 6.910626e-02 8.000000e-02 + vertex 7.530715e-02 6.579387e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.511735e-02 -5.798342e-02 8.000000e-02 + vertex -5.210980e-02 -6.070065e-02 8.000000e-02 + vertex -6.579387e-02 -7.530715e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.511735e-02 -5.798342e-02 8.000000e-02 + vertex -6.579387e-02 -7.530715e-02 8.000000e-02 + vertex -6.910626e-02 -7.227949e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.227949e-02 -6.910626e-02 8.000000e-02 + vertex -5.511735e-02 -5.798342e-02 8.000000e-02 + vertex -6.910626e-02 -7.227949e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.227949e-02 -6.910626e-02 8.000000e-02 + vertex -5.798342e-02 -5.511735e-02 8.000000e-02 + vertex -5.511735e-02 -5.798342e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 6.910626e-02 7.227949e-02 8.000000e-02 + vertex 5.798342e-02 5.511735e-02 8.000000e-02 + vertex 5.511735e-02 5.798342e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.910626e-02 7.227949e-02 8.000000e-02 + vertex 7.227949e-02 6.910626e-02 8.000000e-02 + vertex 5.798342e-02 5.511735e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 6.579387e-02 7.530715e-02 8.000000e-02 + vertex 5.511735e-02 5.798342e-02 8.000000e-02 + vertex 5.210980e-02 6.070065e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.579387e-02 7.530715e-02 8.000000e-02 + vertex 6.910626e-02 7.227949e-02 8.000000e-02 + vertex 5.511735e-02 5.798342e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.530715e-02 -6.579387e-02 8.000000e-02 + vertex -5.798342e-02 -5.511735e-02 8.000000e-02 + vertex -7.227949e-02 -6.910626e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.530715e-02 -6.579387e-02 8.000000e-02 + vertex -6.070065e-02 -5.210980e-02 8.000000e-02 + vertex -5.798342e-02 -5.511735e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 6.234898e-02 7.818315e-02 8.000000e-02 + vertex 5.210980e-02 6.070065e-02 8.000000e-02 + vertex 4.896848e-02 6.326206e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.234898e-02 7.818315e-02 8.000000e-02 + vertex 6.579387e-02 7.530715e-02 8.000000e-02 + vertex 5.210980e-02 6.070065e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.818315e-02 -6.234898e-02 8.000000e-02 + vertex -6.070065e-02 -5.210980e-02 8.000000e-02 + vertex -7.530715e-02 -6.579387e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -7.818315e-02 -6.234898e-02 8.000000e-02 + vertex -6.326206e-02 -4.896848e-02 8.000000e-02 + vertex -6.070065e-02 -5.210980e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.090170e-02 -5.877853e-02 8.000000e-02 + vertex -6.326206e-02 -4.896848e-02 8.000000e-02 + vertex -7.818315e-02 -6.234898e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -8.090170e-02 -5.877853e-02 8.000000e-02 + vertex -6.566108e-02 -4.570146e-02 8.000000e-02 + vertex -6.326206e-02 -4.896848e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.877853e-02 8.090170e-02 8.000000e-02 + vertex 4.896848e-02 6.326206e-02 8.000000e-02 + vertex 4.570146e-02 6.566108e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.877853e-02 8.090170e-02 8.000000e-02 + vertex 6.234898e-02 7.818315e-02 8.000000e-02 + vertex 4.896848e-02 6.326206e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.345733e-02 -5.508970e-02 8.000000e-02 + vertex -6.566108e-02 -4.570146e-02 8.000000e-02 + vertex -8.090170e-02 -5.877853e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -8.345733e-02 -5.508970e-02 8.000000e-02 + vertex -6.789154e-02 -4.231712e-02 8.000000e-02 + vertex -6.566108e-02 -4.570146e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.508970e-02 8.345733e-02 8.000000e-02 + vertex 4.570146e-02 6.566108e-02 8.000000e-02 + vertex 4.231712e-02 6.789154e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.508970e-02 8.345733e-02 8.000000e-02 + vertex 5.877853e-02 8.090170e-02 8.000000e-02 + vertex 4.570146e-02 6.566108e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.128993e-02 8.584488e-02 8.000000e-02 + vertex 4.231712e-02 6.789154e-02 8.000000e-02 + vertex 3.882416e-02 6.994773e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.128993e-02 8.584488e-02 8.000000e-02 + vertex 5.508970e-02 8.345733e-02 8.000000e-02 + vertex 4.231712e-02 6.789154e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.511735e-02 -5.798342e-02 8.000000e-02 + vertex 6.910626e-02 -7.227949e-02 8.000000e-02 + vertex 6.579387e-02 -7.530715e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.511735e-02 -5.798342e-02 8.000000e-02 + vertex 7.227949e-02 -6.910626e-02 8.000000e-02 + vertex 6.910626e-02 -7.227949e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.584488e-02 -5.128993e-02 8.000000e-02 + vertex -6.789154e-02 -4.231712e-02 8.000000e-02 + vertex -8.345733e-02 -5.508970e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -8.584488e-02 -5.128993e-02 8.000000e-02 + vertex -6.994773e-02 -3.882416e-02 8.000000e-02 + vertex -6.789154e-02 -4.231712e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.738687e-02 8.805955e-02 8.000000e-02 + vertex 3.882416e-02 6.994773e-02 8.000000e-02 + vertex 3.523153e-02 7.182436e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.738687e-02 8.805955e-02 8.000000e-02 + vertex 5.128993e-02 8.584488e-02 8.000000e-02 + vertex 3.882416e-02 6.994773e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.798342e-02 -5.511735e-02 8.000000e-02 + vertex 7.530715e-02 -6.579387e-02 8.000000e-02 + vertex 7.227949e-02 -6.910626e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -8.805955e-02 -4.738687e-02 8.000000e-02 + vertex -7.182436e-02 -3.523153e-02 8.000000e-02 + vertex -6.994773e-02 -3.882416e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.805955e-02 -4.738687e-02 8.000000e-02 + vertex -6.994773e-02 -3.882416e-02 8.000000e-02 + vertex -8.584488e-02 -5.128993e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.798342e-02 -5.511735e-02 8.000000e-02 + vertex 7.227949e-02 -6.910626e-02 8.000000e-02 + vertex 5.511735e-02 -5.798342e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -9.009689e-02 -4.338837e-02 8.000000e-02 + vertex -7.351662e-02 -3.154847e-02 8.000000e-02 + vertex -7.182436e-02 -3.523153e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.009689e-02 -4.338837e-02 8.000000e-02 + vertex -7.182436e-02 -3.523153e-02 8.000000e-02 + vertex -8.805955e-02 -4.738687e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.338837e-02 9.009689e-02 8.000000e-02 + vertex 3.523153e-02 7.182436e-02 8.000000e-02 + vertex 3.154847e-02 7.351662e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 5.210980e-02 -6.070065e-02 8.000000e-02 + vertex 6.579387e-02 -7.530715e-02 8.000000e-02 + vertex 6.234898e-02 -7.818315e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.338837e-02 9.009689e-02 8.000000e-02 + vertex 4.738687e-02 8.805955e-02 8.000000e-02 + vertex 3.523153e-02 7.182436e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 5.210980e-02 -6.070065e-02 8.000000e-02 + vertex 5.511735e-02 -5.798342e-02 8.000000e-02 + vertex 6.579387e-02 -7.530715e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.070065e-02 -5.210980e-02 8.000000e-02 + vertex 7.530715e-02 -6.579387e-02 8.000000e-02 + vertex 5.798342e-02 -5.511735e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.070065e-02 -5.210980e-02 8.000000e-02 + vertex 7.818315e-02 -6.234898e-02 8.000000e-02 + vertex 7.530715e-02 -6.579387e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.195278e-02 -3.930250e-02 8.000000e-02 + vertex -7.351662e-02 -3.154847e-02 8.000000e-02 + vertex -9.009689e-02 -4.338837e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.896848e-02 -6.326206e-02 8.000000e-02 + vertex 5.210980e-02 -6.070065e-02 8.000000e-02 + vertex 6.234898e-02 -7.818315e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.930250e-02 9.195278e-02 8.000000e-02 + vertex 4.338837e-02 9.009689e-02 8.000000e-02 + vertex 3.154847e-02 7.351662e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.896848e-02 -6.326206e-02 8.000000e-02 + vertex 6.234898e-02 -7.818315e-02 8.000000e-02 + vertex 5.877853e-02 -8.090170e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.362349e-02 -3.513748e-02 8.000000e-02 + vertex -7.351662e-02 -3.154847e-02 8.000000e-02 + vertex -9.195278e-02 -3.930250e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.326206e-02 -4.896848e-02 8.000000e-02 + vertex 8.090170e-02 -5.877853e-02 8.000000e-02 + vertex 7.818315e-02 -6.234898e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -9.362349e-02 -3.513748e-02 8.000000e-02 + vertex -7.502017e-02 -2.778442e-02 8.000000e-02 + vertex -7.351662e-02 -3.154847e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.513748e-02 9.362349e-02 8.000000e-02 + vertex 3.154847e-02 7.351662e-02 8.000000e-02 + vertex 2.778442e-02 7.502017e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.513748e-02 9.362349e-02 8.000000e-02 + vertex 3.930250e-02 9.195278e-02 8.000000e-02 + vertex 3.154847e-02 7.351662e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.326206e-02 -4.896848e-02 8.000000e-02 + vertex 7.818315e-02 -6.234898e-02 8.000000e-02 + vertex 6.070065e-02 -5.210980e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.570146e-02 -6.566108e-02 8.000000e-02 + vertex 4.896848e-02 -6.326206e-02 8.000000e-02 + vertex 5.877853e-02 -8.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.090170e-02 9.510565e-02 8.000000e-02 + vertex 2.778442e-02 7.502017e-02 8.000000e-02 + vertex 2.394905e-02 7.633114e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.090170e-02 9.510565e-02 8.000000e-02 + vertex 3.513748e-02 9.362349e-02 8.000000e-02 + vertex 2.778442e-02 7.502017e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.570146e-02 -6.566108e-02 8.000000e-02 + vertex 5.877853e-02 -8.090170e-02 8.000000e-02 + vertex 5.508970e-02 -8.345733e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.510565e-02 -3.090170e-02 8.000000e-02 + vertex -7.502017e-02 -2.778442e-02 8.000000e-02 + vertex -9.362349e-02 -3.513748e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -9.510565e-02 -3.090170e-02 8.000000e-02 + vertex -7.633114e-02 -2.394905e-02 8.000000e-02 + vertex -7.502017e-02 -2.778442e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.566108e-02 -4.570146e-02 8.000000e-02 + vertex 8.090170e-02 -5.877853e-02 8.000000e-02 + vertex 6.326206e-02 -4.896848e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.566108e-02 -4.570146e-02 8.000000e-02 + vertex 8.345733e-02 -5.508970e-02 8.000000e-02 + vertex 8.090170e-02 -5.877853e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.639629e-02 -2.660368e-02 8.000000e-02 + vertex -7.633114e-02 -2.394905e-02 8.000000e-02 + vertex -9.510565e-02 -3.090170e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -9.639629e-02 -2.660368e-02 8.000000e-02 + vertex -7.744617e-02 -2.005220e-02 8.000000e-02 + vertex -7.633114e-02 -2.394905e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.660368e-02 9.639629e-02 8.000000e-02 + vertex 3.090170e-02 9.510565e-02 8.000000e-02 + vertex 2.394905e-02 7.633114e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.660368e-02 9.639629e-02 8.000000e-02 + vertex 2.394905e-02 7.633114e-02 8.000000e-02 + vertex 2.005220e-02 7.744617e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.231712e-02 -6.789154e-02 8.000000e-02 + vertex 5.508970e-02 -8.345733e-02 8.000000e-02 + vertex 5.128993e-02 -8.584488e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.231712e-02 -6.789154e-02 8.000000e-02 + vertex 4.570146e-02 -6.566108e-02 8.000000e-02 + vertex 5.508970e-02 -8.345733e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.789154e-02 -4.231712e-02 8.000000e-02 + vertex 8.584488e-02 -5.128993e-02 8.000000e-02 + vertex 8.345733e-02 -5.508970e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.225209e-02 9.749279e-02 8.000000e-02 + vertex 2.660368e-02 9.639629e-02 8.000000e-02 + vertex 2.005220e-02 7.744617e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.225209e-02 9.749279e-02 8.000000e-02 + vertex 2.005220e-02 7.744617e-02 8.000000e-02 + vertex 1.610388e-02 7.836240e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.749279e-02 -2.225209e-02 8.000000e-02 + vertex -7.744617e-02 -2.005220e-02 8.000000e-02 + vertex -9.639629e-02 -2.660368e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.789154e-02 -4.231712e-02 8.000000e-02 + vertex 8.345733e-02 -5.508970e-02 8.000000e-02 + vertex 6.566108e-02 -4.570146e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -9.749279e-02 -2.225209e-02 8.000000e-02 + vertex -7.836240e-02 -1.610388e-02 8.000000e-02 + vertex -7.744617e-02 -2.005220e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.882416e-02 -6.994773e-02 8.000000e-02 + vertex 5.128993e-02 -8.584488e-02 8.000000e-02 + vertex 4.738687e-02 -8.805955e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.882416e-02 -6.994773e-02 8.000000e-02 + vertex 4.231712e-02 -6.789154e-02 8.000000e-02 + vertex 5.128993e-02 -8.584488e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.994773e-02 -3.882416e-02 8.000000e-02 + vertex 8.584488e-02 -5.128993e-02 8.000000e-02 + vertex 6.789154e-02 -4.231712e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.994773e-02 -3.882416e-02 8.000000e-02 + vertex 8.805955e-02 -4.738687e-02 8.000000e-02 + vertex 8.584488e-02 -5.128993e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.785569e-02 9.839296e-02 8.000000e-02 + vertex 2.225209e-02 9.749279e-02 8.000000e-02 + vertex 1.610388e-02 7.836240e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.785569e-02 9.839296e-02 8.000000e-02 + vertex 1.610388e-02 7.836240e-02 8.000000e-02 + vertex 1.211422e-02 7.907747e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.839296e-02 -1.785569e-02 8.000000e-02 + vertex -7.836240e-02 -1.610388e-02 8.000000e-02 + vertex -9.749279e-02 -2.225209e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -9.839296e-02 -1.785569e-02 8.000000e-02 + vertex -7.907747e-02 -1.211422e-02 8.000000e-02 + vertex -7.836240e-02 -1.610388e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.523153e-02 -7.182436e-02 8.000000e-02 + vertex 4.738687e-02 -8.805955e-02 8.000000e-02 + vertex 4.338837e-02 -9.009689e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.523153e-02 -7.182436e-02 8.000000e-02 + vertex 3.882416e-02 -6.994773e-02 8.000000e-02 + vertex 4.738687e-02 -8.805955e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.342333e-02 9.909498e-02 8.000000e-02 + vertex 1.211422e-02 7.907747e-02 8.000000e-02 + vertex 8.093466e-03 7.958955e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.182436e-02 -3.523153e-02 8.000000e-02 + vertex 9.009689e-02 -4.338837e-02 8.000000e-02 + vertex 8.805955e-02 -4.738687e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.342333e-02 9.909498e-02 8.000000e-02 + vertex 1.785569e-02 9.839296e-02 8.000000e-02 + vertex 1.211422e-02 7.907747e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.909498e-02 -1.342333e-02 8.000000e-02 + vertex -7.907747e-02 -1.211422e-02 8.000000e-02 + vertex -9.839296e-02 -1.785569e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.182436e-02 -3.523153e-02 8.000000e-02 + vertex 8.805955e-02 -4.738687e-02 8.000000e-02 + vertex 6.994773e-02 -3.882416e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -9.909498e-02 -1.342333e-02 8.000000e-02 + vertex -7.958955e-02 -8.093466e-03 8.000000e-02 + vertex -7.907747e-02 -1.211422e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.154847e-02 -7.351662e-02 8.000000e-02 + vertex 3.930250e-02 -9.195278e-02 8.000000e-02 + vertex 3.513748e-02 -9.362349e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 3.154847e-02 -7.351662e-02 8.000000e-02 + vertex 4.338837e-02 -9.009689e-02 8.000000e-02 + vertex 3.930250e-02 -9.195278e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 8.963931e-03 9.959743e-02 8.000000e-02 + vertex 8.093466e-03 7.958955e-02 8.000000e-02 + vertex 4.051934e-03 7.989732e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 3.154847e-02 -7.351662e-02 8.000000e-02 + vertex 3.523153e-02 -7.182436e-02 8.000000e-02 + vertex 4.338837e-02 -9.009689e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 8.963931e-03 9.959743e-02 8.000000e-02 + vertex 1.342333e-02 9.909498e-02 8.000000e-02 + vertex 8.093466e-03 7.958955e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.351662e-02 -3.154847e-02 8.000000e-02 + vertex 9.009689e-02 -4.338837e-02 8.000000e-02 + vertex 7.182436e-02 -3.523153e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.351662e-02 -3.154847e-02 8.000000e-02 + vertex 9.195278e-02 -3.930250e-02 8.000000e-02 + vertex 9.009689e-02 -4.338837e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.351662e-02 -3.154847e-02 8.000000e-02 + vertex 9.362349e-02 -3.513748e-02 8.000000e-02 + vertex 9.195278e-02 -3.930250e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.959743e-02 -8.963931e-03 8.000000e-02 + vertex -7.958955e-02 -8.093466e-03 8.000000e-02 + vertex -9.909498e-02 -1.342333e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -9.959743e-02 -8.963931e-03 8.000000e-02 + vertex -7.989732e-02 -4.051934e-03 8.000000e-02 + vertex -7.958955e-02 -8.093466e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.778442e-02 -7.502017e-02 8.000000e-02 + vertex 3.154847e-02 -7.351662e-02 8.000000e-02 + vertex 3.513748e-02 -9.362349e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.778442e-02 -7.502017e-02 8.000000e-02 + vertex 3.513748e-02 -9.362349e-02 8.000000e-02 + vertex 3.090170e-02 -9.510565e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.502017e-02 -2.778442e-02 8.000000e-02 + vertex 9.510565e-02 -3.090170e-02 8.000000e-02 + vertex 9.362349e-02 -3.513748e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.502017e-02 -2.778442e-02 8.000000e-02 + vertex 9.362349e-02 -3.513748e-02 8.000000e-02 + vertex 7.351662e-02 -3.154847e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.486483e-03 9.989931e-02 8.000000e-02 + vertex 4.051934e-03 7.989732e-02 8.000000e-02 + vertex 4.898587e-18 8.000000e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.486483e-03 9.989931e-02 8.000000e-02 + vertex 8.963931e-03 9.959743e-02 8.000000e-02 + vertex 4.051934e-03 7.989732e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.394905e-02 -7.633114e-02 8.000000e-02 + vertex 3.090170e-02 -9.510565e-02 8.000000e-02 + vertex 2.660368e-02 -9.639629e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.394905e-02 -7.633114e-02 8.000000e-02 + vertex 2.778442e-02 -7.502017e-02 8.000000e-02 + vertex 3.090170e-02 -9.510565e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.989931e-02 -4.486483e-03 8.000000e-02 + vertex -7.989732e-02 -4.051934e-03 8.000000e-02 + vertex -9.959743e-02 -8.963931e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -9.989931e-02 -4.486483e-03 8.000000e-02 + vertex -8.000000e-02 9.797174e-18 8.000000e-02 + vertex -7.989732e-02 -4.051934e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.633114e-02 -2.394905e-02 8.000000e-02 + vertex 9.639629e-02 -2.660368e-02 8.000000e-02 + vertex 9.510565e-02 -3.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.633114e-02 -2.394905e-02 8.000000e-02 + vertex 9.510565e-02 -3.090170e-02 8.000000e-02 + vertex 7.502017e-02 -2.778442e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.005220e-02 -7.744617e-02 8.000000e-02 + vertex 2.394905e-02 -7.633114e-02 8.000000e-02 + vertex 2.660368e-02 -9.639629e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.000000e-01 1.224647e-17 8.000000e-02 + vertex -8.000000e-02 9.797174e-18 8.000000e-02 + vertex -9.989931e-02 -4.486483e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.005220e-02 -7.744617e-02 8.000000e-02 + vertex 2.660368e-02 -9.639629e-02 8.000000e-02 + vertex 2.225209e-02 -9.749279e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.123234e-18 1.000000e-01 8.000000e-02 + vertex 4.486483e-03 9.989931e-02 8.000000e-02 + vertex 4.898587e-18 8.000000e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.744617e-02 -2.005220e-02 8.000000e-02 + vertex 9.639629e-02 -2.660368e-02 8.000000e-02 + vertex 7.633114e-02 -2.394905e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.744617e-02 -2.005220e-02 8.000000e-02 + vertex 9.749279e-02 -2.225209e-02 8.000000e-02 + vertex 9.639629e-02 -2.660368e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.989931e-02 4.486483e-03 8.000000e-02 + vertex -7.989732e-02 4.051934e-03 8.000000e-02 + vertex -8.000000e-02 9.797174e-18 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.610388e-02 -7.836240e-02 8.000000e-02 + vertex 2.225209e-02 -9.749279e-02 8.000000e-02 + vertex 1.785569e-02 -9.839296e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.610388e-02 -7.836240e-02 8.000000e-02 + vertex 2.005220e-02 -7.744617e-02 8.000000e-02 + vertex 2.225209e-02 -9.749279e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.989931e-02 4.486483e-03 8.000000e-02 + vertex -8.000000e-02 9.797174e-18 8.000000e-02 + vertex -1.000000e-01 1.224647e-17 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.486483e-03 9.989931e-02 8.000000e-02 + vertex 4.898587e-18 8.000000e-02 8.000000e-02 + vertex -4.051934e-03 7.989732e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.836240e-02 -1.610388e-02 8.000000e-02 + vertex 9.839296e-02 -1.785569e-02 8.000000e-02 + vertex 9.749279e-02 -2.225209e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.486483e-03 9.989931e-02 8.000000e-02 + vertex 6.123234e-18 1.000000e-01 8.000000e-02 + vertex 4.898587e-18 8.000000e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.836240e-02 -1.610388e-02 8.000000e-02 + vertex 9.749279e-02 -2.225209e-02 8.000000e-02 + vertex 7.744617e-02 -2.005220e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 1.211422e-02 -7.907747e-02 8.000000e-02 + vertex 1.785569e-02 -9.839296e-02 8.000000e-02 + vertex 1.342333e-02 -9.909498e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 1.211422e-02 -7.907747e-02 8.000000e-02 + vertex 1.610388e-02 -7.836240e-02 8.000000e-02 + vertex 1.785569e-02 -9.839296e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.907747e-02 -1.211422e-02 8.000000e-02 + vertex 9.909498e-02 -1.342333e-02 8.000000e-02 + vertex 9.839296e-02 -1.785569e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.907747e-02 -1.211422e-02 8.000000e-02 + vertex 9.839296e-02 -1.785569e-02 8.000000e-02 + vertex 7.836240e-02 -1.610388e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.959743e-02 8.963931e-03 8.000000e-02 + vertex -7.989732e-02 4.051934e-03 8.000000e-02 + vertex -9.989931e-02 4.486483e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.959743e-02 8.963931e-03 8.000000e-02 + vertex -7.958955e-02 8.093466e-03 8.000000e-02 + vertex -7.989732e-02 4.051934e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.963931e-03 9.959743e-02 8.000000e-02 + vertex -4.051934e-03 7.989732e-02 8.000000e-02 + vertex -8.093466e-03 7.958955e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 8.093466e-03 -7.958955e-02 8.000000e-02 + vertex 1.342333e-02 -9.909498e-02 8.000000e-02 + vertex 8.963931e-03 -9.959743e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 8.093466e-03 -7.958955e-02 8.000000e-02 + vertex 1.211422e-02 -7.907747e-02 8.000000e-02 + vertex 1.342333e-02 -9.909498e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -8.963931e-03 9.959743e-02 8.000000e-02 + vertex -4.486483e-03 9.989931e-02 8.000000e-02 + vertex -4.051934e-03 7.989732e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.958955e-02 -8.093466e-03 8.000000e-02 + vertex 9.959743e-02 -8.963931e-03 8.000000e-02 + vertex 9.909498e-02 -1.342333e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.958955e-02 -8.093466e-03 8.000000e-02 + vertex 9.909498e-02 -1.342333e-02 8.000000e-02 + vertex 7.907747e-02 -1.211422e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 4.051934e-03 -7.989732e-02 8.000000e-02 + vertex 8.963931e-03 -9.959743e-02 8.000000e-02 + vertex 4.486483e-03 -9.989931e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 4.051934e-03 -7.989732e-02 8.000000e-02 + vertex 8.093466e-03 -7.958955e-02 8.000000e-02 + vertex 8.963931e-03 -9.959743e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.989732e-02 -4.051934e-03 8.000000e-02 + vertex 9.989931e-02 -4.486483e-03 8.000000e-02 + vertex 9.959743e-02 -8.963931e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.989732e-02 -4.051934e-03 8.000000e-02 + vertex 9.959743e-02 -8.963931e-03 8.000000e-02 + vertex 7.958955e-02 -8.093466e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.909498e-02 1.342333e-02 8.000000e-02 + vertex -7.958955e-02 8.093466e-03 8.000000e-02 + vertex -9.959743e-02 8.963931e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.909498e-02 1.342333e-02 8.000000e-02 + vertex -7.907747e-02 1.211422e-02 8.000000e-02 + vertex -7.958955e-02 8.093466e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.342333e-02 9.909498e-02 8.000000e-02 + vertex -8.093466e-03 7.958955e-02 8.000000e-02 + vertex -1.211422e-02 7.907747e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.695213e-16 -8.000000e-02 8.000000e-02 + vertex -1.836970e-17 -1.000000e-01 8.000000e-02 + vertex -4.486483e-03 -9.989931e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 2.695213e-16 -8.000000e-02 8.000000e-02 + vertex 4.486483e-03 -9.989931e-02 8.000000e-02 + vertex -1.836970e-17 -1.000000e-01 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 2.695213e-16 -8.000000e-02 8.000000e-02 + vertex 4.051934e-03 -7.989732e-02 8.000000e-02 + vertex 4.486483e-03 -9.989931e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.342333e-02 9.909498e-02 8.000000e-02 + vertex -8.963931e-03 9.959743e-02 8.000000e-02 + vertex -8.093466e-03 7.958955e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 8.000000e-02 0.000000e+00 8.000000e-02 + vertex 9.989931e-02 4.486483e-03 8.000000e-02 + vertex 1.000000e-01 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 8.000000e-02 0.000000e+00 8.000000e-02 + vertex 1.000000e-01 0.000000e+00 8.000000e-02 + vertex 9.989931e-02 -4.486483e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 8.000000e-02 0.000000e+00 8.000000e-02 + vertex 9.989931e-02 -4.486483e-03 8.000000e-02 + vertex 7.989732e-02 -4.051934e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.051934e-03 -7.989732e-02 8.000000e-02 + vertex -4.486483e-03 -9.989931e-02 8.000000e-02 + vertex -8.963931e-03 -9.959743e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.051934e-03 -7.989732e-02 8.000000e-02 + vertex 2.695213e-16 -8.000000e-02 8.000000e-02 + vertex -4.486483e-03 -9.989931e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.989732e-02 4.051934e-03 8.000000e-02 + vertex 9.959743e-02 8.963931e-03 8.000000e-02 + vertex 9.989931e-02 4.486483e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.785569e-02 9.839296e-02 8.000000e-02 + vertex -1.342333e-02 9.909498e-02 8.000000e-02 + vertex -1.211422e-02 7.907747e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.989732e-02 4.051934e-03 8.000000e-02 + vertex 9.989931e-02 4.486483e-03 8.000000e-02 + vertex 8.000000e-02 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.785569e-02 9.839296e-02 8.000000e-02 + vertex -1.211422e-02 7.907747e-02 8.000000e-02 + vertex -1.610388e-02 7.836240e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.093466e-03 -7.958955e-02 8.000000e-02 + vertex -4.051934e-03 -7.989732e-02 8.000000e-02 + vertex -8.963931e-03 -9.959743e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.839296e-02 1.785569e-02 8.000000e-02 + vertex -7.907747e-02 1.211422e-02 8.000000e-02 + vertex -9.909498e-02 1.342333e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -8.093466e-03 -7.958955e-02 8.000000e-02 + vertex -8.963931e-03 -9.959743e-02 8.000000e-02 + vertex -1.342333e-02 -9.909498e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.958955e-02 8.093466e-03 8.000000e-02 + vertex 9.959743e-02 8.963931e-03 8.000000e-02 + vertex 7.989732e-02 4.051934e-03 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.839296e-02 1.785569e-02 8.000000e-02 + vertex -7.836240e-02 1.610388e-02 8.000000e-02 + vertex -7.907747e-02 1.211422e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.958955e-02 8.093466e-03 8.000000e-02 + vertex 9.909498e-02 1.342333e-02 8.000000e-02 + vertex 9.959743e-02 8.963931e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.749279e-02 2.225209e-02 8.000000e-02 + vertex -7.836240e-02 1.610388e-02 8.000000e-02 + vertex -9.839296e-02 1.785569e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.749279e-02 2.225209e-02 8.000000e-02 + vertex -7.744617e-02 2.005220e-02 8.000000e-02 + vertex -7.836240e-02 1.610388e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.225209e-02 9.749279e-02 8.000000e-02 + vertex -1.785569e-02 9.839296e-02 8.000000e-02 + vertex -1.610388e-02 7.836240e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.225209e-02 9.749279e-02 8.000000e-02 + vertex -1.610388e-02 7.836240e-02 8.000000e-02 + vertex -2.005220e-02 7.744617e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.211422e-02 -7.907747e-02 8.000000e-02 + vertex -1.342333e-02 -9.909498e-02 8.000000e-02 + vertex -1.785569e-02 -9.839296e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.211422e-02 -7.907747e-02 8.000000e-02 + vertex -8.093466e-03 -7.958955e-02 8.000000e-02 + vertex -1.342333e-02 -9.909498e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.907747e-02 1.211422e-02 8.000000e-02 + vertex 9.839296e-02 1.785569e-02 8.000000e-02 + vertex 9.909498e-02 1.342333e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.907747e-02 1.211422e-02 8.000000e-02 + vertex 9.909498e-02 1.342333e-02 8.000000e-02 + vertex 7.958955e-02 8.093466e-03 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.639629e-02 2.660368e-02 8.000000e-02 + vertex -7.744617e-02 2.005220e-02 8.000000e-02 + vertex -9.749279e-02 2.225209e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.639629e-02 2.660368e-02 8.000000e-02 + vertex -7.633114e-02 2.394905e-02 8.000000e-02 + vertex -7.744617e-02 2.005220e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -1.610388e-02 -7.836240e-02 8.000000e-02 + vertex -1.211422e-02 -7.907747e-02 8.000000e-02 + vertex -1.785569e-02 -9.839296e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.660368e-02 9.639629e-02 8.000000e-02 + vertex -2.225209e-02 9.749279e-02 8.000000e-02 + vertex -2.005220e-02 7.744617e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -1.610388e-02 -7.836240e-02 8.000000e-02 + vertex -1.785569e-02 -9.839296e-02 8.000000e-02 + vertex -2.225209e-02 -9.749279e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.660368e-02 9.639629e-02 8.000000e-02 + vertex -2.005220e-02 7.744617e-02 8.000000e-02 + vertex -2.394905e-02 7.633114e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.836240e-02 1.610388e-02 8.000000e-02 + vertex 9.839296e-02 1.785569e-02 8.000000e-02 + vertex 7.907747e-02 1.211422e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.836240e-02 1.610388e-02 8.000000e-02 + vertex 9.749279e-02 2.225209e-02 8.000000e-02 + vertex 9.839296e-02 1.785569e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.510565e-02 3.090170e-02 8.000000e-02 + vertex -7.633114e-02 2.394905e-02 8.000000e-02 + vertex -9.639629e-02 2.660368e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.005220e-02 -7.744617e-02 8.000000e-02 + vertex -2.225209e-02 -9.749279e-02 8.000000e-02 + vertex -2.660368e-02 -9.639629e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.510565e-02 3.090170e-02 8.000000e-02 + vertex -7.502017e-02 2.778442e-02 8.000000e-02 + vertex -7.633114e-02 2.394905e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.005220e-02 -7.744617e-02 8.000000e-02 + vertex -1.610388e-02 -7.836240e-02 8.000000e-02 + vertex -2.225209e-02 -9.749279e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.090170e-02 9.510565e-02 8.000000e-02 + vertex -2.394905e-02 7.633114e-02 8.000000e-02 + vertex -2.778442e-02 7.502017e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.744617e-02 2.005220e-02 8.000000e-02 + vertex 9.639629e-02 2.660368e-02 8.000000e-02 + vertex 9.749279e-02 2.225209e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.090170e-02 9.510565e-02 8.000000e-02 + vertex -2.660368e-02 9.639629e-02 8.000000e-02 + vertex -2.394905e-02 7.633114e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.744617e-02 2.005220e-02 8.000000e-02 + vertex 9.749279e-02 2.225209e-02 8.000000e-02 + vertex 7.836240e-02 1.610388e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.362349e-02 3.513748e-02 8.000000e-02 + vertex -7.502017e-02 2.778442e-02 8.000000e-02 + vertex -9.510565e-02 3.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.394905e-02 -7.633114e-02 8.000000e-02 + vertex -2.660368e-02 -9.639629e-02 8.000000e-02 + vertex -3.090170e-02 -9.510565e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.394905e-02 -7.633114e-02 8.000000e-02 + vertex -2.005220e-02 -7.744617e-02 8.000000e-02 + vertex -2.660368e-02 -9.639629e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.362349e-02 3.513748e-02 8.000000e-02 + vertex -7.351662e-02 3.154847e-02 8.000000e-02 + vertex -7.502017e-02 2.778442e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.633114e-02 2.394905e-02 8.000000e-02 + vertex 9.510565e-02 3.090170e-02 8.000000e-02 + vertex 9.639629e-02 2.660368e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.513748e-02 9.362349e-02 8.000000e-02 + vertex -2.778442e-02 7.502017e-02 8.000000e-02 + vertex -3.154847e-02 7.351662e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.633114e-02 2.394905e-02 8.000000e-02 + vertex 9.639629e-02 2.660368e-02 8.000000e-02 + vertex 7.744617e-02 2.005220e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -2.778442e-02 -7.502017e-02 8.000000e-02 + vertex -3.090170e-02 -9.510565e-02 8.000000e-02 + vertex -3.513748e-02 -9.362349e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.513748e-02 9.362349e-02 8.000000e-02 + vertex -3.090170e-02 9.510565e-02 8.000000e-02 + vertex -2.778442e-02 7.502017e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -2.778442e-02 -7.502017e-02 8.000000e-02 + vertex -2.394905e-02 -7.633114e-02 8.000000e-02 + vertex -3.090170e-02 -9.510565e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.502017e-02 2.778442e-02 8.000000e-02 + vertex 9.362349e-02 3.513748e-02 8.000000e-02 + vertex 9.510565e-02 3.090170e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.502017e-02 2.778442e-02 8.000000e-02 + vertex 9.510565e-02 3.090170e-02 8.000000e-02 + vertex 7.633114e-02 2.394905e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.930250e-02 9.195278e-02 8.000000e-02 + vertex -3.513748e-02 9.362349e-02 8.000000e-02 + vertex -3.154847e-02 7.351662e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.195278e-02 3.930250e-02 8.000000e-02 + vertex -7.351662e-02 3.154847e-02 8.000000e-02 + vertex -9.362349e-02 3.513748e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.154847e-02 -7.351662e-02 8.000000e-02 + vertex -3.930250e-02 -9.195278e-02 8.000000e-02 + vertex -4.338837e-02 -9.009689e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.154847e-02 -7.351662e-02 8.000000e-02 + vertex -3.513748e-02 -9.362349e-02 8.000000e-02 + vertex -3.930250e-02 -9.195278e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.154847e-02 -7.351662e-02 8.000000e-02 + vertex -2.778442e-02 -7.502017e-02 8.000000e-02 + vertex -3.513748e-02 -9.362349e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.009689e-02 4.338837e-02 8.000000e-02 + vertex -7.351662e-02 3.154847e-02 8.000000e-02 + vertex -9.195278e-02 3.930250e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.351662e-02 3.154847e-02 8.000000e-02 + vertex 9.195278e-02 3.930250e-02 8.000000e-02 + vertex 9.362349e-02 3.513748e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.351662e-02 3.154847e-02 8.000000e-02 + vertex 9.009689e-02 4.338837e-02 8.000000e-02 + vertex 9.195278e-02 3.930250e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.351662e-02 3.154847e-02 8.000000e-02 + vertex 9.362349e-02 3.513748e-02 8.000000e-02 + vertex 7.502017e-02 2.778442e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -9.009689e-02 4.338837e-02 8.000000e-02 + vertex -7.182436e-02 3.523153e-02 8.000000e-02 + vertex -7.351662e-02 3.154847e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.338837e-02 9.009689e-02 8.000000e-02 + vertex -3.154847e-02 7.351662e-02 8.000000e-02 + vertex -3.523153e-02 7.182436e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.523153e-02 -7.182436e-02 8.000000e-02 + vertex -4.338837e-02 -9.009689e-02 8.000000e-02 + vertex -4.738687e-02 -8.805955e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.523153e-02 -7.182436e-02 8.000000e-02 + vertex -3.154847e-02 -7.351662e-02 8.000000e-02 + vertex -4.338837e-02 -9.009689e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.338837e-02 9.009689e-02 8.000000e-02 + vertex -3.930250e-02 9.195278e-02 8.000000e-02 + vertex -3.154847e-02 7.351662e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 7.182436e-02 3.523153e-02 8.000000e-02 + vertex 8.805955e-02 4.738687e-02 8.000000e-02 + vertex 9.009689e-02 4.338837e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 7.182436e-02 3.523153e-02 8.000000e-02 + vertex 9.009689e-02 4.338837e-02 8.000000e-02 + vertex 7.351662e-02 3.154847e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.805955e-02 4.738687e-02 8.000000e-02 + vertex -7.182436e-02 3.523153e-02 8.000000e-02 + vertex -9.009689e-02 4.338837e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.805955e-02 4.738687e-02 8.000000e-02 + vertex -6.994773e-02 3.882416e-02 8.000000e-02 + vertex -7.182436e-02 3.523153e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.738687e-02 8.805955e-02 8.000000e-02 + vertex -3.523153e-02 7.182436e-02 8.000000e-02 + vertex -3.882416e-02 6.994773e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -3.882416e-02 -6.994773e-02 8.000000e-02 + vertex -4.738687e-02 -8.805955e-02 8.000000e-02 + vertex -5.128993e-02 -8.584488e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -3.882416e-02 -6.994773e-02 8.000000e-02 + vertex -3.523153e-02 -7.182436e-02 8.000000e-02 + vertex -4.738687e-02 -8.805955e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.738687e-02 8.805955e-02 8.000000e-02 + vertex -4.338837e-02 9.009689e-02 8.000000e-02 + vertex -3.523153e-02 7.182436e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 6.994773e-02 3.882416e-02 8.000000e-02 + vertex 8.584488e-02 5.128993e-02 8.000000e-02 + vertex 8.805955e-02 4.738687e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.994773e-02 3.882416e-02 8.000000e-02 + vertex 8.805955e-02 4.738687e-02 8.000000e-02 + vertex 7.182436e-02 3.523153e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.584488e-02 5.128993e-02 8.000000e-02 + vertex -6.789154e-02 4.231712e-02 8.000000e-02 + vertex -6.994773e-02 3.882416e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.584488e-02 5.128993e-02 8.000000e-02 + vertex -6.994773e-02 3.882416e-02 8.000000e-02 + vertex -8.805955e-02 4.738687e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.128993e-02 8.584488e-02 8.000000e-02 + vertex -3.882416e-02 6.994773e-02 8.000000e-02 + vertex -4.231712e-02 6.789154e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.231712e-02 -6.789154e-02 8.000000e-02 + vertex -5.128993e-02 -8.584488e-02 8.000000e-02 + vertex -5.508970e-02 -8.345733e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.231712e-02 -6.789154e-02 8.000000e-02 + vertex -3.882416e-02 -6.994773e-02 8.000000e-02 + vertex -5.128993e-02 -8.584488e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.128993e-02 8.584488e-02 8.000000e-02 + vertex -4.738687e-02 8.805955e-02 8.000000e-02 + vertex -3.882416e-02 6.994773e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 6.789154e-02 4.231712e-02 8.000000e-02 + vertex 8.345733e-02 5.508970e-02 8.000000e-02 + vertex 8.584488e-02 5.128993e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.508970e-02 8.345733e-02 8.000000e-02 + vertex -4.231712e-02 6.789154e-02 8.000000e-02 + vertex -4.570146e-02 6.566108e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.789154e-02 4.231712e-02 8.000000e-02 + vertex 8.584488e-02 5.128993e-02 8.000000e-02 + vertex 6.994773e-02 3.882416e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.508970e-02 8.345733e-02 8.000000e-02 + vertex -5.128993e-02 8.584488e-02 8.000000e-02 + vertex -4.231712e-02 6.789154e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.345733e-02 5.508970e-02 8.000000e-02 + vertex -6.789154e-02 4.231712e-02 8.000000e-02 + vertex -8.584488e-02 5.128993e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.570146e-02 -6.566108e-02 8.000000e-02 + vertex -5.508970e-02 -8.345733e-02 8.000000e-02 + vertex -5.877853e-02 -8.090170e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.570146e-02 -6.566108e-02 8.000000e-02 + vertex -4.231712e-02 -6.789154e-02 8.000000e-02 + vertex -5.508970e-02 -8.345733e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.345733e-02 5.508970e-02 8.000000e-02 + vertex -6.566108e-02 4.570146e-02 8.000000e-02 + vertex -6.789154e-02 4.231712e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -5.877853e-02 8.090170e-02 8.000000e-02 + vertex -4.570146e-02 6.566108e-02 8.000000e-02 + vertex -4.896848e-02 6.326206e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -5.877853e-02 8.090170e-02 8.000000e-02 + vertex -5.508970e-02 8.345733e-02 8.000000e-02 + vertex -4.570146e-02 6.566108e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 6.566108e-02 4.570146e-02 8.000000e-02 + vertex 8.090170e-02 5.877853e-02 8.000000e-02 + vertex 8.345733e-02 5.508970e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.566108e-02 4.570146e-02 8.000000e-02 + vertex 8.345733e-02 5.508970e-02 8.000000e-02 + vertex 6.789154e-02 4.231712e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.090170e-02 5.877853e-02 8.000000e-02 + vertex -6.566108e-02 4.570146e-02 8.000000e-02 + vertex -8.345733e-02 5.508970e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -8.090170e-02 5.877853e-02 8.000000e-02 + vertex -6.326206e-02 4.896848e-02 8.000000e-02 + vertex -6.566108e-02 4.570146e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -4.896848e-02 -6.326206e-02 8.000000e-02 + vertex -5.877853e-02 -8.090170e-02 8.000000e-02 + vertex -6.234898e-02 -7.818315e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.818315e-02 6.234898e-02 8.000000e-02 + vertex -6.070065e-02 5.210980e-02 8.000000e-02 + vertex -6.326206e-02 4.896848e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -4.896848e-02 -6.326206e-02 8.000000e-02 + vertex -4.570146e-02 -6.566108e-02 8.000000e-02 + vertex -5.877853e-02 -8.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -7.818315e-02 6.234898e-02 8.000000e-02 + vertex -6.326206e-02 4.896848e-02 8.000000e-02 + vertex -8.090170e-02 5.877853e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex -6.234898e-02 7.818315e-02 8.000000e-02 + vertex -5.877853e-02 8.090170e-02 8.000000e-02 + vertex -4.896848e-02 6.326206e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex -6.234898e-02 7.818315e-02 8.000000e-02 + vertex -4.896848e-02 6.326206e-02 8.000000e-02 + vertex -5.210980e-02 6.070065e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 -1.000000e+00 + outer loop + vertex 6.326206e-02 4.896848e-02 8.000000e-02 + vertex 7.818315e-02 6.234898e-02 8.000000e-02 + vertex 8.090170e-02 5.877853e-02 8.000000e-02 + endloop + endfacet + facet normal 0.000000e+00 -0.000000e+00 -1.000000e+00 + outer loop + vertex 6.326206e-02 4.896848e-02 8.000000e-02 + vertex 8.090170e-02 5.877853e-02 8.000000e-02 + vertex 6.566108e-02 4.570146e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 -7.956245e-01 -0.000000e+00 + outer loop + vertex -5.877853e-02 -8.090170e-02 1.000000e-01 + vertex -6.234898e-02 -7.818315e-02 1.000000e-01 + vertex -6.234898e-02 -7.818315e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex -5.877853e-02 -8.090170e-02 1.000000e-01 + vertex -6.234898e-02 -7.818315e-02 8.000000e-02 + vertex -5.877853e-02 -8.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 -8.220021e-01 -0.000000e+00 + outer loop + vertex -5.508970e-02 -8.345733e-02 1.000000e-01 + vertex -5.877853e-02 -8.090170e-02 1.000000e-01 + vertex -5.877853e-02 -8.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex -5.508970e-02 -8.345733e-02 1.000000e-01 + vertex -5.877853e-02 -8.090170e-02 8.000000e-02 + vertex -5.508970e-02 -8.345733e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 -8.467242e-01 -0.000000e+00 + outer loop + vertex -5.128993e-02 -8.584488e-02 1.000000e-01 + vertex -5.508970e-02 -8.345733e-02 1.000000e-01 + vertex -5.508970e-02 -8.345733e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex -5.128993e-02 -8.584488e-02 1.000000e-01 + vertex -5.508970e-02 -8.345733e-02 8.000000e-02 + vertex -5.128993e-02 -8.584488e-02 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex 9.989931e-02 4.486483e-03 1.000000e-01 + vertex 1.000000e-01 0.000000e+00 8.000000e-02 + vertex 9.989931e-02 4.486483e-03 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex 9.989931e-02 4.486483e-03 1.000000e-01 + vertex 1.000000e-01 0.000000e+00 1.000000e-01 + vertex 1.000000e-01 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 -8.697411e-01 -0.000000e+00 + outer loop + vertex -4.738687e-02 -8.805955e-02 1.000000e-01 + vertex -5.128993e-02 -8.584488e-02 1.000000e-01 + vertex -5.128993e-02 -8.584488e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex -4.738687e-02 -8.805955e-02 1.000000e-01 + vertex -5.128993e-02 -8.584488e-02 8.000000e-02 + vertex -4.738687e-02 -8.805955e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex 9.959743e-02 8.963931e-03 1.000000e-01 + vertex 9.989931e-02 4.486483e-03 8.000000e-02 + vertex 9.959743e-02 8.963931e-03 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex 9.959743e-02 8.963931e-03 1.000000e-01 + vertex 9.989931e-02 4.486483e-03 1.000000e-01 + vertex 9.989931e-02 4.486483e-03 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 -8.910065e-01 -0.000000e+00 + outer loop + vertex -4.338837e-02 -9.009689e-02 1.000000e-01 + vertex -4.738687e-02 -8.805955e-02 1.000000e-01 + vertex -4.738687e-02 -8.805955e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex -4.338837e-02 -9.009689e-02 1.000000e-01 + vertex -4.738687e-02 -8.805955e-02 8.000000e-02 + vertex -4.338837e-02 -9.009689e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex 9.909498e-02 1.342333e-02 1.000000e-01 + vertex 9.959743e-02 8.963931e-03 8.000000e-02 + vertex 9.909498e-02 1.342333e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex 9.909498e-02 1.342333e-02 1.000000e-01 + vertex 9.959743e-02 8.963931e-03 1.000000e-01 + vertex 9.959743e-02 8.963931e-03 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 -9.104775e-01 -0.000000e+00 + outer loop + vertex -3.930250e-02 -9.195278e-02 1.000000e-01 + vertex -4.338837e-02 -9.009689e-02 1.000000e-01 + vertex -4.338837e-02 -9.009689e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex -3.930250e-02 -9.195278e-02 1.000000e-01 + vertex -4.338837e-02 -9.009689e-02 8.000000e-02 + vertex -3.930250e-02 -9.195278e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex 9.839296e-02 1.785569e-02 1.000000e-01 + vertex 9.909498e-02 1.342333e-02 1.000000e-01 + vertex 9.909498e-02 1.342333e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex 9.839296e-02 1.785569e-02 1.000000e-01 + vertex 9.909498e-02 1.342333e-02 8.000000e-02 + vertex 9.839296e-02 1.785569e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 -9.281150e-01 -0.000000e+00 + outer loop + vertex -3.513748e-02 -9.362349e-02 1.000000e-01 + vertex -3.930250e-02 -9.195278e-02 1.000000e-01 + vertex -3.930250e-02 -9.195278e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex -3.513748e-02 -9.362349e-02 1.000000e-01 + vertex -3.930250e-02 -9.195278e-02 8.000000e-02 + vertex -3.513748e-02 -9.362349e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex 9.749279e-02 2.225209e-02 1.000000e-01 + vertex 9.839296e-02 1.785569e-02 1.000000e-01 + vertex 9.839296e-02 1.785569e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex 9.749279e-02 2.225209e-02 1.000000e-01 + vertex 9.839296e-02 1.785569e-02 8.000000e-02 + vertex 9.749279e-02 2.225209e-02 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 -9.438833e-01 -0.000000e+00 + outer loop + vertex -3.090170e-02 -9.510565e-02 1.000000e-01 + vertex -3.513748e-02 -9.362349e-02 1.000000e-01 + vertex -3.513748e-02 -9.362349e-02 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex -3.090170e-02 -9.510565e-02 1.000000e-01 + vertex -3.513748e-02 -9.362349e-02 8.000000e-02 + vertex -3.090170e-02 -9.510565e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex 9.639629e-02 2.660368e-02 1.000000e-01 + vertex 9.749279e-02 2.225209e-02 8.000000e-02 + vertex 9.639629e-02 2.660368e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex 9.639629e-02 2.660368e-02 1.000000e-01 + vertex 9.749279e-02 2.225209e-02 1.000000e-01 + vertex 9.749279e-02 2.225209e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 -9.577508e-01 -0.000000e+00 + outer loop + vertex -2.660368e-02 -9.639629e-02 1.000000e-01 + vertex -3.090170e-02 -9.510565e-02 1.000000e-01 + vertex -3.090170e-02 -9.510565e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex 9.510565e-02 3.090170e-02 1.000000e-01 + vertex 9.639629e-02 2.660368e-02 8.000000e-02 + vertex 9.510565e-02 3.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex -2.660368e-02 -9.639629e-02 1.000000e-01 + vertex -3.090170e-02 -9.510565e-02 8.000000e-02 + vertex -2.660368e-02 -9.639629e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex 9.510565e-02 3.090170e-02 1.000000e-01 + vertex 9.639629e-02 2.660368e-02 1.000000e-01 + vertex 9.639629e-02 2.660368e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 -9.696895e-01 -0.000000e+00 + outer loop + vertex -2.225209e-02 -9.749279e-02 1.000000e-01 + vertex -2.660368e-02 -9.639629e-02 1.000000e-01 + vertex -2.660368e-02 -9.639629e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex 9.362349e-02 3.513748e-02 1.000000e-01 + vertex 9.510565e-02 3.090170e-02 1.000000e-01 + vertex 9.510565e-02 3.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex -2.225209e-02 -9.749279e-02 1.000000e-01 + vertex -2.660368e-02 -9.639629e-02 8.000000e-02 + vertex -2.225209e-02 -9.749279e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex 9.362349e-02 3.513748e-02 1.000000e-01 + vertex 9.510565e-02 3.090170e-02 8.000000e-02 + vertex 9.362349e-02 3.513748e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex -1.785569e-02 -9.839296e-02 1.000000e-01 + vertex -2.225209e-02 -9.749279e-02 8.000000e-02 + vertex -1.785569e-02 -9.839296e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 -9.796754e-01 -0.000000e+00 + outer loop + vertex -1.785569e-02 -9.839296e-02 1.000000e-01 + vertex -2.225209e-02 -9.749279e-02 1.000000e-01 + vertex -2.225209e-02 -9.749279e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex 9.195278e-02 3.930250e-02 1.000000e-01 + vertex 9.362349e-02 3.513748e-02 8.000000e-02 + vertex 9.195278e-02 3.930250e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex 9.195278e-02 3.930250e-02 1.000000e-01 + vertex 9.362349e-02 3.513748e-02 1.000000e-01 + vertex 9.362349e-02 3.513748e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex -1.342333e-02 -9.909498e-02 1.000000e-01 + vertex -1.785569e-02 -9.839296e-02 8.000000e-02 + vertex -1.342333e-02 -9.909498e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 -9.876883e-01 -0.000000e+00 + outer loop + vertex -1.342333e-02 -9.909498e-02 1.000000e-01 + vertex -1.785569e-02 -9.839296e-02 1.000000e-01 + vertex -1.785569e-02 -9.839296e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex 9.009689e-02 4.338837e-02 1.000000e-01 + vertex 9.195278e-02 3.930250e-02 8.000000e-02 + vertex 9.009689e-02 4.338837e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex 9.009689e-02 4.338837e-02 1.000000e-01 + vertex 9.195278e-02 3.930250e-02 1.000000e-01 + vertex 9.195278e-02 3.930250e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex -8.963931e-03 -9.959743e-02 1.000000e-01 + vertex -1.342333e-02 -9.909498e-02 8.000000e-02 + vertex -8.963931e-03 -9.959743e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 -9.937122e-01 -0.000000e+00 + outer loop + vertex -8.963931e-03 -9.959743e-02 1.000000e-01 + vertex -1.342333e-02 -9.909498e-02 1.000000e-01 + vertex -1.342333e-02 -9.909498e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex 8.805955e-02 4.738687e-02 1.000000e-01 + vertex 9.009689e-02 4.338837e-02 8.000000e-02 + vertex 8.805955e-02 4.738687e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex 8.805955e-02 4.738687e-02 1.000000e-01 + vertex 9.009689e-02 4.338837e-02 1.000000e-01 + vertex 9.009689e-02 4.338837e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex -4.486483e-03 -9.989931e-02 1.000000e-01 + vertex -8.963931e-03 -9.959743e-02 8.000000e-02 + vertex -4.486483e-03 -9.989931e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 -9.977349e-01 -0.000000e+00 + outer loop + vertex -4.486483e-03 -9.989931e-02 1.000000e-01 + vertex -8.963931e-03 -9.959743e-02 1.000000e-01 + vertex -8.963931e-03 -9.959743e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex 8.584488e-02 5.128993e-02 1.000000e-01 + vertex 8.805955e-02 4.738687e-02 8.000000e-02 + vertex 8.584488e-02 5.128993e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex 8.584488e-02 5.128993e-02 1.000000e-01 + vertex 8.805955e-02 4.738687e-02 1.000000e-01 + vertex 8.805955e-02 4.738687e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex -1.836970e-17 -1.000000e-01 1.000000e-01 + vertex -4.486483e-03 -9.989931e-02 8.000000e-02 + vertex -1.836970e-17 -1.000000e-01 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 -9.997482e-01 -0.000000e+00 + outer loop + vertex -1.836970e-17 -1.000000e-01 1.000000e-01 + vertex -4.486483e-03 -9.989931e-02 1.000000e-01 + vertex -4.486483e-03 -9.989931e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex 8.345733e-02 5.508970e-02 1.000000e-01 + vertex 8.584488e-02 5.128993e-02 8.000000e-02 + vertex 8.345733e-02 5.508970e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex 8.345733e-02 5.508970e-02 1.000000e-01 + vertex 8.584488e-02 5.128993e-02 1.000000e-01 + vertex 8.584488e-02 5.128993e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex 4.486483e-03 -9.989931e-02 1.000000e-01 + vertex -1.836970e-17 -1.000000e-01 8.000000e-02 + vertex 4.486483e-03 -9.989931e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 -9.997482e-01 0.000000e+00 + outer loop + vertex 4.486483e-03 -9.989931e-02 1.000000e-01 + vertex -1.836970e-17 -1.000000e-01 1.000000e-01 + vertex -1.836970e-17 -1.000000e-01 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex 8.090170e-02 5.877853e-02 1.000000e-01 + vertex 8.345733e-02 5.508970e-02 8.000000e-02 + vertex 8.090170e-02 5.877853e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex 8.963931e-03 -9.959743e-02 1.000000e-01 + vertex 4.486483e-03 -9.989931e-02 1.000000e-01 + vertex 4.486483e-03 -9.989931e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex 8.090170e-02 5.877853e-02 1.000000e-01 + vertex 8.345733e-02 5.508970e-02 1.000000e-01 + vertex 8.345733e-02 5.508970e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 -9.977349e-01 0.000000e+00 + outer loop + vertex 8.963931e-03 -9.959743e-02 1.000000e-01 + vertex 4.486483e-03 -9.989931e-02 8.000000e-02 + vertex 8.963931e-03 -9.959743e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex 7.818315e-02 6.234898e-02 1.000000e-01 + vertex 8.090170e-02 5.877853e-02 8.000000e-02 + vertex 7.818315e-02 6.234898e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex 1.342333e-02 -9.909498e-02 1.000000e-01 + vertex 8.963931e-03 -9.959743e-02 8.000000e-02 + vertex 1.342333e-02 -9.909498e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex 7.818315e-02 6.234898e-02 1.000000e-01 + vertex 8.090170e-02 5.877853e-02 1.000000e-01 + vertex 8.090170e-02 5.877853e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 -9.937122e-01 0.000000e+00 + outer loop + vertex 1.342333e-02 -9.909498e-02 1.000000e-01 + vertex 8.963931e-03 -9.959743e-02 1.000000e-01 + vertex 8.963931e-03 -9.959743e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex 7.530715e-02 6.579387e-02 1.000000e-01 + vertex 7.818315e-02 6.234898e-02 8.000000e-02 + vertex 7.530715e-02 6.579387e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex 1.785569e-02 -9.839296e-02 1.000000e-01 + vertex 1.342333e-02 -9.909498e-02 8.000000e-02 + vertex 1.785569e-02 -9.839296e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex 7.530715e-02 6.579387e-02 1.000000e-01 + vertex 7.818315e-02 6.234898e-02 1.000000e-01 + vertex 7.818315e-02 6.234898e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 -9.876883e-01 0.000000e+00 + outer loop + vertex 1.785569e-02 -9.839296e-02 1.000000e-01 + vertex 1.342333e-02 -9.909498e-02 1.000000e-01 + vertex 1.342333e-02 -9.909498e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex 2.225209e-02 -9.749279e-02 1.000000e-01 + vertex 1.785569e-02 -9.839296e-02 8.000000e-02 + vertex 2.225209e-02 -9.749279e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex 7.227949e-02 6.910626e-02 1.000000e-01 + vertex 7.530715e-02 6.579387e-02 8.000000e-02 + vertex 7.227949e-02 6.910626e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 -9.796754e-01 0.000000e+00 + outer loop + vertex 2.225209e-02 -9.749279e-02 1.000000e-01 + vertex 1.785569e-02 -9.839296e-02 1.000000e-01 + vertex 1.785569e-02 -9.839296e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex 7.227949e-02 6.910626e-02 1.000000e-01 + vertex 7.530715e-02 6.579387e-02 1.000000e-01 + vertex 7.530715e-02 6.579387e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex 2.660368e-02 -9.639629e-02 1.000000e-01 + vertex 2.225209e-02 -9.749279e-02 8.000000e-02 + vertex 2.660368e-02 -9.639629e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex 6.910626e-02 7.227949e-02 1.000000e-01 + vertex 7.227949e-02 6.910626e-02 8.000000e-02 + vertex 6.910626e-02 7.227949e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 -9.696895e-01 0.000000e+00 + outer loop + vertex 2.660368e-02 -9.639629e-02 1.000000e-01 + vertex 2.225209e-02 -9.749279e-02 1.000000e-01 + vertex 2.225209e-02 -9.749279e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex 6.910626e-02 7.227949e-02 1.000000e-01 + vertex 7.227949e-02 6.910626e-02 1.000000e-01 + vertex 7.227949e-02 6.910626e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex 3.090170e-02 -9.510565e-02 1.000000e-01 + vertex 2.660368e-02 -9.639629e-02 8.000000e-02 + vertex 3.090170e-02 -9.510565e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex 6.579387e-02 7.530715e-02 1.000000e-01 + vertex 6.910626e-02 7.227949e-02 8.000000e-02 + vertex 6.579387e-02 7.530715e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 -9.577508e-01 0.000000e+00 + outer loop + vertex 3.090170e-02 -9.510565e-02 1.000000e-01 + vertex 2.660368e-02 -9.639629e-02 1.000000e-01 + vertex 2.660368e-02 -9.639629e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex 6.579387e-02 7.530715e-02 1.000000e-01 + vertex 6.910626e-02 7.227949e-02 1.000000e-01 + vertex 6.910626e-02 7.227949e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex 3.513748e-02 -9.362349e-02 1.000000e-01 + vertex 3.090170e-02 -9.510565e-02 8.000000e-02 + vertex 3.513748e-02 -9.362349e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 -9.438833e-01 0.000000e+00 + outer loop + vertex 3.513748e-02 -9.362349e-02 1.000000e-01 + vertex 3.090170e-02 -9.510565e-02 1.000000e-01 + vertex 3.090170e-02 -9.510565e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex 6.234898e-02 7.818315e-02 1.000000e-01 + vertex 6.579387e-02 7.530715e-02 8.000000e-02 + vertex 6.234898e-02 7.818315e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex 6.234898e-02 7.818315e-02 1.000000e-01 + vertex 6.579387e-02 7.530715e-02 1.000000e-01 + vertex 6.579387e-02 7.530715e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex 3.930250e-02 -9.195278e-02 1.000000e-01 + vertex 3.513748e-02 -9.362349e-02 8.000000e-02 + vertex 3.930250e-02 -9.195278e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 -9.281150e-01 0.000000e+00 + outer loop + vertex 3.930250e-02 -9.195278e-02 1.000000e-01 + vertex 3.513748e-02 -9.362349e-02 1.000000e-01 + vertex 3.513748e-02 -9.362349e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex 5.877853e-02 8.090170e-02 1.000000e-01 + vertex 6.234898e-02 7.818315e-02 8.000000e-02 + vertex 5.877853e-02 8.090170e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex 5.877853e-02 8.090170e-02 1.000000e-01 + vertex 6.234898e-02 7.818315e-02 1.000000e-01 + vertex 6.234898e-02 7.818315e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex 4.338837e-02 -9.009689e-02 1.000000e-01 + vertex 3.930250e-02 -9.195278e-02 8.000000e-02 + vertex 4.338837e-02 -9.009689e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 -9.104775e-01 0.000000e+00 + outer loop + vertex 4.338837e-02 -9.009689e-02 1.000000e-01 + vertex 3.930250e-02 -9.195278e-02 1.000000e-01 + vertex 3.930250e-02 -9.195278e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex 5.508970e-02 8.345733e-02 1.000000e-01 + vertex 5.877853e-02 8.090170e-02 8.000000e-02 + vertex 5.508970e-02 8.345733e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex 5.508970e-02 8.345733e-02 1.000000e-01 + vertex 5.877853e-02 8.090170e-02 1.000000e-01 + vertex 5.877853e-02 8.090170e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex 4.738687e-02 -8.805955e-02 1.000000e-01 + vertex 4.338837e-02 -9.009689e-02 8.000000e-02 + vertex 4.738687e-02 -8.805955e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 -8.910065e-01 0.000000e+00 + outer loop + vertex 4.738687e-02 -8.805955e-02 1.000000e-01 + vertex 4.338837e-02 -9.009689e-02 1.000000e-01 + vertex 4.338837e-02 -9.009689e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex 5.128993e-02 8.584488e-02 1.000000e-01 + vertex 5.508970e-02 8.345733e-02 8.000000e-02 + vertex 5.128993e-02 8.584488e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex 5.128993e-02 8.584488e-02 1.000000e-01 + vertex 5.508970e-02 8.345733e-02 1.000000e-01 + vertex 5.508970e-02 8.345733e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex 5.128993e-02 -8.584488e-02 1.000000e-01 + vertex 4.738687e-02 -8.805955e-02 8.000000e-02 + vertex 5.128993e-02 -8.584488e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 -8.697411e-01 0.000000e+00 + outer loop + vertex 5.128993e-02 -8.584488e-02 1.000000e-01 + vertex 4.738687e-02 -8.805955e-02 1.000000e-01 + vertex 4.738687e-02 -8.805955e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex 4.738687e-02 8.805955e-02 1.000000e-01 + vertex 5.128993e-02 8.584488e-02 8.000000e-02 + vertex 4.738687e-02 8.805955e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex 5.508970e-02 -8.345733e-02 1.000000e-01 + vertex 5.128993e-02 -8.584488e-02 8.000000e-02 + vertex 5.508970e-02 -8.345733e-02 8.000000e-02 + endloop + endfacet + facet normal 4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex 4.738687e-02 8.805955e-02 1.000000e-01 + vertex 5.128993e-02 8.584488e-02 1.000000e-01 + vertex 5.128993e-02 8.584488e-02 8.000000e-02 + endloop + endfacet + facet normal 5.320321e-01 -8.467242e-01 0.000000e+00 + outer loop + vertex 5.508970e-02 -8.345733e-02 1.000000e-01 + vertex 5.128993e-02 -8.584488e-02 1.000000e-01 + vertex 5.128993e-02 -8.584488e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex 4.338837e-02 9.009689e-02 1.000000e-01 + vertex 4.738687e-02 8.805955e-02 8.000000e-02 + vertex 4.338837e-02 9.009689e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex 5.877853e-02 -8.090170e-02 1.000000e-01 + vertex 5.508970e-02 -8.345733e-02 8.000000e-02 + vertex 5.877853e-02 -8.090170e-02 8.000000e-02 + endloop + endfacet + facet normal 4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex 4.338837e-02 9.009689e-02 1.000000e-01 + vertex 4.738687e-02 8.805955e-02 1.000000e-01 + vertex 4.738687e-02 8.805955e-02 8.000000e-02 + endloop + endfacet + facet normal 5.694845e-01 -8.220021e-01 0.000000e+00 + outer loop + vertex 5.877853e-02 -8.090170e-02 1.000000e-01 + vertex 5.508970e-02 -8.345733e-02 1.000000e-01 + vertex 5.508970e-02 -8.345733e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex 3.930250e-02 9.195278e-02 1.000000e-01 + vertex 4.338837e-02 9.009689e-02 8.000000e-02 + vertex 3.930250e-02 9.195278e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex 6.234898e-02 -7.818315e-02 1.000000e-01 + vertex 5.877853e-02 -8.090170e-02 8.000000e-02 + vertex 6.234898e-02 -7.818315e-02 8.000000e-02 + endloop + endfacet + facet normal 4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex 3.930250e-02 9.195278e-02 1.000000e-01 + vertex 4.338837e-02 9.009689e-02 1.000000e-01 + vertex 4.338837e-02 9.009689e-02 8.000000e-02 + endloop + endfacet + facet normal 6.057900e-01 -7.956245e-01 0.000000e+00 + outer loop + vertex 6.234898e-02 -7.818315e-02 1.000000e-01 + vertex 5.877853e-02 -8.090170e-02 1.000000e-01 + vertex 5.877853e-02 -8.090170e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex 6.579387e-02 -7.530715e-02 1.000000e-01 + vertex 6.234898e-02 -7.818315e-02 8.000000e-02 + vertex 6.579387e-02 -7.530715e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex 3.513748e-02 9.362349e-02 1.000000e-01 + vertex 3.930250e-02 9.195278e-02 8.000000e-02 + vertex 3.513748e-02 9.362349e-02 8.000000e-02 + endloop + endfacet + facet normal 6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex 6.579387e-02 -7.530715e-02 1.000000e-01 + vertex 6.234898e-02 -7.818315e-02 1.000000e-01 + vertex 6.234898e-02 -7.818315e-02 8.000000e-02 + endloop + endfacet + facet normal 3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex 3.513748e-02 9.362349e-02 1.000000e-01 + vertex 3.930250e-02 9.195278e-02 1.000000e-01 + vertex 3.930250e-02 9.195278e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex 6.910626e-02 -7.227949e-02 1.000000e-01 + vertex 6.579387e-02 -7.530715e-02 8.000000e-02 + vertex 6.910626e-02 -7.227949e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex 3.090170e-02 9.510565e-02 1.000000e-01 + vertex 3.513748e-02 9.362349e-02 8.000000e-02 + vertex 3.090170e-02 9.510565e-02 8.000000e-02 + endloop + endfacet + facet normal 6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex 6.910626e-02 -7.227949e-02 1.000000e-01 + vertex 6.579387e-02 -7.530715e-02 1.000000e-01 + vertex 6.579387e-02 -7.530715e-02 8.000000e-02 + endloop + endfacet + facet normal 3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex 3.090170e-02 9.510565e-02 1.000000e-01 + vertex 3.513748e-02 9.362349e-02 1.000000e-01 + vertex 3.513748e-02 9.362349e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex 7.227949e-02 -6.910626e-02 1.000000e-01 + vertex 6.910626e-02 -7.227949e-02 8.000000e-02 + vertex 7.227949e-02 -6.910626e-02 8.000000e-02 + endloop + endfacet + facet normal 7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex 7.227949e-02 -6.910626e-02 1.000000e-01 + vertex 6.910626e-02 -7.227949e-02 1.000000e-01 + vertex 6.910626e-02 -7.227949e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex 2.660368e-02 9.639629e-02 1.000000e-01 + vertex 3.090170e-02 9.510565e-02 8.000000e-02 + vertex 2.660368e-02 9.639629e-02 8.000000e-02 + endloop + endfacet + facet normal 2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex 2.660368e-02 9.639629e-02 1.000000e-01 + vertex 3.090170e-02 9.510565e-02 1.000000e-01 + vertex 3.090170e-02 9.510565e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex 7.530715e-02 -6.579387e-02 1.000000e-01 + vertex 7.227949e-02 -6.910626e-02 8.000000e-02 + vertex 7.530715e-02 -6.579387e-02 8.000000e-02 + endloop + endfacet + facet normal 7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex 7.530715e-02 -6.579387e-02 1.000000e-01 + vertex 7.227949e-02 -6.910626e-02 1.000000e-01 + vertex 7.227949e-02 -6.910626e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex 2.225209e-02 9.749279e-02 1.000000e-01 + vertex 2.660368e-02 9.639629e-02 1.000000e-01 + vertex 2.660368e-02 9.639629e-02 8.000000e-02 + endloop + endfacet + facet normal 2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex 2.225209e-02 9.749279e-02 1.000000e-01 + vertex 2.660368e-02 9.639629e-02 8.000000e-02 + vertex 2.225209e-02 9.749279e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex 7.818315e-02 -6.234898e-02 1.000000e-01 + vertex 7.530715e-02 -6.579387e-02 8.000000e-02 + vertex 7.818315e-02 -6.234898e-02 8.000000e-02 + endloop + endfacet + facet normal 7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex 7.818315e-02 -6.234898e-02 1.000000e-01 + vertex 7.530715e-02 -6.579387e-02 1.000000e-01 + vertex 7.530715e-02 -6.579387e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex 1.785569e-02 9.839296e-02 1.000000e-01 + vertex 2.225209e-02 9.749279e-02 1.000000e-01 + vertex 2.225209e-02 9.749279e-02 8.000000e-02 + endloop + endfacet + facet normal 2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex 1.785569e-02 9.839296e-02 1.000000e-01 + vertex 2.225209e-02 9.749279e-02 8.000000e-02 + vertex 1.785569e-02 9.839296e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex 8.090170e-02 -5.877853e-02 1.000000e-01 + vertex 7.818315e-02 -6.234898e-02 8.000000e-02 + vertex 8.090170e-02 -5.877853e-02 8.000000e-02 + endloop + endfacet + facet normal 7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex 8.090170e-02 -5.877853e-02 1.000000e-01 + vertex 7.818315e-02 -6.234898e-02 1.000000e-01 + vertex 7.818315e-02 -6.234898e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex 1.342333e-02 9.909498e-02 1.000000e-01 + vertex 1.785569e-02 9.839296e-02 1.000000e-01 + vertex 1.785569e-02 9.839296e-02 8.000000e-02 + endloop + endfacet + facet normal 1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex 1.342333e-02 9.909498e-02 1.000000e-01 + vertex 1.785569e-02 9.839296e-02 8.000000e-02 + vertex 1.342333e-02 9.909498e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex 8.345733e-02 -5.508970e-02 1.000000e-01 + vertex 8.090170e-02 -5.877853e-02 8.000000e-02 + vertex 8.345733e-02 -5.508970e-02 8.000000e-02 + endloop + endfacet + facet normal 8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex 8.345733e-02 -5.508970e-02 1.000000e-01 + vertex 8.090170e-02 -5.877853e-02 1.000000e-01 + vertex 8.090170e-02 -5.877853e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex 8.963931e-03 9.959743e-02 1.000000e-01 + vertex 1.342333e-02 9.909498e-02 1.000000e-01 + vertex 1.342333e-02 9.909498e-02 8.000000e-02 + endloop + endfacet + facet normal 1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex 8.963931e-03 9.959743e-02 1.000000e-01 + vertex 1.342333e-02 9.909498e-02 8.000000e-02 + vertex 8.963931e-03 9.959743e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex 8.584488e-02 -5.128993e-02 1.000000e-01 + vertex 8.345733e-02 -5.508970e-02 8.000000e-02 + vertex 8.584488e-02 -5.128993e-02 8.000000e-02 + endloop + endfacet + facet normal 8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex 8.584488e-02 -5.128993e-02 1.000000e-01 + vertex 8.345733e-02 -5.508970e-02 1.000000e-01 + vertex 8.345733e-02 -5.508970e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex 4.486483e-03 9.989931e-02 1.000000e-01 + vertex 8.963931e-03 9.959743e-02 1.000000e-01 + vertex 8.963931e-03 9.959743e-02 8.000000e-02 + endloop + endfacet + facet normal 6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex 4.486483e-03 9.989931e-02 1.000000e-01 + vertex 8.963931e-03 9.959743e-02 8.000000e-02 + vertex 4.486483e-03 9.989931e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex 8.805955e-02 -4.738687e-02 1.000000e-01 + vertex 8.584488e-02 -5.128993e-02 8.000000e-02 + vertex 8.805955e-02 -4.738687e-02 8.000000e-02 + endloop + endfacet + facet normal 8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex 8.805955e-02 -4.738687e-02 1.000000e-01 + vertex 8.584488e-02 -5.128993e-02 1.000000e-01 + vertex 8.584488e-02 -5.128993e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex 6.123234e-18 1.000000e-01 1.000000e-01 + vertex 4.486483e-03 9.989931e-02 1.000000e-01 + vertex 4.486483e-03 9.989931e-02 8.000000e-02 + endloop + endfacet + facet normal 2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex 6.123234e-18 1.000000e-01 1.000000e-01 + vertex 4.486483e-03 9.989931e-02 8.000000e-02 + vertex 6.123234e-18 1.000000e-01 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex 9.009689e-02 -4.338837e-02 1.000000e-01 + vertex 8.805955e-02 -4.738687e-02 1.000000e-01 + vertex 8.805955e-02 -4.738687e-02 8.000000e-02 + endloop + endfacet + facet normal 8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex 9.009689e-02 -4.338837e-02 1.000000e-01 + vertex 8.805955e-02 -4.738687e-02 8.000000e-02 + vertex 9.009689e-02 -4.338837e-02 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex 9.195278e-02 -3.930250e-02 1.000000e-01 + vertex 9.009689e-02 -4.338837e-02 1.000000e-01 + vertex 9.009689e-02 -4.338837e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex -4.486483e-03 9.989931e-02 1.000000e-01 + vertex 6.123234e-18 1.000000e-01 1.000000e-01 + vertex 6.123234e-18 1.000000e-01 8.000000e-02 + endloop + endfacet + facet normal 9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex 9.195278e-02 -3.930250e-02 1.000000e-01 + vertex 9.009689e-02 -4.338837e-02 8.000000e-02 + vertex 9.195278e-02 -3.930250e-02 8.000000e-02 + endloop + endfacet + facet normal -2.243806e-02 9.997482e-01 0.000000e+00 + outer loop + vertex -4.486483e-03 9.989931e-02 1.000000e-01 + vertex 6.123234e-18 1.000000e-01 8.000000e-02 + vertex -4.486483e-03 9.989931e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex 9.362349e-02 -3.513748e-02 1.000000e-01 + vertex 9.195278e-02 -3.930250e-02 1.000000e-01 + vertex 9.195278e-02 -3.930250e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex -8.963931e-03 9.959743e-02 1.000000e-01 + vertex -4.486483e-03 9.989931e-02 1.000000e-01 + vertex -4.486483e-03 9.989931e-02 8.000000e-02 + endloop + endfacet + facet normal 9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex 9.362349e-02 -3.513748e-02 1.000000e-01 + vertex 9.195278e-02 -3.930250e-02 8.000000e-02 + vertex 9.362349e-02 -3.513748e-02 8.000000e-02 + endloop + endfacet + facet normal -6.726901e-02 9.977349e-01 0.000000e+00 + outer loop + vertex -8.963931e-03 9.959743e-02 1.000000e-01 + vertex -4.486483e-03 9.989931e-02 8.000000e-02 + vertex -8.963931e-03 9.959743e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex 9.510565e-02 -3.090170e-02 1.000000e-01 + vertex 9.362349e-02 -3.513748e-02 1.000000e-01 + vertex 9.362349e-02 -3.513748e-02 8.000000e-02 + endloop + endfacet + facet normal 9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex 9.510565e-02 -3.090170e-02 1.000000e-01 + vertex 9.362349e-02 -3.513748e-02 8.000000e-02 + vertex 9.510565e-02 -3.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex -1.342333e-02 9.909498e-02 1.000000e-01 + vertex -8.963931e-03 9.959743e-02 1.000000e-01 + vertex -8.963931e-03 9.959743e-02 8.000000e-02 + endloop + endfacet + facet normal -1.119645e-01 9.937122e-01 0.000000e+00 + outer loop + vertex -1.342333e-02 9.909498e-02 1.000000e-01 + vertex -8.963931e-03 9.959743e-02 8.000000e-02 + vertex -1.342333e-02 9.909498e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex 9.639629e-02 -2.660368e-02 1.000000e-01 + vertex 9.510565e-02 -3.090170e-02 1.000000e-01 + vertex 9.510565e-02 -3.090170e-02 8.000000e-02 + endloop + endfacet + facet normal 9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex 9.639629e-02 -2.660368e-02 1.000000e-01 + vertex 9.510565e-02 -3.090170e-02 8.000000e-02 + vertex 9.639629e-02 -2.660368e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex -1.785569e-02 9.839296e-02 1.000000e-01 + vertex -1.342333e-02 9.909498e-02 8.000000e-02 + vertex -1.785569e-02 9.839296e-02 8.000000e-02 + endloop + endfacet + facet normal -1.564345e-01 9.876883e-01 0.000000e+00 + outer loop + vertex -1.785569e-02 9.839296e-02 1.000000e-01 + vertex -1.342333e-02 9.909498e-02 1.000000e-01 + vertex -1.342333e-02 9.909498e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex 9.749279e-02 -2.225209e-02 1.000000e-01 + vertex 9.639629e-02 -2.660368e-02 1.000000e-01 + vertex 9.639629e-02 -2.660368e-02 8.000000e-02 + endloop + endfacet + facet normal 9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex 9.749279e-02 -2.225209e-02 1.000000e-01 + vertex 9.639629e-02 -2.660368e-02 8.000000e-02 + vertex 9.749279e-02 -2.225209e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex -2.225209e-02 9.749279e-02 1.000000e-01 + vertex -1.785569e-02 9.839296e-02 8.000000e-02 + vertex -2.225209e-02 9.749279e-02 8.000000e-02 + endloop + endfacet + facet normal -2.005894e-01 9.796754e-01 0.000000e+00 + outer loop + vertex -2.225209e-02 9.749279e-02 1.000000e-01 + vertex -1.785569e-02 9.839296e-02 1.000000e-01 + vertex -1.785569e-02 9.839296e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex 9.839296e-02 -1.785569e-02 1.000000e-01 + vertex 9.749279e-02 -2.225209e-02 1.000000e-01 + vertex 9.749279e-02 -2.225209e-02 8.000000e-02 + endloop + endfacet + facet normal 9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex 9.839296e-02 -1.785569e-02 1.000000e-01 + vertex 9.749279e-02 -2.225209e-02 8.000000e-02 + vertex 9.839296e-02 -1.785569e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex -2.660368e-02 9.639629e-02 1.000000e-01 + vertex -2.225209e-02 9.749279e-02 8.000000e-02 + vertex -2.660368e-02 9.639629e-02 8.000000e-02 + endloop + endfacet + facet normal -2.443404e-01 9.696895e-01 0.000000e+00 + outer loop + vertex -2.660368e-02 9.639629e-02 1.000000e-01 + vertex -2.225209e-02 9.749279e-02 1.000000e-01 + vertex -2.225209e-02 9.749279e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex 9.909498e-02 -1.342333e-02 1.000000e-01 + vertex 9.839296e-02 -1.785569e-02 1.000000e-01 + vertex 9.839296e-02 -1.785569e-02 8.000000e-02 + endloop + endfacet + facet normal 9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex 9.909498e-02 -1.342333e-02 1.000000e-01 + vertex 9.839296e-02 -1.785569e-02 8.000000e-02 + vertex 9.909498e-02 -1.342333e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex -3.090170e-02 9.510565e-02 1.000000e-01 + vertex -2.660368e-02 9.639629e-02 8.000000e-02 + vertex -3.090170e-02 9.510565e-02 8.000000e-02 + endloop + endfacet + facet normal -2.875993e-01 9.577508e-01 0.000000e+00 + outer loop + vertex -3.090170e-02 9.510565e-02 1.000000e-01 + vertex -2.660368e-02 9.639629e-02 1.000000e-01 + vertex -2.660368e-02 9.639629e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex 9.959743e-02 -8.963931e-03 1.000000e-01 + vertex 9.909498e-02 -1.342333e-02 1.000000e-01 + vertex 9.909498e-02 -1.342333e-02 8.000000e-02 + endloop + endfacet + facet normal 9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex 9.959743e-02 -8.963931e-03 1.000000e-01 + vertex 9.909498e-02 -1.342333e-02 8.000000e-02 + vertex 9.959743e-02 -8.963931e-03 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex -3.513748e-02 9.362349e-02 1.000000e-01 + vertex -3.090170e-02 9.510565e-02 8.000000e-02 + vertex -3.513748e-02 9.362349e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex 9.989931e-02 -4.486483e-03 1.000000e-01 + vertex 9.959743e-02 -8.963931e-03 1.000000e-01 + vertex 9.959743e-02 -8.963931e-03 8.000000e-02 + endloop + endfacet + facet normal -3.302791e-01 9.438833e-01 0.000000e+00 + outer loop + vertex -3.513748e-02 9.362349e-02 1.000000e-01 + vertex -3.090170e-02 9.510565e-02 1.000000e-01 + vertex -3.090170e-02 9.510565e-02 8.000000e-02 + endloop + endfacet + facet normal 9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex 9.989931e-02 -4.486483e-03 1.000000e-01 + vertex 9.959743e-02 -8.963931e-03 8.000000e-02 + vertex 9.989931e-02 -4.486483e-03 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex 1.000000e-01 0.000000e+00 1.000000e-01 + vertex 9.989931e-02 -4.486483e-03 8.000000e-02 + vertex 1.000000e-01 0.000000e+00 8.000000e-02 + endloop + endfacet + facet normal 9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex 1.000000e-01 0.000000e+00 1.000000e-01 + vertex 9.989931e-02 -4.486483e-03 1.000000e-01 + vertex 9.989931e-02 -4.486483e-03 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex -3.930250e-02 9.195278e-02 1.000000e-01 + vertex -3.513748e-02 9.362349e-02 8.000000e-02 + vertex -3.930250e-02 9.195278e-02 8.000000e-02 + endloop + endfacet + facet normal -3.722937e-01 9.281150e-01 0.000000e+00 + outer loop + vertex -3.930250e-02 9.195278e-02 1.000000e-01 + vertex -3.513748e-02 9.362349e-02 1.000000e-01 + vertex -3.513748e-02 9.362349e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex -4.338837e-02 9.009689e-02 1.000000e-01 + vertex -3.930250e-02 9.195278e-02 8.000000e-02 + vertex -4.338837e-02 9.009689e-02 8.000000e-02 + endloop + endfacet + facet normal -4.135585e-01 9.104775e-01 0.000000e+00 + outer loop + vertex -4.338837e-02 9.009689e-02 1.000000e-01 + vertex -3.930250e-02 9.195278e-02 1.000000e-01 + vertex -3.930250e-02 9.195278e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex -4.738687e-02 8.805955e-02 1.000000e-01 + vertex -4.338837e-02 9.009689e-02 8.000000e-02 + vertex -4.738687e-02 8.805955e-02 8.000000e-02 + endloop + endfacet + facet normal -4.539905e-01 8.910065e-01 0.000000e+00 + outer loop + vertex -4.738687e-02 8.805955e-02 1.000000e-01 + vertex -4.338837e-02 9.009689e-02 1.000000e-01 + vertex -4.338837e-02 9.009689e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex -5.128993e-02 8.584488e-02 1.000000e-01 + vertex -4.738687e-02 8.805955e-02 8.000000e-02 + vertex -5.128993e-02 8.584488e-02 8.000000e-02 + endloop + endfacet + facet normal -4.935082e-01 8.697411e-01 0.000000e+00 + outer loop + vertex -5.128993e-02 8.584488e-02 1.000000e-01 + vertex -4.738687e-02 8.805955e-02 1.000000e-01 + vertex -4.738687e-02 8.805955e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex -5.508970e-02 8.345733e-02 1.000000e-01 + vertex -5.128993e-02 8.584488e-02 8.000000e-02 + vertex -5.508970e-02 8.345733e-02 8.000000e-02 + endloop + endfacet + facet normal -5.320321e-01 8.467242e-01 0.000000e+00 + outer loop + vertex -5.508970e-02 8.345733e-02 1.000000e-01 + vertex -5.128993e-02 8.584488e-02 1.000000e-01 + vertex -5.128993e-02 8.584488e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex -5.877853e-02 8.090170e-02 1.000000e-01 + vertex -5.508970e-02 8.345733e-02 8.000000e-02 + vertex -5.877853e-02 8.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -5.694845e-01 8.220021e-01 0.000000e+00 + outer loop + vertex -5.877853e-02 8.090170e-02 1.000000e-01 + vertex -5.508970e-02 8.345733e-02 1.000000e-01 + vertex -5.508970e-02 8.345733e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex -6.234898e-02 7.818315e-02 1.000000e-01 + vertex -5.877853e-02 8.090170e-02 8.000000e-02 + vertex -6.234898e-02 7.818315e-02 8.000000e-02 + endloop + endfacet + facet normal -6.057900e-01 7.956245e-01 0.000000e+00 + outer loop + vertex -6.234898e-02 7.818315e-02 1.000000e-01 + vertex -5.877853e-02 8.090170e-02 1.000000e-01 + vertex -5.877853e-02 8.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex -6.579387e-02 7.530715e-02 1.000000e-01 + vertex -6.234898e-02 7.818315e-02 8.000000e-02 + vertex -6.579387e-02 7.530715e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 7.676447e-01 0.000000e+00 + outer loop + vertex -6.579387e-02 7.530715e-02 1.000000e-01 + vertex -6.234898e-02 7.818315e-02 1.000000e-01 + vertex -6.234898e-02 7.818315e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex -6.910626e-02 7.227949e-02 1.000000e-01 + vertex -6.579387e-02 7.530715e-02 8.000000e-02 + vertex -6.910626e-02 7.227949e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 7.381190e-01 0.000000e+00 + outer loop + vertex -6.910626e-02 7.227949e-02 1.000000e-01 + vertex -6.579387e-02 7.530715e-02 1.000000e-01 + vertex -6.579387e-02 7.530715e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex -7.227949e-02 6.910626e-02 1.000000e-01 + vertex -6.910626e-02 7.227949e-02 8.000000e-02 + vertex -7.227949e-02 6.910626e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex -7.227949e-02 6.910626e-02 1.000000e-01 + vertex -6.910626e-02 7.227949e-02 1.000000e-01 + vertex -6.910626e-02 7.227949e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex -7.530715e-02 6.579387e-02 1.000000e-01 + vertex -7.227949e-02 6.910626e-02 8.000000e-02 + vertex -7.530715e-02 6.579387e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 6.746705e-01 0.000000e+00 + outer loop + vertex -7.530715e-02 6.579387e-02 1.000000e-01 + vertex -7.227949e-02 6.910626e-02 1.000000e-01 + vertex -7.227949e-02 6.910626e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex -7.818315e-02 6.234898e-02 1.000000e-01 + vertex -7.530715e-02 6.579387e-02 1.000000e-01 + vertex -7.530715e-02 6.579387e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 6.408756e-01 0.000000e+00 + outer loop + vertex -7.818315e-02 6.234898e-02 1.000000e-01 + vertex -7.530715e-02 6.579387e-02 8.000000e-02 + vertex -7.818315e-02 6.234898e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex -8.090170e-02 5.877853e-02 1.000000e-01 + vertex -7.818315e-02 6.234898e-02 1.000000e-01 + vertex -7.818315e-02 6.234898e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 6.057900e-01 0.000000e+00 + outer loop + vertex -8.090170e-02 5.877853e-02 1.000000e-01 + vertex -7.818315e-02 6.234898e-02 8.000000e-02 + vertex -8.090170e-02 5.877853e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex -8.345733e-02 5.508970e-02 1.000000e-01 + vertex -8.090170e-02 5.877853e-02 1.000000e-01 + vertex -8.090170e-02 5.877853e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 5.694845e-01 0.000000e+00 + outer loop + vertex -8.345733e-02 5.508970e-02 1.000000e-01 + vertex -8.090170e-02 5.877853e-02 8.000000e-02 + vertex -8.345733e-02 5.508970e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex -8.584488e-02 5.128993e-02 1.000000e-01 + vertex -8.345733e-02 5.508970e-02 1.000000e-01 + vertex -8.345733e-02 5.508970e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 5.320321e-01 0.000000e+00 + outer loop + vertex -8.584488e-02 5.128993e-02 1.000000e-01 + vertex -8.345733e-02 5.508970e-02 8.000000e-02 + vertex -8.584488e-02 5.128993e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex -8.805955e-02 4.738687e-02 1.000000e-01 + vertex -8.584488e-02 5.128993e-02 1.000000e-01 + vertex -8.584488e-02 5.128993e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 4.935082e-01 0.000000e+00 + outer loop + vertex -8.805955e-02 4.738687e-02 1.000000e-01 + vertex -8.584488e-02 5.128993e-02 8.000000e-02 + vertex -8.805955e-02 4.738687e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex -9.009689e-02 4.338837e-02 1.000000e-01 + vertex -8.805955e-02 4.738687e-02 1.000000e-01 + vertex -8.805955e-02 4.738687e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 4.539905e-01 0.000000e+00 + outer loop + vertex -9.009689e-02 4.338837e-02 1.000000e-01 + vertex -8.805955e-02 4.738687e-02 8.000000e-02 + vertex -9.009689e-02 4.338837e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex -9.195278e-02 3.930250e-02 1.000000e-01 + vertex -9.009689e-02 4.338837e-02 1.000000e-01 + vertex -9.009689e-02 4.338837e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 4.135585e-01 0.000000e+00 + outer loop + vertex -9.195278e-02 3.930250e-02 1.000000e-01 + vertex -9.009689e-02 4.338837e-02 8.000000e-02 + vertex -9.195278e-02 3.930250e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex -9.362349e-02 3.513748e-02 1.000000e-01 + vertex -9.195278e-02 3.930250e-02 1.000000e-01 + vertex -9.195278e-02 3.930250e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 3.722937e-01 0.000000e+00 + outer loop + vertex -9.362349e-02 3.513748e-02 1.000000e-01 + vertex -9.195278e-02 3.930250e-02 8.000000e-02 + vertex -9.362349e-02 3.513748e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex -9.510565e-02 3.090170e-02 1.000000e-01 + vertex -9.362349e-02 3.513748e-02 1.000000e-01 + vertex -9.362349e-02 3.513748e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 3.302791e-01 0.000000e+00 + outer loop + vertex -9.510565e-02 3.090170e-02 1.000000e-01 + vertex -9.362349e-02 3.513748e-02 8.000000e-02 + vertex -9.510565e-02 3.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex -9.639629e-02 2.660368e-02 1.000000e-01 + vertex -9.510565e-02 3.090170e-02 1.000000e-01 + vertex -9.510565e-02 3.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 2.875993e-01 0.000000e+00 + outer loop + vertex -9.639629e-02 2.660368e-02 1.000000e-01 + vertex -9.510565e-02 3.090170e-02 8.000000e-02 + vertex -9.639629e-02 2.660368e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex -9.749279e-02 2.225209e-02 1.000000e-01 + vertex -9.639629e-02 2.660368e-02 1.000000e-01 + vertex -9.639629e-02 2.660368e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 2.443404e-01 0.000000e+00 + outer loop + vertex -9.749279e-02 2.225209e-02 1.000000e-01 + vertex -9.639629e-02 2.660368e-02 8.000000e-02 + vertex -9.749279e-02 2.225209e-02 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex -9.839296e-02 1.785569e-02 1.000000e-01 + vertex -9.749279e-02 2.225209e-02 1.000000e-01 + vertex -9.749279e-02 2.225209e-02 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 2.005894e-01 0.000000e+00 + outer loop + vertex -9.839296e-02 1.785569e-02 1.000000e-01 + vertex -9.749279e-02 2.225209e-02 8.000000e-02 + vertex -9.839296e-02 1.785569e-02 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex -9.909498e-02 1.342333e-02 1.000000e-01 + vertex -9.839296e-02 1.785569e-02 1.000000e-01 + vertex -9.839296e-02 1.785569e-02 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 1.564345e-01 0.000000e+00 + outer loop + vertex -9.909498e-02 1.342333e-02 1.000000e-01 + vertex -9.839296e-02 1.785569e-02 8.000000e-02 + vertex -9.909498e-02 1.342333e-02 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex -9.959743e-02 8.963931e-03 1.000000e-01 + vertex -9.909498e-02 1.342333e-02 1.000000e-01 + vertex -9.909498e-02 1.342333e-02 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 1.119645e-01 0.000000e+00 + outer loop + vertex -9.959743e-02 8.963931e-03 1.000000e-01 + vertex -9.909498e-02 1.342333e-02 8.000000e-02 + vertex -9.959743e-02 8.963931e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex -9.989931e-02 4.486483e-03 1.000000e-01 + vertex -9.959743e-02 8.963931e-03 1.000000e-01 + vertex -9.959743e-02 8.963931e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 6.726901e-02 0.000000e+00 + outer loop + vertex -9.989931e-02 4.486483e-03 1.000000e-01 + vertex -9.959743e-02 8.963931e-03 8.000000e-02 + vertex -9.989931e-02 4.486483e-03 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex -1.000000e-01 1.224647e-17 1.000000e-01 + vertex -9.989931e-02 4.486483e-03 1.000000e-01 + vertex -9.989931e-02 4.486483e-03 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 2.243806e-02 0.000000e+00 + outer loop + vertex -1.000000e-01 1.224647e-17 1.000000e-01 + vertex -9.989931e-02 4.486483e-03 8.000000e-02 + vertex -1.000000e-01 1.224647e-17 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 -2.243806e-02 -0.000000e+00 + outer loop + vertex -9.989931e-02 -4.486483e-03 1.000000e-01 + vertex -1.000000e-01 1.224647e-17 1.000000e-01 + vertex -1.000000e-01 1.224647e-17 8.000000e-02 + endloop + endfacet + facet normal -9.997482e-01 -2.243806e-02 0.000000e+00 + outer loop + vertex -9.989931e-02 -4.486483e-03 1.000000e-01 + vertex -1.000000e-01 1.224647e-17 8.000000e-02 + vertex -9.989931e-02 -4.486483e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 -6.726901e-02 0.000000e+00 + outer loop + vertex -9.959743e-02 -8.963931e-03 1.000000e-01 + vertex -9.989931e-02 -4.486483e-03 8.000000e-02 + vertex -9.959743e-02 -8.963931e-03 8.000000e-02 + endloop + endfacet + facet normal -9.977349e-01 -6.726901e-02 -0.000000e+00 + outer loop + vertex -9.959743e-02 -8.963931e-03 1.000000e-01 + vertex -9.989931e-02 -4.486483e-03 1.000000e-01 + vertex -9.989931e-02 -4.486483e-03 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 -1.119645e-01 0.000000e+00 + outer loop + vertex -9.909498e-02 -1.342333e-02 1.000000e-01 + vertex -9.959743e-02 -8.963931e-03 8.000000e-02 + vertex -9.909498e-02 -1.342333e-02 8.000000e-02 + endloop + endfacet + facet normal -9.937122e-01 -1.119645e-01 -0.000000e+00 + outer loop + vertex -9.909498e-02 -1.342333e-02 1.000000e-01 + vertex -9.959743e-02 -8.963931e-03 1.000000e-01 + vertex -9.959743e-02 -8.963931e-03 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 -1.564345e-01 -0.000000e+00 + outer loop + vertex -9.839296e-02 -1.785569e-02 1.000000e-01 + vertex -9.909498e-02 -1.342333e-02 1.000000e-01 + vertex -9.909498e-02 -1.342333e-02 8.000000e-02 + endloop + endfacet + facet normal -9.876883e-01 -1.564345e-01 0.000000e+00 + outer loop + vertex -9.839296e-02 -1.785569e-02 1.000000e-01 + vertex -9.909498e-02 -1.342333e-02 8.000000e-02 + vertex -9.839296e-02 -1.785569e-02 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 -2.005894e-01 0.000000e+00 + outer loop + vertex -9.749279e-02 -2.225209e-02 1.000000e-01 + vertex -9.839296e-02 -1.785569e-02 8.000000e-02 + vertex -9.749279e-02 -2.225209e-02 8.000000e-02 + endloop + endfacet + facet normal -9.796754e-01 -2.005894e-01 -0.000000e+00 + outer loop + vertex -9.749279e-02 -2.225209e-02 1.000000e-01 + vertex -9.839296e-02 -1.785569e-02 1.000000e-01 + vertex -9.839296e-02 -1.785569e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 -2.443404e-01 0.000000e+00 + outer loop + vertex -9.639629e-02 -2.660368e-02 1.000000e-01 + vertex -9.749279e-02 -2.225209e-02 8.000000e-02 + vertex -9.639629e-02 -2.660368e-02 8.000000e-02 + endloop + endfacet + facet normal -9.696895e-01 -2.443404e-01 -0.000000e+00 + outer loop + vertex -9.639629e-02 -2.660368e-02 1.000000e-01 + vertex -9.749279e-02 -2.225209e-02 1.000000e-01 + vertex -9.749279e-02 -2.225209e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 -2.875993e-01 0.000000e+00 + outer loop + vertex -9.510565e-02 -3.090170e-02 1.000000e-01 + vertex -9.639629e-02 -2.660368e-02 8.000000e-02 + vertex -9.510565e-02 -3.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -9.577508e-01 -2.875993e-01 -0.000000e+00 + outer loop + vertex -9.510565e-02 -3.090170e-02 1.000000e-01 + vertex -9.639629e-02 -2.660368e-02 1.000000e-01 + vertex -9.639629e-02 -2.660368e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 -3.302791e-01 0.000000e+00 + outer loop + vertex -9.362349e-02 -3.513748e-02 1.000000e-01 + vertex -9.510565e-02 -3.090170e-02 8.000000e-02 + vertex -9.362349e-02 -3.513748e-02 8.000000e-02 + endloop + endfacet + facet normal -9.438833e-01 -3.302791e-01 -0.000000e+00 + outer loop + vertex -9.362349e-02 -3.513748e-02 1.000000e-01 + vertex -9.510565e-02 -3.090170e-02 1.000000e-01 + vertex -9.510565e-02 -3.090170e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 -3.722937e-01 0.000000e+00 + outer loop + vertex -9.195278e-02 -3.930250e-02 1.000000e-01 + vertex -9.362349e-02 -3.513748e-02 8.000000e-02 + vertex -9.195278e-02 -3.930250e-02 8.000000e-02 + endloop + endfacet + facet normal -9.281150e-01 -3.722937e-01 -0.000000e+00 + outer loop + vertex -9.195278e-02 -3.930250e-02 1.000000e-01 + vertex -9.362349e-02 -3.513748e-02 1.000000e-01 + vertex -9.362349e-02 -3.513748e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 -4.135585e-01 -0.000000e+00 + outer loop + vertex -9.009689e-02 -4.338837e-02 1.000000e-01 + vertex -9.195278e-02 -3.930250e-02 1.000000e-01 + vertex -9.195278e-02 -3.930250e-02 8.000000e-02 + endloop + endfacet + facet normal -9.104775e-01 -4.135585e-01 0.000000e+00 + outer loop + vertex -9.009689e-02 -4.338837e-02 1.000000e-01 + vertex -9.195278e-02 -3.930250e-02 8.000000e-02 + vertex -9.009689e-02 -4.338837e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 -4.539905e-01 -0.000000e+00 + outer loop + vertex -8.805955e-02 -4.738687e-02 1.000000e-01 + vertex -9.009689e-02 -4.338837e-02 1.000000e-01 + vertex -9.009689e-02 -4.338837e-02 8.000000e-02 + endloop + endfacet + facet normal -8.910065e-01 -4.539905e-01 0.000000e+00 + outer loop + vertex -8.805955e-02 -4.738687e-02 1.000000e-01 + vertex -9.009689e-02 -4.338837e-02 8.000000e-02 + vertex -8.805955e-02 -4.738687e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 -4.935082e-01 -0.000000e+00 + outer loop + vertex -8.584488e-02 -5.128993e-02 1.000000e-01 + vertex -8.805955e-02 -4.738687e-02 1.000000e-01 + vertex -8.805955e-02 -4.738687e-02 8.000000e-02 + endloop + endfacet + facet normal -8.697411e-01 -4.935082e-01 0.000000e+00 + outer loop + vertex -8.584488e-02 -5.128993e-02 1.000000e-01 + vertex -8.805955e-02 -4.738687e-02 8.000000e-02 + vertex -8.584488e-02 -5.128993e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 -5.320321e-01 -0.000000e+00 + outer loop + vertex -8.345733e-02 -5.508970e-02 1.000000e-01 + vertex -8.584488e-02 -5.128993e-02 1.000000e-01 + vertex -8.584488e-02 -5.128993e-02 8.000000e-02 + endloop + endfacet + facet normal -8.467242e-01 -5.320321e-01 0.000000e+00 + outer loop + vertex -8.345733e-02 -5.508970e-02 1.000000e-01 + vertex -8.584488e-02 -5.128993e-02 8.000000e-02 + vertex -8.345733e-02 -5.508970e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 -5.694845e-01 -0.000000e+00 + outer loop + vertex -8.090170e-02 -5.877853e-02 1.000000e-01 + vertex -8.345733e-02 -5.508970e-02 1.000000e-01 + vertex -8.345733e-02 -5.508970e-02 8.000000e-02 + endloop + endfacet + facet normal -8.220021e-01 -5.694845e-01 0.000000e+00 + outer loop + vertex -8.090170e-02 -5.877853e-02 1.000000e-01 + vertex -8.345733e-02 -5.508970e-02 8.000000e-02 + vertex -8.090170e-02 -5.877853e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 -6.057900e-01 -0.000000e+00 + outer loop + vertex -7.818315e-02 -6.234898e-02 1.000000e-01 + vertex -8.090170e-02 -5.877853e-02 1.000000e-01 + vertex -8.090170e-02 -5.877853e-02 8.000000e-02 + endloop + endfacet + facet normal -7.956245e-01 -6.057900e-01 0.000000e+00 + outer loop + vertex -7.818315e-02 -6.234898e-02 1.000000e-01 + vertex -8.090170e-02 -5.877853e-02 8.000000e-02 + vertex -7.818315e-02 -6.234898e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 -6.408756e-01 -0.000000e+00 + outer loop + vertex -7.530715e-02 -6.579387e-02 1.000000e-01 + vertex -7.818315e-02 -6.234898e-02 1.000000e-01 + vertex -7.818315e-02 -6.234898e-02 8.000000e-02 + endloop + endfacet + facet normal -7.676447e-01 -6.408756e-01 0.000000e+00 + outer loop + vertex -7.530715e-02 -6.579387e-02 1.000000e-01 + vertex -7.818315e-02 -6.234898e-02 8.000000e-02 + vertex -7.530715e-02 -6.579387e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 -6.746705e-01 -0.000000e+00 + outer loop + vertex -7.227949e-02 -6.910626e-02 1.000000e-01 + vertex -7.530715e-02 -6.579387e-02 1.000000e-01 + vertex -7.530715e-02 -6.579387e-02 8.000000e-02 + endloop + endfacet + facet normal -7.381190e-01 -6.746705e-01 0.000000e+00 + outer loop + vertex -7.227949e-02 -6.910626e-02 1.000000e-01 + vertex -7.530715e-02 -6.579387e-02 8.000000e-02 + vertex -7.227949e-02 -6.910626e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 -7.071068e-01 -0.000000e+00 + outer loop + vertex -6.910626e-02 -7.227949e-02 1.000000e-01 + vertex -7.227949e-02 -6.910626e-02 1.000000e-01 + vertex -7.227949e-02 -6.910626e-02 8.000000e-02 + endloop + endfacet + facet normal -7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex -6.910626e-02 -7.227949e-02 1.000000e-01 + vertex -7.227949e-02 -6.910626e-02 8.000000e-02 + vertex -6.910626e-02 -7.227949e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 -7.381190e-01 -0.000000e+00 + outer loop + vertex -6.579387e-02 -7.530715e-02 1.000000e-01 + vertex -6.910626e-02 -7.227949e-02 1.000000e-01 + vertex -6.910626e-02 -7.227949e-02 8.000000e-02 + endloop + endfacet + facet normal -6.746705e-01 -7.381190e-01 0.000000e+00 + outer loop + vertex -6.579387e-02 -7.530715e-02 1.000000e-01 + vertex -6.910626e-02 -7.227949e-02 8.000000e-02 + vertex -6.579387e-02 -7.530715e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 -7.676447e-01 -0.000000e+00 + outer loop + vertex -6.234898e-02 -7.818315e-02 1.000000e-01 + vertex -6.579387e-02 -7.530715e-02 1.000000e-01 + vertex -6.579387e-02 -7.530715e-02 8.000000e-02 + endloop + endfacet + facet normal -6.408756e-01 -7.676447e-01 0.000000e+00 + outer loop + vertex -6.234898e-02 -7.818315e-02 1.000000e-01 + vertex -6.579387e-02 -7.530715e-02 8.000000e-02 + vertex -6.234898e-02 -7.818315e-02 8.000000e-02 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.345733e-02 5.508970e-02 1.000000e-01 + vertex 6.789154e-02 4.231712e-02 1.000000e-01 + vertex 8.584488e-02 5.128993e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.508970e-02 8.345733e-02 1.000000e-01 + vertex 4.231712e-02 6.789154e-02 1.000000e-01 + vertex 4.570146e-02 6.566108e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.508970e-02 8.345733e-02 1.000000e-01 + vertex 5.128993e-02 8.584488e-02 1.000000e-01 + vertex 4.231712e-02 6.789154e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.326206e-02 4.896848e-02 1.000000e-01 + vertex -7.818315e-02 6.234898e-02 1.000000e-01 + vertex -8.090170e-02 5.877853e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.326206e-02 4.896848e-02 1.000000e-01 + vertex -8.090170e-02 5.877853e-02 1.000000e-01 + vertex -6.566108e-02 4.570146e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.896848e-02 -6.326206e-02 1.000000e-01 + vertex 4.570146e-02 -6.566108e-02 1.000000e-01 + vertex 5.877853e-02 -8.090170e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.090170e-02 5.877853e-02 1.000000e-01 + vertex 6.326206e-02 4.896848e-02 1.000000e-01 + vertex 6.566108e-02 4.570146e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.896848e-02 -6.326206e-02 1.000000e-01 + vertex 5.877853e-02 -8.090170e-02 1.000000e-01 + vertex 6.234898e-02 -7.818315e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.090170e-02 5.877853e-02 1.000000e-01 + vertex 6.566108e-02 4.570146e-02 1.000000e-01 + vertex 8.345733e-02 5.508970e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.877853e-02 8.090170e-02 1.000000e-01 + vertex 5.508970e-02 8.345733e-02 1.000000e-01 + vertex 4.570146e-02 6.566108e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.877853e-02 8.090170e-02 1.000000e-01 + vertex 4.570146e-02 6.566108e-02 1.000000e-01 + vertex 4.896848e-02 6.326206e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.070065e-02 5.210980e-02 1.000000e-01 + vertex -7.818315e-02 6.234898e-02 1.000000e-01 + vertex -6.326206e-02 4.896848e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.818315e-02 6.234898e-02 1.000000e-01 + vertex 6.070065e-02 5.210980e-02 1.000000e-01 + vertex 6.326206e-02 4.896848e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.070065e-02 5.210980e-02 1.000000e-01 + vertex -7.530715e-02 6.579387e-02 1.000000e-01 + vertex -7.818315e-02 6.234898e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.818315e-02 6.234898e-02 1.000000e-01 + vertex 6.326206e-02 4.896848e-02 1.000000e-01 + vertex 8.090170e-02 5.877853e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.210980e-02 -6.070065e-02 1.000000e-01 + vertex 6.234898e-02 -7.818315e-02 1.000000e-01 + vertex 6.579387e-02 -7.530715e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.234898e-02 7.818315e-02 1.000000e-01 + vertex 4.896848e-02 6.326206e-02 1.000000e-01 + vertex 5.210980e-02 6.070065e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.234898e-02 7.818315e-02 1.000000e-01 + vertex 5.877853e-02 8.090170e-02 1.000000e-01 + vertex 4.896848e-02 6.326206e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.579387e-02 7.530715e-02 1.000000e-01 + vertex 5.210980e-02 6.070065e-02 1.000000e-01 + vertex 5.511735e-02 5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.579387e-02 7.530715e-02 1.000000e-01 + vertex 6.234898e-02 7.818315e-02 1.000000e-01 + vertex 5.210980e-02 6.070065e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.210980e-02 -6.070065e-02 1.000000e-01 + vertex 4.896848e-02 -6.326206e-02 1.000000e-01 + vertex 6.234898e-02 -7.818315e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.530715e-02 6.579387e-02 1.000000e-01 + vertex 5.798342e-02 5.511735e-02 1.000000e-01 + vertex 6.070065e-02 5.210980e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.530715e-02 6.579387e-02 1.000000e-01 + vertex 6.070065e-02 5.210980e-02 1.000000e-01 + vertex 7.818315e-02 6.234898e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.910626e-02 7.227949e-02 1.000000e-01 + vertex 5.511735e-02 5.798342e-02 1.000000e-01 + vertex 5.798342e-02 5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.798342e-02 5.511735e-02 1.000000e-01 + vertex -7.530715e-02 6.579387e-02 1.000000e-01 + vertex -6.070065e-02 5.210980e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.910626e-02 7.227949e-02 1.000000e-01 + vertex 6.579387e-02 7.530715e-02 1.000000e-01 + vertex 5.511735e-02 5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.798342e-02 5.511735e-02 1.000000e-01 + vertex -7.227949e-02 6.910626e-02 1.000000e-01 + vertex -7.530715e-02 6.579387e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.227949e-02 6.910626e-02 1.000000e-01 + vertex 6.910626e-02 7.227949e-02 1.000000e-01 + vertex 5.798342e-02 5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.227949e-02 6.910626e-02 1.000000e-01 + vertex 5.798342e-02 5.511735e-02 1.000000e-01 + vertex 7.530715e-02 6.579387e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.511735e-02 -5.798342e-02 1.000000e-01 + vertex 5.210980e-02 -6.070065e-02 1.000000e-01 + vertex 6.579387e-02 -7.530715e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.511735e-02 -5.798342e-02 1.000000e-01 + vertex 6.579387e-02 -7.530715e-02 1.000000e-01 + vertex 6.910626e-02 -7.227949e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.227949e-02 -6.910626e-02 1.000000e-01 + vertex 5.798342e-02 -5.511735e-02 1.000000e-01 + vertex 5.511735e-02 -5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.227949e-02 -6.910626e-02 1.000000e-01 + vertex 5.511735e-02 -5.798342e-02 1.000000e-01 + vertex 6.910626e-02 -7.227949e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.910626e-02 7.227949e-02 1.000000e-01 + vertex -7.227949e-02 6.910626e-02 1.000000e-01 + vertex -5.798342e-02 5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.910626e-02 7.227949e-02 1.000000e-01 + vertex -5.798342e-02 5.511735e-02 1.000000e-01 + vertex -5.511735e-02 5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.530715e-02 -6.579387e-02 1.000000e-01 + vertex 5.798342e-02 -5.511735e-02 1.000000e-01 + vertex 7.227949e-02 -6.910626e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.530715e-02 -6.579387e-02 1.000000e-01 + vertex 6.070065e-02 -5.210980e-02 1.000000e-01 + vertex 5.798342e-02 -5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.579387e-02 7.530715e-02 1.000000e-01 + vertex -6.910626e-02 7.227949e-02 1.000000e-01 + vertex -5.511735e-02 5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.579387e-02 7.530715e-02 1.000000e-01 + vertex -5.511735e-02 5.798342e-02 1.000000e-01 + vertex -5.210980e-02 6.070065e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.818315e-02 -6.234898e-02 1.000000e-01 + vertex 6.070065e-02 -5.210980e-02 1.000000e-01 + vertex 7.530715e-02 -6.579387e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 7.818315e-02 -6.234898e-02 1.000000e-01 + vertex 6.326206e-02 -4.896848e-02 1.000000e-01 + vertex 6.070065e-02 -5.210980e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.234898e-02 7.818315e-02 1.000000e-01 + vertex -6.579387e-02 7.530715e-02 1.000000e-01 + vertex -5.210980e-02 6.070065e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.234898e-02 7.818315e-02 1.000000e-01 + vertex -5.210980e-02 6.070065e-02 1.000000e-01 + vertex -4.896848e-02 6.326206e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.090170e-02 -5.877853e-02 1.000000e-01 + vertex 6.326206e-02 -4.896848e-02 1.000000e-01 + vertex 7.818315e-02 -6.234898e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.090170e-02 -5.877853e-02 1.000000e-01 + vertex 6.566108e-02 -4.570146e-02 1.000000e-01 + vertex 6.326206e-02 -4.896848e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.877853e-02 8.090170e-02 1.000000e-01 + vertex -6.234898e-02 7.818315e-02 1.000000e-01 + vertex -4.896848e-02 6.326206e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.877853e-02 8.090170e-02 1.000000e-01 + vertex -4.896848e-02 6.326206e-02 1.000000e-01 + vertex -4.570146e-02 6.566108e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.345733e-02 -5.508970e-02 1.000000e-01 + vertex 6.789154e-02 -4.231712e-02 1.000000e-01 + vertex 6.566108e-02 -4.570146e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.345733e-02 -5.508970e-02 1.000000e-01 + vertex 6.566108e-02 -4.570146e-02 1.000000e-01 + vertex 8.090170e-02 -5.877853e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.508970e-02 8.345733e-02 1.000000e-01 + vertex -5.877853e-02 8.090170e-02 1.000000e-01 + vertex -4.570146e-02 6.566108e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.508970e-02 8.345733e-02 1.000000e-01 + vertex -4.570146e-02 6.566108e-02 1.000000e-01 + vertex -4.231712e-02 6.789154e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.584488e-02 -5.128993e-02 1.000000e-01 + vertex 6.994773e-02 -3.882416e-02 1.000000e-01 + vertex 6.789154e-02 -4.231712e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.584488e-02 -5.128993e-02 1.000000e-01 + vertex 6.789154e-02 -4.231712e-02 1.000000e-01 + vertex 8.345733e-02 -5.508970e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.128993e-02 8.584488e-02 1.000000e-01 + vertex -5.508970e-02 8.345733e-02 1.000000e-01 + vertex -4.231712e-02 6.789154e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.128993e-02 8.584488e-02 1.000000e-01 + vertex -4.231712e-02 6.789154e-02 1.000000e-01 + vertex -3.882416e-02 6.994773e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.511735e-02 -5.798342e-02 1.000000e-01 + vertex -6.910626e-02 -7.227949e-02 1.000000e-01 + vertex -6.579387e-02 -7.530715e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.798342e-02 -5.511735e-02 1.000000e-01 + vertex -6.910626e-02 -7.227949e-02 1.000000e-01 + vertex -5.511735e-02 -5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.805955e-02 -4.738687e-02 1.000000e-01 + vertex 7.182436e-02 -3.523153e-02 1.000000e-01 + vertex 6.994773e-02 -3.882416e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.805955e-02 -4.738687e-02 1.000000e-01 + vertex 6.994773e-02 -3.882416e-02 1.000000e-01 + vertex 8.584488e-02 -5.128993e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.738687e-02 8.805955e-02 1.000000e-01 + vertex -5.128993e-02 8.584488e-02 1.000000e-01 + vertex -3.882416e-02 6.994773e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.738687e-02 8.805955e-02 1.000000e-01 + vertex -3.882416e-02 6.994773e-02 1.000000e-01 + vertex -3.523153e-02 7.182436e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.798342e-02 -5.511735e-02 1.000000e-01 + vertex -7.530715e-02 -6.579387e-02 1.000000e-01 + vertex -7.227949e-02 -6.910626e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.798342e-02 -5.511735e-02 1.000000e-01 + vertex -7.227949e-02 -6.910626e-02 1.000000e-01 + vertex -6.910626e-02 -7.227949e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.210980e-02 -6.070065e-02 1.000000e-01 + vertex -5.511735e-02 -5.798342e-02 1.000000e-01 + vertex -6.579387e-02 -7.530715e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -5.210980e-02 -6.070065e-02 1.000000e-01 + vertex -6.579387e-02 -7.530715e-02 1.000000e-01 + vertex -6.234898e-02 -7.818315e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.009689e-02 -4.338837e-02 1.000000e-01 + vertex 7.351662e-02 -3.154847e-02 1.000000e-01 + vertex 7.182436e-02 -3.523153e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.009689e-02 -4.338837e-02 1.000000e-01 + vertex 7.182436e-02 -3.523153e-02 1.000000e-01 + vertex 8.805955e-02 -4.738687e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.338837e-02 9.009689e-02 1.000000e-01 + vertex -3.523153e-02 7.182436e-02 1.000000e-01 + vertex -3.154847e-02 7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.338837e-02 9.009689e-02 1.000000e-01 + vertex -4.738687e-02 8.805955e-02 1.000000e-01 + vertex -3.523153e-02 7.182436e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.070065e-02 -5.210980e-02 1.000000e-01 + vertex -7.530715e-02 -6.579387e-02 1.000000e-01 + vertex -5.798342e-02 -5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.070065e-02 -5.210980e-02 1.000000e-01 + vertex -7.818315e-02 -6.234898e-02 1.000000e-01 + vertex -7.530715e-02 -6.579387e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.930250e-02 9.195278e-02 1.000000e-01 + vertex -4.338837e-02 9.009689e-02 1.000000e-01 + vertex -3.154847e-02 7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.195278e-02 -3.930250e-02 1.000000e-01 + vertex 7.351662e-02 -3.154847e-02 1.000000e-01 + vertex 9.009689e-02 -4.338837e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.896848e-02 -6.326206e-02 1.000000e-01 + vertex -5.210980e-02 -6.070065e-02 1.000000e-01 + vertex -6.234898e-02 -7.818315e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.896848e-02 -6.326206e-02 1.000000e-01 + vertex -6.234898e-02 -7.818315e-02 1.000000e-01 + vertex -5.877853e-02 -8.090170e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.326206e-02 -4.896848e-02 1.000000e-01 + vertex -7.818315e-02 -6.234898e-02 1.000000e-01 + vertex -6.070065e-02 -5.210980e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.362349e-02 -3.513748e-02 1.000000e-01 + vertex 7.502017e-02 -2.778442e-02 1.000000e-01 + vertex 7.351662e-02 -3.154847e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.362349e-02 -3.513748e-02 1.000000e-01 + vertex 7.351662e-02 -3.154847e-02 1.000000e-01 + vertex 9.195278e-02 -3.930250e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.513748e-02 9.362349e-02 1.000000e-01 + vertex -3.930250e-02 9.195278e-02 1.000000e-01 + vertex -3.154847e-02 7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.513748e-02 9.362349e-02 1.000000e-01 + vertex -3.154847e-02 7.351662e-02 1.000000e-01 + vertex -2.778442e-02 7.502017e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.326206e-02 -4.896848e-02 1.000000e-01 + vertex -8.090170e-02 -5.877853e-02 1.000000e-01 + vertex -7.818315e-02 -6.234898e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.566108e-02 -4.570146e-02 1.000000e-01 + vertex -8.090170e-02 -5.877853e-02 1.000000e-01 + vertex -6.326206e-02 -4.896848e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.510565e-02 -3.090170e-02 1.000000e-01 + vertex 7.633114e-02 -2.394905e-02 1.000000e-01 + vertex 7.502017e-02 -2.778442e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.566108e-02 -4.570146e-02 1.000000e-01 + vertex -8.345733e-02 -5.508970e-02 1.000000e-01 + vertex -8.090170e-02 -5.877853e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.510565e-02 -3.090170e-02 1.000000e-01 + vertex 7.502017e-02 -2.778442e-02 1.000000e-01 + vertex 9.362349e-02 -3.513748e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.090170e-02 9.510565e-02 1.000000e-01 + vertex -3.513748e-02 9.362349e-02 1.000000e-01 + vertex -2.778442e-02 7.502017e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.090170e-02 9.510565e-02 1.000000e-01 + vertex -2.778442e-02 7.502017e-02 1.000000e-01 + vertex -2.394905e-02 7.633114e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.570146e-02 -6.566108e-02 1.000000e-01 + vertex -5.877853e-02 -8.090170e-02 1.000000e-01 + vertex -5.508970e-02 -8.345733e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.570146e-02 -6.566108e-02 1.000000e-01 + vertex -4.896848e-02 -6.326206e-02 1.000000e-01 + vertex -5.877853e-02 -8.090170e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.639629e-02 -2.660368e-02 1.000000e-01 + vertex 7.744617e-02 -2.005220e-02 1.000000e-01 + vertex 7.633114e-02 -2.394905e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.639629e-02 -2.660368e-02 1.000000e-01 + vertex 7.633114e-02 -2.394905e-02 1.000000e-01 + vertex 9.510565e-02 -3.090170e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.660368e-02 9.639629e-02 1.000000e-01 + vertex -3.090170e-02 9.510565e-02 1.000000e-01 + vertex -2.394905e-02 7.633114e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.231712e-02 -6.789154e-02 1.000000e-01 + vertex -4.570146e-02 -6.566108e-02 1.000000e-01 + vertex -5.508970e-02 -8.345733e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.231712e-02 -6.789154e-02 1.000000e-01 + vertex -5.508970e-02 -8.345733e-02 1.000000e-01 + vertex -5.128993e-02 -8.584488e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.660368e-02 9.639629e-02 1.000000e-01 + vertex -2.394905e-02 7.633114e-02 1.000000e-01 + vertex -2.005220e-02 7.744617e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.789154e-02 -4.231712e-02 1.000000e-01 + vertex -8.345733e-02 -5.508970e-02 1.000000e-01 + vertex -6.566108e-02 -4.570146e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.749279e-02 -2.225209e-02 1.000000e-01 + vertex 7.744617e-02 -2.005220e-02 1.000000e-01 + vertex 9.639629e-02 -2.660368e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.749279e-02 -2.225209e-02 1.000000e-01 + vertex 7.836240e-02 -1.610388e-02 1.000000e-01 + vertex 7.744617e-02 -2.005220e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.789154e-02 -4.231712e-02 1.000000e-01 + vertex -8.584488e-02 -5.128993e-02 1.000000e-01 + vertex -8.345733e-02 -5.508970e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.225209e-02 9.749279e-02 1.000000e-01 + vertex -2.660368e-02 9.639629e-02 1.000000e-01 + vertex -2.005220e-02 7.744617e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.225209e-02 9.749279e-02 1.000000e-01 + vertex -2.005220e-02 7.744617e-02 1.000000e-01 + vertex -1.610388e-02 7.836240e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.882416e-02 -6.994773e-02 1.000000e-01 + vertex -4.231712e-02 -6.789154e-02 1.000000e-01 + vertex -5.128993e-02 -8.584488e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.882416e-02 -6.994773e-02 1.000000e-01 + vertex -5.128993e-02 -8.584488e-02 1.000000e-01 + vertex -4.738687e-02 -8.805955e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.994773e-02 -3.882416e-02 1.000000e-01 + vertex -8.584488e-02 -5.128993e-02 1.000000e-01 + vertex -6.789154e-02 -4.231712e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.994773e-02 -3.882416e-02 1.000000e-01 + vertex -8.805955e-02 -4.738687e-02 1.000000e-01 + vertex -8.584488e-02 -5.128993e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.785569e-02 9.839296e-02 1.000000e-01 + vertex -2.225209e-02 9.749279e-02 1.000000e-01 + vertex -1.610388e-02 7.836240e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.785569e-02 9.839296e-02 1.000000e-01 + vertex -1.610388e-02 7.836240e-02 1.000000e-01 + vertex -1.211422e-02 7.907747e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.839296e-02 -1.785569e-02 1.000000e-01 + vertex 7.836240e-02 -1.610388e-02 1.000000e-01 + vertex 9.749279e-02 -2.225209e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.839296e-02 -1.785569e-02 1.000000e-01 + vertex 7.907747e-02 -1.211422e-02 1.000000e-01 + vertex 7.836240e-02 -1.610388e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.182436e-02 -3.523153e-02 1.000000e-01 + vertex -8.805955e-02 -4.738687e-02 1.000000e-01 + vertex -6.994773e-02 -3.882416e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.182436e-02 -3.523153e-02 1.000000e-01 + vertex -9.009689e-02 -4.338837e-02 1.000000e-01 + vertex -8.805955e-02 -4.738687e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.909498e-02 -1.342333e-02 1.000000e-01 + vertex 7.907747e-02 -1.211422e-02 1.000000e-01 + vertex 9.839296e-02 -1.785569e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.523153e-02 -7.182436e-02 1.000000e-01 + vertex -3.882416e-02 -6.994773e-02 1.000000e-01 + vertex -4.738687e-02 -8.805955e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.909498e-02 -1.342333e-02 1.000000e-01 + vertex 7.958955e-02 -8.093466e-03 1.000000e-01 + vertex 7.907747e-02 -1.211422e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.523153e-02 -7.182436e-02 1.000000e-01 + vertex -4.738687e-02 -8.805955e-02 1.000000e-01 + vertex -4.338837e-02 -9.009689e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.342333e-02 9.909498e-02 1.000000e-01 + vertex -1.785569e-02 9.839296e-02 1.000000e-01 + vertex -1.211422e-02 7.907747e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.342333e-02 9.909498e-02 1.000000e-01 + vertex -1.211422e-02 7.907747e-02 1.000000e-01 + vertex -8.093466e-03 7.958955e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.351662e-02 -3.154847e-02 1.000000e-01 + vertex -9.009689e-02 -4.338837e-02 1.000000e-01 + vertex -7.182436e-02 -3.523153e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.351662e-02 -3.154847e-02 1.000000e-01 + vertex -9.362349e-02 -3.513748e-02 1.000000e-01 + vertex -9.195278e-02 -3.930250e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.351662e-02 -3.154847e-02 1.000000e-01 + vertex -9.195278e-02 -3.930250e-02 1.000000e-01 + vertex -9.009689e-02 -4.338837e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.959743e-02 -8.963931e-03 1.000000e-01 + vertex 7.958955e-02 -8.093466e-03 1.000000e-01 + vertex 9.909498e-02 -1.342333e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.959743e-02 -8.963931e-03 1.000000e-01 + vertex 7.989732e-02 -4.051934e-03 1.000000e-01 + vertex 7.958955e-02 -8.093466e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.154847e-02 -7.351662e-02 1.000000e-01 + vertex -3.523153e-02 -7.182436e-02 1.000000e-01 + vertex -4.338837e-02 -9.009689e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -8.963931e-03 9.959743e-02 1.000000e-01 + vertex -1.342333e-02 9.909498e-02 1.000000e-01 + vertex -8.093466e-03 7.958955e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.154847e-02 -7.351662e-02 1.000000e-01 + vertex -4.338837e-02 -9.009689e-02 1.000000e-01 + vertex -3.930250e-02 -9.195278e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -3.154847e-02 -7.351662e-02 1.000000e-01 + vertex -3.930250e-02 -9.195278e-02 1.000000e-01 + vertex -3.513748e-02 -9.362349e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -8.963931e-03 9.959743e-02 1.000000e-01 + vertex -8.093466e-03 7.958955e-02 1.000000e-01 + vertex -4.051934e-03 7.989732e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.502017e-02 -2.778442e-02 1.000000e-01 + vertex -9.362349e-02 -3.513748e-02 1.000000e-01 + vertex -7.351662e-02 -3.154847e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.502017e-02 -2.778442e-02 1.000000e-01 + vertex -9.510565e-02 -3.090170e-02 1.000000e-01 + vertex -9.362349e-02 -3.513748e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.778442e-02 -7.502017e-02 1.000000e-01 + vertex -3.154847e-02 -7.351662e-02 1.000000e-01 + vertex -3.513748e-02 -9.362349e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.778442e-02 -7.502017e-02 1.000000e-01 + vertex -3.513748e-02 -9.362349e-02 1.000000e-01 + vertex -3.090170e-02 -9.510565e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.989931e-02 -4.486483e-03 1.000000e-01 + vertex 7.989732e-02 -4.051934e-03 1.000000e-01 + vertex 9.959743e-02 -8.963931e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.989931e-02 -4.486483e-03 1.000000e-01 + vertex 8.000000e-02 0.000000e+00 1.000000e-01 + vertex 7.989732e-02 -4.051934e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.486483e-03 9.989931e-02 1.000000e-01 + vertex -8.963931e-03 9.959743e-02 1.000000e-01 + vertex -4.051934e-03 7.989732e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.633114e-02 -2.394905e-02 1.000000e-01 + vertex -9.510565e-02 -3.090170e-02 1.000000e-01 + vertex -7.502017e-02 -2.778442e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.486483e-03 9.989931e-02 1.000000e-01 + vertex -4.051934e-03 7.989732e-02 1.000000e-01 + vertex 4.898587e-18 8.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.633114e-02 -2.394905e-02 1.000000e-01 + vertex -9.639629e-02 -2.660368e-02 1.000000e-01 + vertex -9.510565e-02 -3.090170e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.394905e-02 -7.633114e-02 1.000000e-01 + vertex -2.778442e-02 -7.502017e-02 1.000000e-01 + vertex -3.090170e-02 -9.510565e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.394905e-02 -7.633114e-02 1.000000e-01 + vertex -3.090170e-02 -9.510565e-02 1.000000e-01 + vertex -2.660368e-02 -9.639629e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 6.123234e-18 1.000000e-01 1.000000e-01 + vertex -4.486483e-03 9.989931e-02 1.000000e-01 + vertex 4.898587e-18 8.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.000000e-01 0.000000e+00 1.000000e-01 + vertex 8.000000e-02 0.000000e+00 1.000000e-01 + vertex 9.989931e-02 -4.486483e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.744617e-02 -2.005220e-02 1.000000e-01 + vertex -9.639629e-02 -2.660368e-02 1.000000e-01 + vertex -7.633114e-02 -2.394905e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.744617e-02 -2.005220e-02 1.000000e-01 + vertex -9.749279e-02 -2.225209e-02 1.000000e-01 + vertex -9.639629e-02 -2.660368e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.005220e-02 -7.744617e-02 1.000000e-01 + vertex -2.394905e-02 -7.633114e-02 1.000000e-01 + vertex -2.660368e-02 -9.639629e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -2.005220e-02 -7.744617e-02 1.000000e-01 + vertex -2.660368e-02 -9.639629e-02 1.000000e-01 + vertex -2.225209e-02 -9.749279e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.989931e-02 4.486483e-03 1.000000e-01 + vertex 7.989732e-02 4.051934e-03 1.000000e-01 + vertex 8.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.989931e-02 4.486483e-03 1.000000e-01 + vertex 8.000000e-02 0.000000e+00 1.000000e-01 + vertex 1.000000e-01 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.836240e-02 -1.610388e-02 1.000000e-01 + vertex -9.839296e-02 -1.785569e-02 1.000000e-01 + vertex -9.749279e-02 -2.225209e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.836240e-02 -1.610388e-02 1.000000e-01 + vertex -9.749279e-02 -2.225209e-02 1.000000e-01 + vertex -7.744617e-02 -2.005220e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.610388e-02 -7.836240e-02 1.000000e-01 + vertex -2.225209e-02 -9.749279e-02 1.000000e-01 + vertex -1.785569e-02 -9.839296e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.486483e-03 9.989931e-02 1.000000e-01 + vertex 4.898587e-18 8.000000e-02 1.000000e-01 + vertex 4.051934e-03 7.989732e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.486483e-03 9.989931e-02 1.000000e-01 + vertex 6.123234e-18 1.000000e-01 1.000000e-01 + vertex 4.898587e-18 8.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.610388e-02 -7.836240e-02 1.000000e-01 + vertex -2.005220e-02 -7.744617e-02 1.000000e-01 + vertex -2.225209e-02 -9.749279e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.907747e-02 -1.211422e-02 1.000000e-01 + vertex -9.909498e-02 -1.342333e-02 1.000000e-01 + vertex -9.839296e-02 -1.785569e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.907747e-02 -1.211422e-02 1.000000e-01 + vertex -9.839296e-02 -1.785569e-02 1.000000e-01 + vertex -7.836240e-02 -1.610388e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.211422e-02 -7.907747e-02 1.000000e-01 + vertex -1.785569e-02 -9.839296e-02 1.000000e-01 + vertex -1.342333e-02 -9.909498e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.959743e-02 8.963931e-03 1.000000e-01 + vertex 7.958955e-02 8.093466e-03 1.000000e-01 + vertex 7.989732e-02 4.051934e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -1.211422e-02 -7.907747e-02 1.000000e-01 + vertex -1.610388e-02 -7.836240e-02 1.000000e-01 + vertex -1.785569e-02 -9.839296e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.959743e-02 8.963931e-03 1.000000e-01 + vertex 7.989732e-02 4.051934e-03 1.000000e-01 + vertex 9.989931e-02 4.486483e-03 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.958955e-02 -8.093466e-03 1.000000e-01 + vertex -9.909498e-02 -1.342333e-02 1.000000e-01 + vertex -7.907747e-02 -1.211422e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.963931e-03 9.959743e-02 1.000000e-01 + vertex 4.051934e-03 7.989732e-02 1.000000e-01 + vertex 8.093466e-03 7.958955e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.963931e-03 9.959743e-02 1.000000e-01 + vertex 4.486483e-03 9.989931e-02 1.000000e-01 + vertex 4.051934e-03 7.989732e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.958955e-02 -8.093466e-03 1.000000e-01 + vertex -9.959743e-02 -8.963931e-03 1.000000e-01 + vertex -9.909498e-02 -1.342333e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -8.093466e-03 -7.958955e-02 1.000000e-01 + vertex -1.342333e-02 -9.909498e-02 1.000000e-01 + vertex -8.963931e-03 -9.959743e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -8.093466e-03 -7.958955e-02 1.000000e-01 + vertex -1.211422e-02 -7.907747e-02 1.000000e-01 + vertex -1.342333e-02 -9.909498e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.989732e-02 -4.051934e-03 1.000000e-01 + vertex -9.959743e-02 -8.963931e-03 1.000000e-01 + vertex -7.958955e-02 -8.093466e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.989732e-02 -4.051934e-03 1.000000e-01 + vertex -9.989931e-02 -4.486483e-03 1.000000e-01 + vertex -9.959743e-02 -8.963931e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.051934e-03 -7.989732e-02 1.000000e-01 + vertex -8.963931e-03 -9.959743e-02 1.000000e-01 + vertex -4.486483e-03 -9.989931e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -4.051934e-03 -7.989732e-02 1.000000e-01 + vertex -8.093466e-03 -7.958955e-02 1.000000e-01 + vertex -8.963931e-03 -9.959743e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -8.000000e-02 9.797174e-18 1.000000e-01 + vertex -9.989931e-02 -4.486483e-03 1.000000e-01 + vertex -7.989732e-02 -4.051934e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -8.000000e-02 9.797174e-18 1.000000e-01 + vertex -9.989931e-02 4.486483e-03 1.000000e-01 + vertex -1.000000e-01 1.224647e-17 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -8.000000e-02 9.797174e-18 1.000000e-01 + vertex -1.000000e-01 1.224647e-17 1.000000e-01 + vertex -9.989931e-02 -4.486483e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.695213e-16 -8.000000e-02 1.000000e-01 + vertex -4.486483e-03 -9.989931e-02 1.000000e-01 + vertex -1.836970e-17 -1.000000e-01 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.695213e-16 -8.000000e-02 1.000000e-01 + vertex -1.836970e-17 -1.000000e-01 1.000000e-01 + vertex 4.486483e-03 -9.989931e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.909498e-02 1.342333e-02 1.000000e-01 + vertex 7.907747e-02 1.211422e-02 1.000000e-01 + vertex 7.958955e-02 8.093466e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.695213e-16 -8.000000e-02 1.000000e-01 + vertex -4.051934e-03 -7.989732e-02 1.000000e-01 + vertex -4.486483e-03 -9.989931e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.909498e-02 1.342333e-02 1.000000e-01 + vertex 7.958955e-02 8.093466e-03 1.000000e-01 + vertex 9.959743e-02 8.963931e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.989732e-02 4.051934e-03 1.000000e-01 + vertex -9.989931e-02 4.486483e-03 1.000000e-01 + vertex -8.000000e-02 9.797174e-18 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.989732e-02 4.051934e-03 1.000000e-01 + vertex -9.959743e-02 8.963931e-03 1.000000e-01 + vertex -9.989931e-02 4.486483e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.342333e-02 9.909498e-02 1.000000e-01 + vertex 8.963931e-03 9.959743e-02 1.000000e-01 + vertex 8.093466e-03 7.958955e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.051934e-03 -7.989732e-02 1.000000e-01 + vertex 4.486483e-03 -9.989931e-02 1.000000e-01 + vertex 8.963931e-03 -9.959743e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.051934e-03 -7.989732e-02 1.000000e-01 + vertex 2.695213e-16 -8.000000e-02 1.000000e-01 + vertex 4.486483e-03 -9.989931e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.342333e-02 9.909498e-02 1.000000e-01 + vertex 8.093466e-03 7.958955e-02 1.000000e-01 + vertex 1.211422e-02 7.907747e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.958955e-02 8.093466e-03 1.000000e-01 + vertex -9.959743e-02 8.963931e-03 1.000000e-01 + vertex -7.989732e-02 4.051934e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.958955e-02 8.093466e-03 1.000000e-01 + vertex -9.909498e-02 1.342333e-02 1.000000e-01 + vertex -9.959743e-02 8.963931e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.093466e-03 -7.958955e-02 1.000000e-01 + vertex 4.051934e-03 -7.989732e-02 1.000000e-01 + vertex 8.963931e-03 -9.959743e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.093466e-03 -7.958955e-02 1.000000e-01 + vertex 8.963931e-03 -9.959743e-02 1.000000e-01 + vertex 1.342333e-02 -9.909498e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.839296e-02 1.785569e-02 1.000000e-01 + vertex 7.907747e-02 1.211422e-02 1.000000e-01 + vertex 9.909498e-02 1.342333e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.839296e-02 1.785569e-02 1.000000e-01 + vertex 7.836240e-02 1.610388e-02 1.000000e-01 + vertex 7.907747e-02 1.211422e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.907747e-02 1.211422e-02 1.000000e-01 + vertex -9.909498e-02 1.342333e-02 1.000000e-01 + vertex -7.958955e-02 8.093466e-03 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.907747e-02 1.211422e-02 1.000000e-01 + vertex -9.839296e-02 1.785569e-02 1.000000e-01 + vertex -9.909498e-02 1.342333e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.785569e-02 9.839296e-02 1.000000e-01 + vertex 1.342333e-02 9.909498e-02 1.000000e-01 + vertex 1.211422e-02 7.907747e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.211422e-02 -7.907747e-02 1.000000e-01 + vertex 1.342333e-02 -9.909498e-02 1.000000e-01 + vertex 1.785569e-02 -9.839296e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.211422e-02 -7.907747e-02 1.000000e-01 + vertex 8.093466e-03 -7.958955e-02 1.000000e-01 + vertex 1.342333e-02 -9.909498e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.785569e-02 9.839296e-02 1.000000e-01 + vertex 1.211422e-02 7.907747e-02 1.000000e-01 + vertex 1.610388e-02 7.836240e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.225209e-02 9.749279e-02 1.000000e-01 + vertex 1.785569e-02 9.839296e-02 1.000000e-01 + vertex 1.610388e-02 7.836240e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.836240e-02 1.610388e-02 1.000000e-01 + vertex -9.839296e-02 1.785569e-02 1.000000e-01 + vertex -7.907747e-02 1.211422e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.225209e-02 9.749279e-02 1.000000e-01 + vertex 1.610388e-02 7.836240e-02 1.000000e-01 + vertex 2.005220e-02 7.744617e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.749279e-02 2.225209e-02 1.000000e-01 + vertex 7.836240e-02 1.610388e-02 1.000000e-01 + vertex 9.839296e-02 1.785569e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.836240e-02 1.610388e-02 1.000000e-01 + vertex -9.749279e-02 2.225209e-02 1.000000e-01 + vertex -9.839296e-02 1.785569e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.610388e-02 -7.836240e-02 1.000000e-01 + vertex 1.785569e-02 -9.839296e-02 1.000000e-01 + vertex 2.225209e-02 -9.749279e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.749279e-02 2.225209e-02 1.000000e-01 + vertex 7.744617e-02 2.005220e-02 1.000000e-01 + vertex 7.836240e-02 1.610388e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 1.610388e-02 -7.836240e-02 1.000000e-01 + vertex 1.211422e-02 -7.907747e-02 1.000000e-01 + vertex 1.785569e-02 -9.839296e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.660368e-02 9.639629e-02 1.000000e-01 + vertex 2.225209e-02 9.749279e-02 1.000000e-01 + vertex 2.005220e-02 7.744617e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.744617e-02 2.005220e-02 1.000000e-01 + vertex -9.749279e-02 2.225209e-02 1.000000e-01 + vertex -7.836240e-02 1.610388e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.660368e-02 9.639629e-02 1.000000e-01 + vertex 2.005220e-02 7.744617e-02 1.000000e-01 + vertex 2.394905e-02 7.633114e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.744617e-02 2.005220e-02 1.000000e-01 + vertex -9.639629e-02 2.660368e-02 1.000000e-01 + vertex -9.749279e-02 2.225209e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.005220e-02 -7.744617e-02 1.000000e-01 + vertex 1.610388e-02 -7.836240e-02 1.000000e-01 + vertex 2.225209e-02 -9.749279e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.005220e-02 -7.744617e-02 1.000000e-01 + vertex 2.225209e-02 -9.749279e-02 1.000000e-01 + vertex 2.660368e-02 -9.639629e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.639629e-02 2.660368e-02 1.000000e-01 + vertex 7.744617e-02 2.005220e-02 1.000000e-01 + vertex 9.749279e-02 2.225209e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.639629e-02 2.660368e-02 1.000000e-01 + vertex 7.633114e-02 2.394905e-02 1.000000e-01 + vertex 7.744617e-02 2.005220e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.090170e-02 9.510565e-02 1.000000e-01 + vertex 2.660368e-02 9.639629e-02 1.000000e-01 + vertex 2.394905e-02 7.633114e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.633114e-02 2.394905e-02 1.000000e-01 + vertex -9.639629e-02 2.660368e-02 1.000000e-01 + vertex -7.744617e-02 2.005220e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.633114e-02 2.394905e-02 1.000000e-01 + vertex -9.510565e-02 3.090170e-02 1.000000e-01 + vertex -9.639629e-02 2.660368e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.394905e-02 -7.633114e-02 1.000000e-01 + vertex 2.660368e-02 -9.639629e-02 1.000000e-01 + vertex 3.090170e-02 -9.510565e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.090170e-02 9.510565e-02 1.000000e-01 + vertex 2.394905e-02 7.633114e-02 1.000000e-01 + vertex 2.778442e-02 7.502017e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.510565e-02 3.090170e-02 1.000000e-01 + vertex 7.633114e-02 2.394905e-02 1.000000e-01 + vertex 9.639629e-02 2.660368e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.394905e-02 -7.633114e-02 1.000000e-01 + vertex 2.005220e-02 -7.744617e-02 1.000000e-01 + vertex 2.660368e-02 -9.639629e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.510565e-02 3.090170e-02 1.000000e-01 + vertex 7.502017e-02 2.778442e-02 1.000000e-01 + vertex 7.633114e-02 2.394905e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.502017e-02 2.778442e-02 1.000000e-01 + vertex -9.510565e-02 3.090170e-02 1.000000e-01 + vertex -7.633114e-02 2.394905e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.502017e-02 2.778442e-02 1.000000e-01 + vertex -9.362349e-02 3.513748e-02 1.000000e-01 + vertex -9.510565e-02 3.090170e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.513748e-02 9.362349e-02 1.000000e-01 + vertex 3.090170e-02 9.510565e-02 1.000000e-01 + vertex 2.778442e-02 7.502017e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.778442e-02 -7.502017e-02 1.000000e-01 + vertex 3.090170e-02 -9.510565e-02 1.000000e-01 + vertex 3.513748e-02 -9.362349e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 2.778442e-02 -7.502017e-02 1.000000e-01 + vertex 2.394905e-02 -7.633114e-02 1.000000e-01 + vertex 3.090170e-02 -9.510565e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.513748e-02 9.362349e-02 1.000000e-01 + vertex 2.778442e-02 7.502017e-02 1.000000e-01 + vertex 3.154847e-02 7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.362349e-02 3.513748e-02 1.000000e-01 + vertex 7.502017e-02 2.778442e-02 1.000000e-01 + vertex 9.510565e-02 3.090170e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.362349e-02 3.513748e-02 1.000000e-01 + vertex 7.351662e-02 3.154847e-02 1.000000e-01 + vertex 7.502017e-02 2.778442e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.351662e-02 3.154847e-02 1.000000e-01 + vertex -9.009689e-02 4.338837e-02 1.000000e-01 + vertex -9.195278e-02 3.930250e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.351662e-02 3.154847e-02 1.000000e-01 + vertex -9.195278e-02 3.930250e-02 1.000000e-01 + vertex -9.362349e-02 3.513748e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.351662e-02 3.154847e-02 1.000000e-01 + vertex -9.362349e-02 3.513748e-02 1.000000e-01 + vertex -7.502017e-02 2.778442e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.154847e-02 -7.351662e-02 1.000000e-01 + vertex 3.513748e-02 -9.362349e-02 1.000000e-01 + vertex 3.930250e-02 -9.195278e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.154847e-02 -7.351662e-02 1.000000e-01 + vertex 3.930250e-02 -9.195278e-02 1.000000e-01 + vertex 4.338837e-02 -9.009689e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.930250e-02 9.195278e-02 1.000000e-01 + vertex 3.513748e-02 9.362349e-02 1.000000e-01 + vertex 3.154847e-02 7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.154847e-02 -7.351662e-02 1.000000e-01 + vertex 2.778442e-02 -7.502017e-02 1.000000e-01 + vertex 3.513748e-02 -9.362349e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.195278e-02 3.930250e-02 1.000000e-01 + vertex 7.351662e-02 3.154847e-02 1.000000e-01 + vertex 9.362349e-02 3.513748e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.182436e-02 3.523153e-02 1.000000e-01 + vertex -8.805955e-02 4.738687e-02 1.000000e-01 + vertex -9.009689e-02 4.338837e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -7.182436e-02 3.523153e-02 1.000000e-01 + vertex -9.009689e-02 4.338837e-02 1.000000e-01 + vertex -7.351662e-02 3.154847e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.523153e-02 -7.182436e-02 1.000000e-01 + vertex 4.338837e-02 -9.009689e-02 1.000000e-01 + vertex 4.738687e-02 -8.805955e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.523153e-02 -7.182436e-02 1.000000e-01 + vertex 3.154847e-02 -7.351662e-02 1.000000e-01 + vertex 4.338837e-02 -9.009689e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.009689e-02 4.338837e-02 1.000000e-01 + vertex 7.182436e-02 3.523153e-02 1.000000e-01 + vertex 7.351662e-02 3.154847e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 9.009689e-02 4.338837e-02 1.000000e-01 + vertex 7.351662e-02 3.154847e-02 1.000000e-01 + vertex 9.195278e-02 3.930250e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.994773e-02 3.882416e-02 1.000000e-01 + vertex -8.584488e-02 5.128993e-02 1.000000e-01 + vertex -8.805955e-02 4.738687e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.994773e-02 3.882416e-02 1.000000e-01 + vertex -8.805955e-02 4.738687e-02 1.000000e-01 + vertex -7.182436e-02 3.523153e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.338837e-02 9.009689e-02 1.000000e-01 + vertex 3.930250e-02 9.195278e-02 1.000000e-01 + vertex 3.154847e-02 7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.882416e-02 -6.994773e-02 1.000000e-01 + vertex 4.738687e-02 -8.805955e-02 1.000000e-01 + vertex 5.128993e-02 -8.584488e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 3.882416e-02 -6.994773e-02 1.000000e-01 + vertex 3.523153e-02 -7.182436e-02 1.000000e-01 + vertex 4.738687e-02 -8.805955e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.338837e-02 9.009689e-02 1.000000e-01 + vertex 3.154847e-02 7.351662e-02 1.000000e-01 + vertex 3.523153e-02 7.182436e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.789154e-02 4.231712e-02 1.000000e-01 + vertex -8.345733e-02 5.508970e-02 1.000000e-01 + vertex -8.584488e-02 5.128993e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.789154e-02 4.231712e-02 1.000000e-01 + vertex -8.584488e-02 5.128993e-02 1.000000e-01 + vertex -6.994773e-02 3.882416e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.738687e-02 8.805955e-02 1.000000e-01 + vertex 3.523153e-02 7.182436e-02 1.000000e-01 + vertex 3.882416e-02 6.994773e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.738687e-02 8.805955e-02 1.000000e-01 + vertex 4.338837e-02 9.009689e-02 1.000000e-01 + vertex 3.523153e-02 7.182436e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.231712e-02 -6.789154e-02 1.000000e-01 + vertex 5.128993e-02 -8.584488e-02 1.000000e-01 + vertex 5.508970e-02 -8.345733e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.805955e-02 4.738687e-02 1.000000e-01 + vertex 6.994773e-02 3.882416e-02 1.000000e-01 + vertex 7.182436e-02 3.523153e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.231712e-02 -6.789154e-02 1.000000e-01 + vertex 3.882416e-02 -6.994773e-02 1.000000e-01 + vertex 5.128993e-02 -8.584488e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.805955e-02 4.738687e-02 1.000000e-01 + vertex 7.182436e-02 3.523153e-02 1.000000e-01 + vertex 9.009689e-02 4.338837e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.584488e-02 5.128993e-02 1.000000e-01 + vertex 6.994773e-02 3.882416e-02 1.000000e-01 + vertex 8.805955e-02 4.738687e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.584488e-02 5.128993e-02 1.000000e-01 + vertex 6.789154e-02 4.231712e-02 1.000000e-01 + vertex 6.994773e-02 3.882416e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.566108e-02 4.570146e-02 1.000000e-01 + vertex -8.090170e-02 5.877853e-02 1.000000e-01 + vertex -8.345733e-02 5.508970e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex -6.566108e-02 4.570146e-02 1.000000e-01 + vertex -8.345733e-02 5.508970e-02 1.000000e-01 + vertex -6.789154e-02 4.231712e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.128993e-02 8.584488e-02 1.000000e-01 + vertex 3.882416e-02 6.994773e-02 1.000000e-01 + vertex 4.231712e-02 6.789154e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 5.128993e-02 8.584488e-02 1.000000e-01 + vertex 4.738687e-02 8.805955e-02 1.000000e-01 + vertex 3.882416e-02 6.994773e-02 1.000000e-01 + endloop + endfacet + facet normal -0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.570146e-02 -6.566108e-02 1.000000e-01 + vertex 5.508970e-02 -8.345733e-02 1.000000e-01 + vertex 5.877853e-02 -8.090170e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 8.345733e-02 5.508970e-02 1.000000e-01 + vertex 6.566108e-02 4.570146e-02 1.000000e-01 + vertex 6.789154e-02 4.231712e-02 1.000000e-01 + endloop + endfacet + facet normal 0.000000e+00 0.000000e+00 1.000000e+00 + outer loop + vertex 4.570146e-02 -6.566108e-02 1.000000e-01 + vertex 4.231712e-02 -6.789154e-02 1.000000e-01 + vertex 5.508970e-02 -8.345733e-02 1.000000e-01 + endloop + endfacet + facet normal 1.263386e-01 9.919872e-01 -0.000000e+00 + outer loop + vertex -8.093466e-03 -7.958955e-02 8.000000e-02 + vertex -1.211422e-02 -7.907747e-02 8.000000e-02 + vertex -1.211422e-02 -7.907747e-02 1.000000e-01 + endloop + endfacet + facet normal 1.263386e-01 9.919872e-01 0.000000e+00 + outer loop + vertex -8.093466e-03 -7.958955e-02 8.000000e-02 + vertex -1.211422e-02 -7.907747e-02 1.000000e-01 + vertex -8.093466e-03 -7.958955e-02 1.000000e-01 + endloop + endfacet + facet normal 7.593311e-02 9.971129e-01 -0.000000e+00 + outer loop + vertex -4.051934e-03 -7.989732e-02 8.000000e-02 + vertex -8.093466e-03 -7.958955e-02 8.000000e-02 + vertex -8.093466e-03 -7.958955e-02 1.000000e-01 + endloop + endfacet + facet normal 7.593311e-02 9.971129e-01 0.000000e+00 + outer loop + vertex -4.051934e-03 -7.989732e-02 8.000000e-02 + vertex -8.093466e-03 -7.958955e-02 1.000000e-01 + vertex -4.051934e-03 -7.989732e-02 1.000000e-01 + endloop + endfacet + facet normal 2.533271e-02 9.996791e-01 -0.000000e+00 + outer loop + vertex 2.695213e-16 -8.000000e-02 8.000000e-02 + vertex -4.051934e-03 -7.989732e-02 8.000000e-02 + vertex -4.051934e-03 -7.989732e-02 1.000000e-01 + endloop + endfacet + facet normal 2.533271e-02 9.996791e-01 0.000000e+00 + outer loop + vertex 2.695213e-16 -8.000000e-02 8.000000e-02 + vertex -4.051934e-03 -7.989732e-02 1.000000e-01 + vertex 2.695213e-16 -8.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -9.996791e-01 -2.533271e-02 0.000000e+00 + outer loop + vertex 7.989732e-02 4.051934e-03 8.000000e-02 + vertex 8.000000e-02 0.000000e+00 1.000000e-01 + vertex 7.989732e-02 4.051934e-03 1.000000e-01 + endloop + endfacet + facet normal -9.996791e-01 -2.533271e-02 0.000000e+00 + outer loop + vertex 7.989732e-02 4.051934e-03 8.000000e-02 + vertex 8.000000e-02 0.000000e+00 8.000000e-02 + vertex 8.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal -2.533271e-02 9.996791e-01 0.000000e+00 + outer loop + vertex 4.051934e-03 -7.989732e-02 8.000000e-02 + vertex 2.695213e-16 -8.000000e-02 8.000000e-02 + vertex 2.695213e-16 -8.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -2.533271e-02 9.996791e-01 0.000000e+00 + outer loop + vertex 4.051934e-03 -7.989732e-02 8.000000e-02 + vertex 2.695213e-16 -8.000000e-02 1.000000e-01 + vertex 4.051934e-03 -7.989732e-02 1.000000e-01 + endloop + endfacet + facet normal -9.971129e-01 -7.593311e-02 0.000000e+00 + outer loop + vertex 7.958955e-02 8.093466e-03 8.000000e-02 + vertex 7.989732e-02 4.051934e-03 1.000000e-01 + vertex 7.958955e-02 8.093466e-03 1.000000e-01 + endloop + endfacet + facet normal -9.971129e-01 -7.593311e-02 0.000000e+00 + outer loop + vertex 7.958955e-02 8.093466e-03 8.000000e-02 + vertex 7.989732e-02 4.051934e-03 8.000000e-02 + vertex 7.989732e-02 4.051934e-03 1.000000e-01 + endloop + endfacet + facet normal -7.593311e-02 9.971129e-01 0.000000e+00 + outer loop + vertex 8.093466e-03 -7.958955e-02 8.000000e-02 + vertex 4.051934e-03 -7.989732e-02 8.000000e-02 + vertex 4.051934e-03 -7.989732e-02 1.000000e-01 + endloop + endfacet + facet normal -7.593311e-02 9.971129e-01 0.000000e+00 + outer loop + vertex 8.093466e-03 -7.958955e-02 8.000000e-02 + vertex 4.051934e-03 -7.989732e-02 1.000000e-01 + vertex 8.093466e-03 -7.958955e-02 1.000000e-01 + endloop + endfacet + facet normal -9.919872e-01 -1.263386e-01 0.000000e+00 + outer loop + vertex 7.907747e-02 1.211422e-02 8.000000e-02 + vertex 7.958955e-02 8.093466e-03 1.000000e-01 + vertex 7.907747e-02 1.211422e-02 1.000000e-01 + endloop + endfacet + facet normal -9.919872e-01 -1.263386e-01 0.000000e+00 + outer loop + vertex 7.907747e-02 1.211422e-02 8.000000e-02 + vertex 7.958955e-02 8.093466e-03 8.000000e-02 + vertex 7.958955e-02 8.093466e-03 1.000000e-01 + endloop + endfacet + facet normal -1.263386e-01 9.919872e-01 0.000000e+00 + outer loop + vertex 1.211422e-02 -7.907747e-02 8.000000e-02 + vertex 8.093466e-03 -7.958955e-02 8.000000e-02 + vertex 8.093466e-03 -7.958955e-02 1.000000e-01 + endloop + endfacet + facet normal -1.263386e-01 9.919872e-01 0.000000e+00 + outer loop + vertex 1.211422e-02 -7.907747e-02 8.000000e-02 + vertex 8.093466e-03 -7.958955e-02 1.000000e-01 + vertex 1.211422e-02 -7.907747e-02 1.000000e-01 + endloop + endfacet + facet normal -9.843150e-01 -1.764198e-01 0.000000e+00 + outer loop + vertex 7.836240e-02 1.610388e-02 8.000000e-02 + vertex 7.907747e-02 1.211422e-02 1.000000e-01 + vertex 7.836240e-02 1.610388e-02 1.000000e-01 + endloop + endfacet + facet normal -1.764198e-01 9.843150e-01 0.000000e+00 + outer loop + vertex 1.610388e-02 -7.836240e-02 8.000000e-02 + vertex 1.211422e-02 -7.907747e-02 8.000000e-02 + vertex 1.211422e-02 -7.907747e-02 1.000000e-01 + endloop + endfacet + facet normal -9.843150e-01 -1.764198e-01 0.000000e+00 + outer loop + vertex 7.836240e-02 1.610388e-02 8.000000e-02 + vertex 7.907747e-02 1.211422e-02 8.000000e-02 + vertex 7.907747e-02 1.211422e-02 1.000000e-01 + endloop + endfacet + facet normal -1.764198e-01 9.843150e-01 0.000000e+00 + outer loop + vertex 1.610388e-02 -7.836240e-02 8.000000e-02 + vertex 1.211422e-02 -7.907747e-02 1.000000e-01 + vertex 1.610388e-02 -7.836240e-02 1.000000e-01 + endloop + endfacet + facet normal -9.741161e-01 -2.260481e-01 0.000000e+00 + outer loop + vertex 7.744617e-02 2.005220e-02 8.000000e-02 + vertex 7.836240e-02 1.610388e-02 1.000000e-01 + vertex 7.744617e-02 2.005220e-02 1.000000e-01 + endloop + endfacet + facet normal -2.260481e-01 9.741161e-01 0.000000e+00 + outer loop + vertex 2.005220e-02 -7.744617e-02 8.000000e-02 + vertex 1.610388e-02 -7.836240e-02 8.000000e-02 + vertex 1.610388e-02 -7.836240e-02 1.000000e-01 + endloop + endfacet + facet normal -9.741161e-01 -2.260481e-01 0.000000e+00 + outer loop + vertex 7.744617e-02 2.005220e-02 8.000000e-02 + vertex 7.836240e-02 1.610388e-02 8.000000e-02 + vertex 7.836240e-02 1.610388e-02 1.000000e-01 + endloop + endfacet + facet normal -2.260481e-01 9.741161e-01 0.000000e+00 + outer loop + vertex 2.005220e-02 -7.744617e-02 8.000000e-02 + vertex 1.610388e-02 -7.836240e-02 1.000000e-01 + vertex 2.005220e-02 -7.744617e-02 1.000000e-01 + endloop + endfacet + facet normal -9.614167e-01 -2.750961e-01 0.000000e+00 + outer loop + vertex 7.633114e-02 2.394905e-02 8.000000e-02 + vertex 7.744617e-02 2.005220e-02 1.000000e-01 + vertex 7.633114e-02 2.394905e-02 1.000000e-01 + endloop + endfacet + facet normal -2.750961e-01 9.614167e-01 0.000000e+00 + outer loop + vertex 2.394905e-02 -7.633114e-02 8.000000e-02 + vertex 2.005220e-02 -7.744617e-02 8.000000e-02 + vertex 2.005220e-02 -7.744617e-02 1.000000e-01 + endloop + endfacet + facet normal -9.614167e-01 -2.750961e-01 0.000000e+00 + outer loop + vertex 7.633114e-02 2.394905e-02 8.000000e-02 + vertex 7.744617e-02 2.005220e-02 8.000000e-02 + vertex 7.744617e-02 2.005220e-02 1.000000e-01 + endloop + endfacet + facet normal -2.750961e-01 9.614167e-01 0.000000e+00 + outer loop + vertex 2.394905e-02 -7.633114e-02 8.000000e-02 + vertex 2.005220e-02 -7.744617e-02 1.000000e-01 + vertex 2.394905e-02 -7.633114e-02 1.000000e-01 + endloop + endfacet + facet normal -9.462494e-01 -3.234380e-01 0.000000e+00 + outer loop + vertex 7.502017e-02 2.778442e-02 8.000000e-02 + vertex 7.633114e-02 2.394905e-02 1.000000e-01 + vertex 7.502017e-02 2.778442e-02 1.000000e-01 + endloop + endfacet + facet normal -3.234380e-01 9.462494e-01 0.000000e+00 + outer loop + vertex 2.778442e-02 -7.502017e-02 8.000000e-02 + vertex 2.394905e-02 -7.633114e-02 8.000000e-02 + vertex 2.394905e-02 -7.633114e-02 1.000000e-01 + endloop + endfacet + facet normal -9.462494e-01 -3.234380e-01 0.000000e+00 + outer loop + vertex 7.502017e-02 2.778442e-02 8.000000e-02 + vertex 7.633114e-02 2.394905e-02 8.000000e-02 + vertex 7.633114e-02 2.394905e-02 1.000000e-01 + endloop + endfacet + facet normal -3.234380e-01 9.462494e-01 0.000000e+00 + outer loop + vertex 2.778442e-02 -7.502017e-02 8.000000e-02 + vertex 2.394905e-02 -7.633114e-02 1.000000e-01 + vertex 2.778442e-02 -7.502017e-02 1.000000e-01 + endloop + endfacet + facet normal -3.709496e-01 9.286530e-01 0.000000e+00 + outer loop + vertex 3.154847e-02 -7.351662e-02 8.000000e-02 + vertex 2.778442e-02 -7.502017e-02 1.000000e-01 + vertex 3.154847e-02 -7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal -9.286530e-01 -3.709496e-01 0.000000e+00 + outer loop + vertex 7.351662e-02 3.154847e-02 8.000000e-02 + vertex 7.502017e-02 2.778442e-02 1.000000e-01 + vertex 7.351662e-02 3.154847e-02 1.000000e-01 + endloop + endfacet + facet normal -3.709496e-01 9.286530e-01 0.000000e+00 + outer loop + vertex 3.154847e-02 -7.351662e-02 8.000000e-02 + vertex 2.778442e-02 -7.502017e-02 8.000000e-02 + vertex 2.778442e-02 -7.502017e-02 1.000000e-01 + endloop + endfacet + facet normal -9.286530e-01 -3.709496e-01 0.000000e+00 + outer loop + vertex 7.351662e-02 3.154847e-02 8.000000e-02 + vertex 7.502017e-02 2.778442e-02 8.000000e-02 + vertex 7.502017e-02 2.778442e-02 1.000000e-01 + endloop + endfacet + facet normal -4.175090e-01 9.086728e-01 0.000000e+00 + outer loop + vertex 3.523153e-02 -7.182436e-02 8.000000e-02 + vertex 3.154847e-02 -7.351662e-02 1.000000e-01 + vertex 3.523153e-02 -7.182436e-02 1.000000e-01 + endloop + endfacet + facet normal -9.086728e-01 -4.175090e-01 0.000000e+00 + outer loop + vertex 7.182436e-02 3.523153e-02 8.000000e-02 + vertex 7.351662e-02 3.154847e-02 1.000000e-01 + vertex 7.182436e-02 3.523153e-02 1.000000e-01 + endloop + endfacet + facet normal -4.175090e-01 9.086728e-01 0.000000e+00 + outer loop + vertex 3.523153e-02 -7.182436e-02 8.000000e-02 + vertex 3.154847e-02 -7.351662e-02 8.000000e-02 + vertex 3.154847e-02 -7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal -9.086728e-01 -4.175090e-01 0.000000e+00 + outer loop + vertex 7.182436e-02 3.523153e-02 8.000000e-02 + vertex 7.351662e-02 3.154847e-02 8.000000e-02 + vertex 7.351662e-02 3.154847e-02 1.000000e-01 + endloop + endfacet + facet normal -4.629966e-01 8.863600e-01 0.000000e+00 + outer loop + vertex 3.882416e-02 -6.994773e-02 8.000000e-02 + vertex 3.523153e-02 -7.182436e-02 1.000000e-01 + vertex 3.882416e-02 -6.994773e-02 1.000000e-01 + endloop + endfacet + facet normal -4.629966e-01 8.863600e-01 0.000000e+00 + outer loop + vertex 3.882416e-02 -6.994773e-02 8.000000e-02 + vertex 3.523153e-02 -7.182436e-02 8.000000e-02 + vertex 3.523153e-02 -7.182436e-02 1.000000e-01 + endloop + endfacet + facet normal -8.863600e-01 -4.629966e-01 0.000000e+00 + outer loop + vertex 6.994773e-02 3.882416e-02 8.000000e-02 + vertex 7.182436e-02 3.523153e-02 1.000000e-01 + vertex 6.994773e-02 3.882416e-02 1.000000e-01 + endloop + endfacet + facet normal -8.863600e-01 -4.629966e-01 0.000000e+00 + outer loop + vertex 6.994773e-02 3.882416e-02 8.000000e-02 + vertex 7.182436e-02 3.523153e-02 8.000000e-02 + vertex 7.182436e-02 3.523153e-02 1.000000e-01 + endloop + endfacet + facet normal -5.072958e-01 8.617720e-01 0.000000e+00 + outer loop + vertex 4.231712e-02 -6.789154e-02 8.000000e-02 + vertex 3.882416e-02 -6.994773e-02 1.000000e-01 + vertex 4.231712e-02 -6.789154e-02 1.000000e-01 + endloop + endfacet + facet normal -5.072958e-01 8.617720e-01 0.000000e+00 + outer loop + vertex 4.231712e-02 -6.789154e-02 8.000000e-02 + vertex 3.882416e-02 -6.994773e-02 8.000000e-02 + vertex 3.882416e-02 -6.994773e-02 1.000000e-01 + endloop + endfacet + facet normal -8.617720e-01 -5.072958e-01 0.000000e+00 + outer loop + vertex 6.789154e-02 4.231712e-02 8.000000e-02 + vertex 6.994773e-02 3.882416e-02 1.000000e-01 + vertex 6.789154e-02 4.231712e-02 1.000000e-01 + endloop + endfacet + facet normal -8.617720e-01 -5.072958e-01 0.000000e+00 + outer loop + vertex 6.789154e-02 4.231712e-02 8.000000e-02 + vertex 6.994773e-02 3.882416e-02 8.000000e-02 + vertex 6.994773e-02 3.882416e-02 1.000000e-01 + endloop + endfacet + facet normal -5.502927e-01 8.349718e-01 0.000000e+00 + outer loop + vertex 4.570146e-02 -6.566108e-02 8.000000e-02 + vertex 4.231712e-02 -6.789154e-02 1.000000e-01 + vertex 4.570146e-02 -6.566108e-02 1.000000e-01 + endloop + endfacet + facet normal -5.502927e-01 8.349718e-01 0.000000e+00 + outer loop + vertex 4.570146e-02 -6.566108e-02 8.000000e-02 + vertex 4.231712e-02 -6.789154e-02 8.000000e-02 + vertex 4.231712e-02 -6.789154e-02 1.000000e-01 + endloop + endfacet + facet normal -8.349718e-01 -5.502927e-01 0.000000e+00 + outer loop + vertex 6.566108e-02 4.570146e-02 8.000000e-02 + vertex 6.789154e-02 4.231712e-02 8.000000e-02 + vertex 6.789154e-02 4.231712e-02 1.000000e-01 + endloop + endfacet + facet normal -8.349718e-01 -5.502927e-01 0.000000e+00 + outer loop + vertex 6.566108e-02 4.570146e-02 8.000000e-02 + vertex 6.789154e-02 4.231712e-02 1.000000e-01 + vertex 6.566108e-02 4.570146e-02 1.000000e-01 + endloop + endfacet + facet normal -5.918770e-01 8.060283e-01 0.000000e+00 + outer loop + vertex 4.896848e-02 -6.326206e-02 8.000000e-02 + vertex 4.570146e-02 -6.566108e-02 1.000000e-01 + vertex 4.896848e-02 -6.326206e-02 1.000000e-01 + endloop + endfacet + facet normal -5.918770e-01 8.060283e-01 0.000000e+00 + outer loop + vertex 4.896848e-02 -6.326206e-02 8.000000e-02 + vertex 4.570146e-02 -6.566108e-02 8.000000e-02 + vertex 4.570146e-02 -6.566108e-02 1.000000e-01 + endloop + endfacet + facet normal -8.060283e-01 -5.918770e-01 0.000000e+00 + outer loop + vertex 6.326206e-02 4.896848e-02 8.000000e-02 + vertex 6.566108e-02 4.570146e-02 8.000000e-02 + vertex 6.566108e-02 4.570146e-02 1.000000e-01 + endloop + endfacet + facet normal -6.319420e-01 7.750157e-01 0.000000e+00 + outer loop + vertex 5.210980e-02 -6.070065e-02 8.000000e-02 + vertex 4.896848e-02 -6.326206e-02 1.000000e-01 + vertex 5.210980e-02 -6.070065e-02 1.000000e-01 + endloop + endfacet + facet normal -8.060283e-01 -5.918770e-01 0.000000e+00 + outer loop + vertex 6.326206e-02 4.896848e-02 8.000000e-02 + vertex 6.566108e-02 4.570146e-02 1.000000e-01 + vertex 6.326206e-02 4.896848e-02 1.000000e-01 + endloop + endfacet + facet normal -6.319420e-01 7.750157e-01 0.000000e+00 + outer loop + vertex 5.210980e-02 -6.070065e-02 8.000000e-02 + vertex 4.896848e-02 -6.326206e-02 8.000000e-02 + vertex 4.896848e-02 -6.326206e-02 1.000000e-01 + endloop + endfacet + facet normal -6.703848e-01 7.420136e-01 0.000000e+00 + outer loop + vertex 5.511735e-02 -5.798342e-02 8.000000e-02 + vertex 5.210980e-02 -6.070065e-02 1.000000e-01 + vertex 5.511735e-02 -5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal -7.750157e-01 -6.319420e-01 0.000000e+00 + outer loop + vertex 6.070065e-02 5.210980e-02 8.000000e-02 + vertex 6.326206e-02 4.896848e-02 8.000000e-02 + vertex 6.326206e-02 4.896848e-02 1.000000e-01 + endloop + endfacet + facet normal -7.750157e-01 -6.319420e-01 0.000000e+00 + outer loop + vertex 6.070065e-02 5.210980e-02 8.000000e-02 + vertex 6.326206e-02 4.896848e-02 1.000000e-01 + vertex 6.070065e-02 5.210980e-02 1.000000e-01 + endloop + endfacet + facet normal -6.703848e-01 7.420136e-01 0.000000e+00 + outer loop + vertex 5.511735e-02 -5.798342e-02 8.000000e-02 + vertex 5.210980e-02 -6.070065e-02 8.000000e-02 + vertex 5.210980e-02 -6.070065e-02 1.000000e-01 + endloop + endfacet + facet normal -7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex 5.798342e-02 -5.511735e-02 8.000000e-02 + vertex 5.511735e-02 -5.798342e-02 1.000000e-01 + vertex 5.798342e-02 -5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal -7.420136e-01 -6.703848e-01 0.000000e+00 + outer loop + vertex 5.798342e-02 5.511735e-02 8.000000e-02 + vertex 6.070065e-02 5.210980e-02 8.000000e-02 + vertex 6.070065e-02 5.210980e-02 1.000000e-01 + endloop + endfacet + facet normal -7.420136e-01 -6.703848e-01 0.000000e+00 + outer loop + vertex 5.798342e-02 5.511735e-02 8.000000e-02 + vertex 6.070065e-02 5.210980e-02 1.000000e-01 + vertex 5.798342e-02 5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal -7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex 5.798342e-02 -5.511735e-02 8.000000e-02 + vertex 5.511735e-02 -5.798342e-02 8.000000e-02 + vertex 5.511735e-02 -5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal -7.420136e-01 6.703848e-01 0.000000e+00 + outer loop + vertex 6.070065e-02 -5.210980e-02 8.000000e-02 + vertex 5.798342e-02 -5.511735e-02 1.000000e-01 + vertex 6.070065e-02 -5.210980e-02 1.000000e-01 + endloop + endfacet + facet normal -7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex 5.511735e-02 5.798342e-02 8.000000e-02 + vertex 5.798342e-02 5.511735e-02 1.000000e-01 + vertex 5.511735e-02 5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal -7.420136e-01 6.703848e-01 0.000000e+00 + outer loop + vertex 6.070065e-02 -5.210980e-02 8.000000e-02 + vertex 5.798342e-02 -5.511735e-02 8.000000e-02 + vertex 5.798342e-02 -5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal -7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex 5.511735e-02 5.798342e-02 8.000000e-02 + vertex 5.798342e-02 5.511735e-02 8.000000e-02 + vertex 5.798342e-02 5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal -7.750157e-01 6.319420e-01 0.000000e+00 + outer loop + vertex 6.326206e-02 -4.896848e-02 8.000000e-02 + vertex 6.070065e-02 -5.210980e-02 1.000000e-01 + vertex 6.326206e-02 -4.896848e-02 1.000000e-01 + endloop + endfacet + facet normal -6.703848e-01 -7.420136e-01 0.000000e+00 + outer loop + vertex 5.210980e-02 6.070065e-02 8.000000e-02 + vertex 5.511735e-02 5.798342e-02 1.000000e-01 + vertex 5.210980e-02 6.070065e-02 1.000000e-01 + endloop + endfacet + facet normal -7.750157e-01 6.319420e-01 0.000000e+00 + outer loop + vertex 6.326206e-02 -4.896848e-02 8.000000e-02 + vertex 6.070065e-02 -5.210980e-02 8.000000e-02 + vertex 6.070065e-02 -5.210980e-02 1.000000e-01 + endloop + endfacet + facet normal -6.703848e-01 -7.420136e-01 0.000000e+00 + outer loop + vertex 5.210980e-02 6.070065e-02 8.000000e-02 + vertex 5.511735e-02 5.798342e-02 8.000000e-02 + vertex 5.511735e-02 5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal -8.060283e-01 5.918770e-01 0.000000e+00 + outer loop + vertex 6.566108e-02 -4.570146e-02 8.000000e-02 + vertex 6.326206e-02 -4.896848e-02 1.000000e-01 + vertex 6.566108e-02 -4.570146e-02 1.000000e-01 + endloop + endfacet + facet normal -6.319420e-01 -7.750157e-01 0.000000e+00 + outer loop + vertex 4.896848e-02 6.326206e-02 8.000000e-02 + vertex 5.210980e-02 6.070065e-02 1.000000e-01 + vertex 4.896848e-02 6.326206e-02 1.000000e-01 + endloop + endfacet + facet normal -8.060283e-01 5.918770e-01 0.000000e+00 + outer loop + vertex 6.566108e-02 -4.570146e-02 8.000000e-02 + vertex 6.326206e-02 -4.896848e-02 8.000000e-02 + vertex 6.326206e-02 -4.896848e-02 1.000000e-01 + endloop + endfacet + facet normal -6.319420e-01 -7.750157e-01 0.000000e+00 + outer loop + vertex 4.896848e-02 6.326206e-02 8.000000e-02 + vertex 5.210980e-02 6.070065e-02 8.000000e-02 + vertex 5.210980e-02 6.070065e-02 1.000000e-01 + endloop + endfacet + facet normal -8.349718e-01 5.502927e-01 0.000000e+00 + outer loop + vertex 6.789154e-02 -4.231712e-02 8.000000e-02 + vertex 6.566108e-02 -4.570146e-02 1.000000e-01 + vertex 6.789154e-02 -4.231712e-02 1.000000e-01 + endloop + endfacet + facet normal -5.918770e-01 -8.060283e-01 0.000000e+00 + outer loop + vertex 4.570146e-02 6.566108e-02 8.000000e-02 + vertex 4.896848e-02 6.326206e-02 1.000000e-01 + vertex 4.570146e-02 6.566108e-02 1.000000e-01 + endloop + endfacet + facet normal -8.349718e-01 5.502927e-01 0.000000e+00 + outer loop + vertex 6.789154e-02 -4.231712e-02 8.000000e-02 + vertex 6.566108e-02 -4.570146e-02 8.000000e-02 + vertex 6.566108e-02 -4.570146e-02 1.000000e-01 + endloop + endfacet + facet normal -5.918770e-01 -8.060283e-01 0.000000e+00 + outer loop + vertex 4.570146e-02 6.566108e-02 8.000000e-02 + vertex 4.896848e-02 6.326206e-02 8.000000e-02 + vertex 4.896848e-02 6.326206e-02 1.000000e-01 + endloop + endfacet + facet normal -8.617720e-01 5.072958e-01 0.000000e+00 + outer loop + vertex 6.994773e-02 -3.882416e-02 8.000000e-02 + vertex 6.789154e-02 -4.231712e-02 8.000000e-02 + vertex 6.789154e-02 -4.231712e-02 1.000000e-01 + endloop + endfacet + facet normal -8.617720e-01 5.072958e-01 0.000000e+00 + outer loop + vertex 6.994773e-02 -3.882416e-02 8.000000e-02 + vertex 6.789154e-02 -4.231712e-02 1.000000e-01 + vertex 6.994773e-02 -3.882416e-02 1.000000e-01 + endloop + endfacet + facet normal -5.502927e-01 -8.349718e-01 0.000000e+00 + outer loop + vertex 4.231712e-02 6.789154e-02 8.000000e-02 + vertex 4.570146e-02 6.566108e-02 1.000000e-01 + vertex 4.231712e-02 6.789154e-02 1.000000e-01 + endloop + endfacet + facet normal -5.502927e-01 -8.349718e-01 0.000000e+00 + outer loop + vertex 4.231712e-02 6.789154e-02 8.000000e-02 + vertex 4.570146e-02 6.566108e-02 8.000000e-02 + vertex 4.570146e-02 6.566108e-02 1.000000e-01 + endloop + endfacet + facet normal -8.863600e-01 4.629966e-01 0.000000e+00 + outer loop + vertex 7.182436e-02 -3.523153e-02 8.000000e-02 + vertex 6.994773e-02 -3.882416e-02 8.000000e-02 + vertex 6.994773e-02 -3.882416e-02 1.000000e-01 + endloop + endfacet + facet normal -8.863600e-01 4.629966e-01 0.000000e+00 + outer loop + vertex 7.182436e-02 -3.523153e-02 8.000000e-02 + vertex 6.994773e-02 -3.882416e-02 1.000000e-01 + vertex 7.182436e-02 -3.523153e-02 1.000000e-01 + endloop + endfacet + facet normal -5.072958e-01 -8.617720e-01 0.000000e+00 + outer loop + vertex 3.882416e-02 6.994773e-02 8.000000e-02 + vertex 4.231712e-02 6.789154e-02 1.000000e-01 + vertex 3.882416e-02 6.994773e-02 1.000000e-01 + endloop + endfacet + facet normal -5.072958e-01 -8.617720e-01 0.000000e+00 + outer loop + vertex 3.882416e-02 6.994773e-02 8.000000e-02 + vertex 4.231712e-02 6.789154e-02 8.000000e-02 + vertex 4.231712e-02 6.789154e-02 1.000000e-01 + endloop + endfacet + facet normal -9.086728e-01 4.175090e-01 0.000000e+00 + outer loop + vertex 7.351662e-02 -3.154847e-02 8.000000e-02 + vertex 7.182436e-02 -3.523153e-02 8.000000e-02 + vertex 7.182436e-02 -3.523153e-02 1.000000e-01 + endloop + endfacet + facet normal -9.086728e-01 4.175090e-01 0.000000e+00 + outer loop + vertex 7.351662e-02 -3.154847e-02 8.000000e-02 + vertex 7.182436e-02 -3.523153e-02 1.000000e-01 + vertex 7.351662e-02 -3.154847e-02 1.000000e-01 + endloop + endfacet + facet normal -4.629966e-01 -8.863600e-01 0.000000e+00 + outer loop + vertex 3.523153e-02 7.182436e-02 8.000000e-02 + vertex 3.882416e-02 6.994773e-02 1.000000e-01 + vertex 3.523153e-02 7.182436e-02 1.000000e-01 + endloop + endfacet + facet normal -4.629966e-01 -8.863600e-01 0.000000e+00 + outer loop + vertex 3.523153e-02 7.182436e-02 8.000000e-02 + vertex 3.882416e-02 6.994773e-02 8.000000e-02 + vertex 3.882416e-02 6.994773e-02 1.000000e-01 + endloop + endfacet + facet normal -9.286530e-01 3.709496e-01 0.000000e+00 + outer loop + vertex 7.502017e-02 -2.778442e-02 8.000000e-02 + vertex 7.351662e-02 -3.154847e-02 1.000000e-01 + vertex 7.502017e-02 -2.778442e-02 1.000000e-01 + endloop + endfacet + facet normal -9.286530e-01 3.709496e-01 0.000000e+00 + outer loop + vertex 7.502017e-02 -2.778442e-02 8.000000e-02 + vertex 7.351662e-02 -3.154847e-02 8.000000e-02 + vertex 7.351662e-02 -3.154847e-02 1.000000e-01 + endloop + endfacet + facet normal -4.175090e-01 -9.086728e-01 0.000000e+00 + outer loop + vertex 3.154847e-02 7.351662e-02 8.000000e-02 + vertex 3.523153e-02 7.182436e-02 1.000000e-01 + vertex 3.154847e-02 7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal -9.462494e-01 3.234380e-01 0.000000e+00 + outer loop + vertex 7.633114e-02 -2.394905e-02 8.000000e-02 + vertex 7.502017e-02 -2.778442e-02 1.000000e-01 + vertex 7.633114e-02 -2.394905e-02 1.000000e-01 + endloop + endfacet + facet normal -4.175090e-01 -9.086728e-01 0.000000e+00 + outer loop + vertex 3.154847e-02 7.351662e-02 8.000000e-02 + vertex 3.523153e-02 7.182436e-02 8.000000e-02 + vertex 3.523153e-02 7.182436e-02 1.000000e-01 + endloop + endfacet + facet normal -9.462494e-01 3.234380e-01 0.000000e+00 + outer loop + vertex 7.633114e-02 -2.394905e-02 8.000000e-02 + vertex 7.502017e-02 -2.778442e-02 8.000000e-02 + vertex 7.502017e-02 -2.778442e-02 1.000000e-01 + endloop + endfacet + facet normal -3.709496e-01 -9.286530e-01 0.000000e+00 + outer loop + vertex 2.778442e-02 7.502017e-02 8.000000e-02 + vertex 3.154847e-02 7.351662e-02 1.000000e-01 + vertex 2.778442e-02 7.502017e-02 1.000000e-01 + endloop + endfacet + facet normal -9.614167e-01 2.750961e-01 0.000000e+00 + outer loop + vertex 7.744617e-02 -2.005220e-02 8.000000e-02 + vertex 7.633114e-02 -2.394905e-02 1.000000e-01 + vertex 7.744617e-02 -2.005220e-02 1.000000e-01 + endloop + endfacet + facet normal -3.709496e-01 -9.286530e-01 0.000000e+00 + outer loop + vertex 2.778442e-02 7.502017e-02 8.000000e-02 + vertex 3.154847e-02 7.351662e-02 8.000000e-02 + vertex 3.154847e-02 7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal -9.614167e-01 2.750961e-01 0.000000e+00 + outer loop + vertex 7.744617e-02 -2.005220e-02 8.000000e-02 + vertex 7.633114e-02 -2.394905e-02 8.000000e-02 + vertex 7.633114e-02 -2.394905e-02 1.000000e-01 + endloop + endfacet + facet normal -3.234380e-01 -9.462494e-01 0.000000e+00 + outer loop + vertex 2.394905e-02 7.633114e-02 8.000000e-02 + vertex 2.778442e-02 7.502017e-02 1.000000e-01 + vertex 2.394905e-02 7.633114e-02 1.000000e-01 + endloop + endfacet + facet normal -9.741161e-01 2.260481e-01 0.000000e+00 + outer loop + vertex 7.836240e-02 -1.610388e-02 8.000000e-02 + vertex 7.744617e-02 -2.005220e-02 1.000000e-01 + vertex 7.836240e-02 -1.610388e-02 1.000000e-01 + endloop + endfacet + facet normal -3.234380e-01 -9.462494e-01 0.000000e+00 + outer loop + vertex 2.394905e-02 7.633114e-02 8.000000e-02 + vertex 2.778442e-02 7.502017e-02 8.000000e-02 + vertex 2.778442e-02 7.502017e-02 1.000000e-01 + endloop + endfacet + facet normal -9.741161e-01 2.260481e-01 0.000000e+00 + outer loop + vertex 7.836240e-02 -1.610388e-02 8.000000e-02 + vertex 7.744617e-02 -2.005220e-02 8.000000e-02 + vertex 7.744617e-02 -2.005220e-02 1.000000e-01 + endloop + endfacet + facet normal -9.843150e-01 1.764198e-01 0.000000e+00 + outer loop + vertex 7.907747e-02 -1.211422e-02 8.000000e-02 + vertex 7.836240e-02 -1.610388e-02 1.000000e-01 + vertex 7.907747e-02 -1.211422e-02 1.000000e-01 + endloop + endfacet + facet normal -2.750961e-01 -9.614167e-01 0.000000e+00 + outer loop + vertex 2.005220e-02 7.744617e-02 8.000000e-02 + vertex 2.394905e-02 7.633114e-02 1.000000e-01 + vertex 2.005220e-02 7.744617e-02 1.000000e-01 + endloop + endfacet + facet normal -9.843150e-01 1.764198e-01 0.000000e+00 + outer loop + vertex 7.907747e-02 -1.211422e-02 8.000000e-02 + vertex 7.836240e-02 -1.610388e-02 8.000000e-02 + vertex 7.836240e-02 -1.610388e-02 1.000000e-01 + endloop + endfacet + facet normal -2.750961e-01 -9.614167e-01 0.000000e+00 + outer loop + vertex 2.005220e-02 7.744617e-02 8.000000e-02 + vertex 2.394905e-02 7.633114e-02 8.000000e-02 + vertex 2.394905e-02 7.633114e-02 1.000000e-01 + endloop + endfacet + facet normal -9.919872e-01 1.263386e-01 0.000000e+00 + outer loop + vertex 7.958955e-02 -8.093466e-03 8.000000e-02 + vertex 7.907747e-02 -1.211422e-02 1.000000e-01 + vertex 7.958955e-02 -8.093466e-03 1.000000e-01 + endloop + endfacet + facet normal -2.260481e-01 -9.741161e-01 0.000000e+00 + outer loop + vertex 1.610388e-02 7.836240e-02 8.000000e-02 + vertex 2.005220e-02 7.744617e-02 1.000000e-01 + vertex 1.610388e-02 7.836240e-02 1.000000e-01 + endloop + endfacet + facet normal -9.919872e-01 1.263386e-01 0.000000e+00 + outer loop + vertex 7.958955e-02 -8.093466e-03 8.000000e-02 + vertex 7.907747e-02 -1.211422e-02 8.000000e-02 + vertex 7.907747e-02 -1.211422e-02 1.000000e-01 + endloop + endfacet + facet normal -2.260481e-01 -9.741161e-01 0.000000e+00 + outer loop + vertex 1.610388e-02 7.836240e-02 8.000000e-02 + vertex 2.005220e-02 7.744617e-02 8.000000e-02 + vertex 2.005220e-02 7.744617e-02 1.000000e-01 + endloop + endfacet + facet normal -9.971129e-01 7.593311e-02 0.000000e+00 + outer loop + vertex 7.989732e-02 -4.051934e-03 8.000000e-02 + vertex 7.958955e-02 -8.093466e-03 1.000000e-01 + vertex 7.989732e-02 -4.051934e-03 1.000000e-01 + endloop + endfacet + facet normal -9.971129e-01 7.593311e-02 0.000000e+00 + outer loop + vertex 7.989732e-02 -4.051934e-03 8.000000e-02 + vertex 7.958955e-02 -8.093466e-03 8.000000e-02 + vertex 7.958955e-02 -8.093466e-03 1.000000e-01 + endloop + endfacet + facet normal -1.764198e-01 -9.843150e-01 0.000000e+00 + outer loop + vertex 1.211422e-02 7.907747e-02 8.000000e-02 + vertex 1.610388e-02 7.836240e-02 1.000000e-01 + vertex 1.211422e-02 7.907747e-02 1.000000e-01 + endloop + endfacet + facet normal -9.996791e-01 2.533271e-02 0.000000e+00 + outer loop + vertex 8.000000e-02 0.000000e+00 8.000000e-02 + vertex 7.989732e-02 -4.051934e-03 8.000000e-02 + vertex 7.989732e-02 -4.051934e-03 1.000000e-01 + endloop + endfacet + facet normal -9.996791e-01 2.533271e-02 0.000000e+00 + outer loop + vertex 8.000000e-02 0.000000e+00 8.000000e-02 + vertex 7.989732e-02 -4.051934e-03 1.000000e-01 + vertex 8.000000e-02 0.000000e+00 1.000000e-01 + endloop + endfacet + facet normal -1.764198e-01 -9.843150e-01 0.000000e+00 + outer loop + vertex 1.211422e-02 7.907747e-02 8.000000e-02 + vertex 1.610388e-02 7.836240e-02 8.000000e-02 + vertex 1.610388e-02 7.836240e-02 1.000000e-01 + endloop + endfacet + facet normal -1.263386e-01 -9.919872e-01 0.000000e+00 + outer loop + vertex 8.093466e-03 7.958955e-02 8.000000e-02 + vertex 1.211422e-02 7.907747e-02 1.000000e-01 + vertex 8.093466e-03 7.958955e-02 1.000000e-01 + endloop + endfacet + facet normal -1.263386e-01 -9.919872e-01 0.000000e+00 + outer loop + vertex 8.093466e-03 7.958955e-02 8.000000e-02 + vertex 1.211422e-02 7.907747e-02 8.000000e-02 + vertex 1.211422e-02 7.907747e-02 1.000000e-01 + endloop + endfacet + facet normal -7.593311e-02 -9.971129e-01 0.000000e+00 + outer loop + vertex 4.051934e-03 7.989732e-02 8.000000e-02 + vertex 8.093466e-03 7.958955e-02 1.000000e-01 + vertex 4.051934e-03 7.989732e-02 1.000000e-01 + endloop + endfacet + facet normal -7.593311e-02 -9.971129e-01 0.000000e+00 + outer loop + vertex 4.051934e-03 7.989732e-02 8.000000e-02 + vertex 8.093466e-03 7.958955e-02 8.000000e-02 + vertex 8.093466e-03 7.958955e-02 1.000000e-01 + endloop + endfacet + facet normal -2.533271e-02 -9.996791e-01 0.000000e+00 + outer loop + vertex 4.898587e-18 8.000000e-02 8.000000e-02 + vertex 4.051934e-03 7.989732e-02 1.000000e-01 + vertex 4.898587e-18 8.000000e-02 1.000000e-01 + endloop + endfacet + facet normal -2.533271e-02 -9.996791e-01 0.000000e+00 + outer loop + vertex 4.898587e-18 8.000000e-02 8.000000e-02 + vertex 4.051934e-03 7.989732e-02 8.000000e-02 + vertex 4.051934e-03 7.989732e-02 1.000000e-01 + endloop + endfacet + facet normal 2.533271e-02 -9.996791e-01 0.000000e+00 + outer loop + vertex -4.051934e-03 7.989732e-02 8.000000e-02 + vertex 4.898587e-18 8.000000e-02 1.000000e-01 + vertex -4.051934e-03 7.989732e-02 1.000000e-01 + endloop + endfacet + facet normal 2.533271e-02 -9.996791e-01 0.000000e+00 + outer loop + vertex -4.051934e-03 7.989732e-02 8.000000e-02 + vertex 4.898587e-18 8.000000e-02 8.000000e-02 + vertex 4.898587e-18 8.000000e-02 1.000000e-01 + endloop + endfacet + facet normal 7.593311e-02 -9.971129e-01 0.000000e+00 + outer loop + vertex -8.093466e-03 7.958955e-02 8.000000e-02 + vertex -4.051934e-03 7.989732e-02 1.000000e-01 + vertex -8.093466e-03 7.958955e-02 1.000000e-01 + endloop + endfacet + facet normal 7.593311e-02 -9.971129e-01 0.000000e+00 + outer loop + vertex -8.093466e-03 7.958955e-02 8.000000e-02 + vertex -4.051934e-03 7.989732e-02 8.000000e-02 + vertex -4.051934e-03 7.989732e-02 1.000000e-01 + endloop + endfacet + facet normal 1.263386e-01 -9.919872e-01 0.000000e+00 + outer loop + vertex -1.211422e-02 7.907747e-02 8.000000e-02 + vertex -8.093466e-03 7.958955e-02 1.000000e-01 + vertex -1.211422e-02 7.907747e-02 1.000000e-01 + endloop + endfacet + facet normal 1.263386e-01 -9.919872e-01 0.000000e+00 + outer loop + vertex -1.211422e-02 7.907747e-02 8.000000e-02 + vertex -8.093466e-03 7.958955e-02 8.000000e-02 + vertex -8.093466e-03 7.958955e-02 1.000000e-01 + endloop + endfacet + facet normal 1.764198e-01 -9.843150e-01 0.000000e+00 + outer loop + vertex -1.610388e-02 7.836240e-02 8.000000e-02 + vertex -1.211422e-02 7.907747e-02 1.000000e-01 + vertex -1.610388e-02 7.836240e-02 1.000000e-01 + endloop + endfacet + facet normal 1.764198e-01 -9.843150e-01 0.000000e+00 + outer loop + vertex -1.610388e-02 7.836240e-02 8.000000e-02 + vertex -1.211422e-02 7.907747e-02 8.000000e-02 + vertex -1.211422e-02 7.907747e-02 1.000000e-01 + endloop + endfacet + facet normal 2.260481e-01 -9.741161e-01 0.000000e+00 + outer loop + vertex -2.005220e-02 7.744617e-02 8.000000e-02 + vertex -1.610388e-02 7.836240e-02 1.000000e-01 + vertex -2.005220e-02 7.744617e-02 1.000000e-01 + endloop + endfacet + facet normal 2.260481e-01 -9.741161e-01 0.000000e+00 + outer loop + vertex -2.005220e-02 7.744617e-02 8.000000e-02 + vertex -1.610388e-02 7.836240e-02 8.000000e-02 + vertex -1.610388e-02 7.836240e-02 1.000000e-01 + endloop + endfacet + facet normal 2.750961e-01 -9.614167e-01 0.000000e+00 + outer loop + vertex -2.394905e-02 7.633114e-02 8.000000e-02 + vertex -2.005220e-02 7.744617e-02 1.000000e-01 + vertex -2.394905e-02 7.633114e-02 1.000000e-01 + endloop + endfacet + facet normal 2.750961e-01 -9.614167e-01 0.000000e+00 + outer loop + vertex -2.394905e-02 7.633114e-02 8.000000e-02 + vertex -2.005220e-02 7.744617e-02 8.000000e-02 + vertex -2.005220e-02 7.744617e-02 1.000000e-01 + endloop + endfacet + facet normal 3.234380e-01 -9.462494e-01 0.000000e+00 + outer loop + vertex -2.778442e-02 7.502017e-02 8.000000e-02 + vertex -2.394905e-02 7.633114e-02 8.000000e-02 + vertex -2.394905e-02 7.633114e-02 1.000000e-01 + endloop + endfacet + facet normal 3.234380e-01 -9.462494e-01 0.000000e+00 + outer loop + vertex -2.778442e-02 7.502017e-02 8.000000e-02 + vertex -2.394905e-02 7.633114e-02 1.000000e-01 + vertex -2.778442e-02 7.502017e-02 1.000000e-01 + endloop + endfacet + facet normal 3.709496e-01 -9.286530e-01 0.000000e+00 + outer loop + vertex -3.154847e-02 7.351662e-02 8.000000e-02 + vertex -2.778442e-02 7.502017e-02 8.000000e-02 + vertex -2.778442e-02 7.502017e-02 1.000000e-01 + endloop + endfacet + facet normal 3.709496e-01 -9.286530e-01 0.000000e+00 + outer loop + vertex -3.154847e-02 7.351662e-02 8.000000e-02 + vertex -2.778442e-02 7.502017e-02 1.000000e-01 + vertex -3.154847e-02 7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal 4.175090e-01 -9.086728e-01 0.000000e+00 + outer loop + vertex -3.523153e-02 7.182436e-02 8.000000e-02 + vertex -3.154847e-02 7.351662e-02 8.000000e-02 + vertex -3.154847e-02 7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal 4.175090e-01 -9.086728e-01 0.000000e+00 + outer loop + vertex -3.523153e-02 7.182436e-02 8.000000e-02 + vertex -3.154847e-02 7.351662e-02 1.000000e-01 + vertex -3.523153e-02 7.182436e-02 1.000000e-01 + endloop + endfacet + facet normal 4.629966e-01 -8.863600e-01 0.000000e+00 + outer loop + vertex -3.882416e-02 6.994773e-02 8.000000e-02 + vertex -3.523153e-02 7.182436e-02 8.000000e-02 + vertex -3.523153e-02 7.182436e-02 1.000000e-01 + endloop + endfacet + facet normal 4.629966e-01 -8.863600e-01 0.000000e+00 + outer loop + vertex -3.882416e-02 6.994773e-02 8.000000e-02 + vertex -3.523153e-02 7.182436e-02 1.000000e-01 + vertex -3.882416e-02 6.994773e-02 1.000000e-01 + endloop + endfacet + facet normal 5.072958e-01 -8.617720e-01 0.000000e+00 + outer loop + vertex -4.231712e-02 6.789154e-02 8.000000e-02 + vertex -3.882416e-02 6.994773e-02 8.000000e-02 + vertex -3.882416e-02 6.994773e-02 1.000000e-01 + endloop + endfacet + facet normal 5.072958e-01 -8.617720e-01 0.000000e+00 + outer loop + vertex -4.231712e-02 6.789154e-02 8.000000e-02 + vertex -3.882416e-02 6.994773e-02 1.000000e-01 + vertex -4.231712e-02 6.789154e-02 1.000000e-01 + endloop + endfacet + facet normal 5.502927e-01 -8.349718e-01 0.000000e+00 + outer loop + vertex -4.570146e-02 6.566108e-02 8.000000e-02 + vertex -4.231712e-02 6.789154e-02 8.000000e-02 + vertex -4.231712e-02 6.789154e-02 1.000000e-01 + endloop + endfacet + facet normal 5.502927e-01 -8.349718e-01 0.000000e+00 + outer loop + vertex -4.570146e-02 6.566108e-02 8.000000e-02 + vertex -4.231712e-02 6.789154e-02 1.000000e-01 + vertex -4.570146e-02 6.566108e-02 1.000000e-01 + endloop + endfacet + facet normal 5.918770e-01 -8.060283e-01 0.000000e+00 + outer loop + vertex -4.896848e-02 6.326206e-02 8.000000e-02 + vertex -4.570146e-02 6.566108e-02 8.000000e-02 + vertex -4.570146e-02 6.566108e-02 1.000000e-01 + endloop + endfacet + facet normal 5.918770e-01 -8.060283e-01 0.000000e+00 + outer loop + vertex -4.896848e-02 6.326206e-02 8.000000e-02 + vertex -4.570146e-02 6.566108e-02 1.000000e-01 + vertex -4.896848e-02 6.326206e-02 1.000000e-01 + endloop + endfacet + facet normal 6.319420e-01 -7.750157e-01 0.000000e+00 + outer loop + vertex -5.210980e-02 6.070065e-02 8.000000e-02 + vertex -4.896848e-02 6.326206e-02 8.000000e-02 + vertex -4.896848e-02 6.326206e-02 1.000000e-01 + endloop + endfacet + facet normal 6.319420e-01 -7.750157e-01 0.000000e+00 + outer loop + vertex -5.210980e-02 6.070065e-02 8.000000e-02 + vertex -4.896848e-02 6.326206e-02 1.000000e-01 + vertex -5.210980e-02 6.070065e-02 1.000000e-01 + endloop + endfacet + facet normal 6.703848e-01 -7.420136e-01 0.000000e+00 + outer loop + vertex -5.511735e-02 5.798342e-02 8.000000e-02 + vertex -5.210980e-02 6.070065e-02 8.000000e-02 + vertex -5.210980e-02 6.070065e-02 1.000000e-01 + endloop + endfacet + facet normal 6.703848e-01 -7.420136e-01 0.000000e+00 + outer loop + vertex -5.511735e-02 5.798342e-02 8.000000e-02 + vertex -5.210980e-02 6.070065e-02 1.000000e-01 + vertex -5.511735e-02 5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal 7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex -5.798342e-02 5.511735e-02 8.000000e-02 + vertex -5.511735e-02 5.798342e-02 8.000000e-02 + vertex -5.511735e-02 5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal 7.071068e-01 -7.071068e-01 0.000000e+00 + outer loop + vertex -5.798342e-02 5.511735e-02 8.000000e-02 + vertex -5.511735e-02 5.798342e-02 1.000000e-01 + vertex -5.798342e-02 5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal 7.420136e-01 -6.703848e-01 0.000000e+00 + outer loop + vertex -6.070065e-02 5.210980e-02 8.000000e-02 + vertex -5.798342e-02 5.511735e-02 8.000000e-02 + vertex -5.798342e-02 5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal 7.420136e-01 -6.703848e-01 0.000000e+00 + outer loop + vertex -6.070065e-02 5.210980e-02 8.000000e-02 + vertex -5.798342e-02 5.511735e-02 1.000000e-01 + vertex -6.070065e-02 5.210980e-02 1.000000e-01 + endloop + endfacet + facet normal 7.750157e-01 -6.319420e-01 0.000000e+00 + outer loop + vertex -6.326206e-02 4.896848e-02 8.000000e-02 + vertex -6.070065e-02 5.210980e-02 1.000000e-01 + vertex -6.326206e-02 4.896848e-02 1.000000e-01 + endloop + endfacet + facet normal 7.750157e-01 -6.319420e-01 0.000000e+00 + outer loop + vertex -6.326206e-02 4.896848e-02 8.000000e-02 + vertex -6.070065e-02 5.210980e-02 8.000000e-02 + vertex -6.070065e-02 5.210980e-02 1.000000e-01 + endloop + endfacet + facet normal 8.060283e-01 -5.918770e-01 0.000000e+00 + outer loop + vertex -6.566108e-02 4.570146e-02 8.000000e-02 + vertex -6.326206e-02 4.896848e-02 1.000000e-01 + vertex -6.566108e-02 4.570146e-02 1.000000e-01 + endloop + endfacet + facet normal 8.060283e-01 -5.918770e-01 0.000000e+00 + outer loop + vertex -6.566108e-02 4.570146e-02 8.000000e-02 + vertex -6.326206e-02 4.896848e-02 8.000000e-02 + vertex -6.326206e-02 4.896848e-02 1.000000e-01 + endloop + endfacet + facet normal 8.349718e-01 -5.502927e-01 0.000000e+00 + outer loop + vertex -6.789154e-02 4.231712e-02 8.000000e-02 + vertex -6.566108e-02 4.570146e-02 1.000000e-01 + vertex -6.789154e-02 4.231712e-02 1.000000e-01 + endloop + endfacet + facet normal 8.349718e-01 -5.502927e-01 0.000000e+00 + outer loop + vertex -6.789154e-02 4.231712e-02 8.000000e-02 + vertex -6.566108e-02 4.570146e-02 8.000000e-02 + vertex -6.566108e-02 4.570146e-02 1.000000e-01 + endloop + endfacet + facet normal 8.617720e-01 -5.072958e-01 0.000000e+00 + outer loop + vertex -6.994773e-02 3.882416e-02 8.000000e-02 + vertex -6.789154e-02 4.231712e-02 1.000000e-01 + vertex -6.994773e-02 3.882416e-02 1.000000e-01 + endloop + endfacet + facet normal 8.617720e-01 -5.072958e-01 0.000000e+00 + outer loop + vertex -6.994773e-02 3.882416e-02 8.000000e-02 + vertex -6.789154e-02 4.231712e-02 8.000000e-02 + vertex -6.789154e-02 4.231712e-02 1.000000e-01 + endloop + endfacet + facet normal 8.863600e-01 -4.629966e-01 0.000000e+00 + outer loop + vertex -7.182436e-02 3.523153e-02 8.000000e-02 + vertex -6.994773e-02 3.882416e-02 1.000000e-01 + vertex -7.182436e-02 3.523153e-02 1.000000e-01 + endloop + endfacet + facet normal 8.863600e-01 -4.629966e-01 0.000000e+00 + outer loop + vertex -7.182436e-02 3.523153e-02 8.000000e-02 + vertex -6.994773e-02 3.882416e-02 8.000000e-02 + vertex -6.994773e-02 3.882416e-02 1.000000e-01 + endloop + endfacet + facet normal 9.086728e-01 -4.175090e-01 0.000000e+00 + outer loop + vertex -7.351662e-02 3.154847e-02 8.000000e-02 + vertex -7.182436e-02 3.523153e-02 1.000000e-01 + vertex -7.351662e-02 3.154847e-02 1.000000e-01 + endloop + endfacet + facet normal 9.086728e-01 -4.175090e-01 0.000000e+00 + outer loop + vertex -7.351662e-02 3.154847e-02 8.000000e-02 + vertex -7.182436e-02 3.523153e-02 8.000000e-02 + vertex -7.182436e-02 3.523153e-02 1.000000e-01 + endloop + endfacet + facet normal 9.286530e-01 -3.709496e-01 0.000000e+00 + outer loop + vertex -7.502017e-02 2.778442e-02 8.000000e-02 + vertex -7.351662e-02 3.154847e-02 1.000000e-01 + vertex -7.502017e-02 2.778442e-02 1.000000e-01 + endloop + endfacet + facet normal 9.286530e-01 -3.709496e-01 0.000000e+00 + outer loop + vertex -7.502017e-02 2.778442e-02 8.000000e-02 + vertex -7.351662e-02 3.154847e-02 8.000000e-02 + vertex -7.351662e-02 3.154847e-02 1.000000e-01 + endloop + endfacet + facet normal 9.462494e-01 -3.234380e-01 0.000000e+00 + outer loop + vertex -7.633114e-02 2.394905e-02 8.000000e-02 + vertex -7.502017e-02 2.778442e-02 1.000000e-01 + vertex -7.633114e-02 2.394905e-02 1.000000e-01 + endloop + endfacet + facet normal 9.462494e-01 -3.234380e-01 0.000000e+00 + outer loop + vertex -7.633114e-02 2.394905e-02 8.000000e-02 + vertex -7.502017e-02 2.778442e-02 8.000000e-02 + vertex -7.502017e-02 2.778442e-02 1.000000e-01 + endloop + endfacet + facet normal 9.614167e-01 -2.750961e-01 0.000000e+00 + outer loop + vertex -7.744617e-02 2.005220e-02 8.000000e-02 + vertex -7.633114e-02 2.394905e-02 1.000000e-01 + vertex -7.744617e-02 2.005220e-02 1.000000e-01 + endloop + endfacet + facet normal 9.614167e-01 -2.750961e-01 0.000000e+00 + outer loop + vertex -7.744617e-02 2.005220e-02 8.000000e-02 + vertex -7.633114e-02 2.394905e-02 8.000000e-02 + vertex -7.633114e-02 2.394905e-02 1.000000e-01 + endloop + endfacet + facet normal 9.741161e-01 -2.260481e-01 0.000000e+00 + outer loop + vertex -7.836240e-02 1.610388e-02 8.000000e-02 + vertex -7.744617e-02 2.005220e-02 1.000000e-01 + vertex -7.836240e-02 1.610388e-02 1.000000e-01 + endloop + endfacet + facet normal 9.741161e-01 -2.260481e-01 0.000000e+00 + outer loop + vertex -7.836240e-02 1.610388e-02 8.000000e-02 + vertex -7.744617e-02 2.005220e-02 8.000000e-02 + vertex -7.744617e-02 2.005220e-02 1.000000e-01 + endloop + endfacet + facet normal 9.843150e-01 -1.764198e-01 0.000000e+00 + outer loop + vertex -7.907747e-02 1.211422e-02 8.000000e-02 + vertex -7.836240e-02 1.610388e-02 1.000000e-01 + vertex -7.907747e-02 1.211422e-02 1.000000e-01 + endloop + endfacet + facet normal 9.843150e-01 -1.764198e-01 0.000000e+00 + outer loop + vertex -7.907747e-02 1.211422e-02 8.000000e-02 + vertex -7.836240e-02 1.610388e-02 8.000000e-02 + vertex -7.836240e-02 1.610388e-02 1.000000e-01 + endloop + endfacet + facet normal 9.919872e-01 -1.263386e-01 0.000000e+00 + outer loop + vertex -7.958955e-02 8.093466e-03 8.000000e-02 + vertex -7.907747e-02 1.211422e-02 1.000000e-01 + vertex -7.958955e-02 8.093466e-03 1.000000e-01 + endloop + endfacet + facet normal 9.919872e-01 -1.263386e-01 0.000000e+00 + outer loop + vertex -7.958955e-02 8.093466e-03 8.000000e-02 + vertex -7.907747e-02 1.211422e-02 8.000000e-02 + vertex -7.907747e-02 1.211422e-02 1.000000e-01 + endloop + endfacet + facet normal 9.971129e-01 -7.593311e-02 0.000000e+00 + outer loop + vertex -7.989732e-02 4.051934e-03 8.000000e-02 + vertex -7.958955e-02 8.093466e-03 1.000000e-01 + vertex -7.989732e-02 4.051934e-03 1.000000e-01 + endloop + endfacet + facet normal 9.971129e-01 -7.593311e-02 0.000000e+00 + outer loop + vertex -7.989732e-02 4.051934e-03 8.000000e-02 + vertex -7.958955e-02 8.093466e-03 8.000000e-02 + vertex -7.958955e-02 8.093466e-03 1.000000e-01 + endloop + endfacet + facet normal 9.996791e-01 -2.533271e-02 0.000000e+00 + outer loop + vertex -8.000000e-02 9.797174e-18 8.000000e-02 + vertex -7.989732e-02 4.051934e-03 1.000000e-01 + vertex -8.000000e-02 9.797174e-18 1.000000e-01 + endloop + endfacet + facet normal 9.996791e-01 -2.533271e-02 0.000000e+00 + outer loop + vertex -8.000000e-02 9.797174e-18 8.000000e-02 + vertex -7.989732e-02 4.051934e-03 8.000000e-02 + vertex -7.989732e-02 4.051934e-03 1.000000e-01 + endloop + endfacet + facet normal 9.996791e-01 2.533271e-02 -0.000000e+00 + outer loop + vertex -7.989732e-02 -4.051934e-03 8.000000e-02 + vertex -8.000000e-02 9.797174e-18 8.000000e-02 + vertex -8.000000e-02 9.797174e-18 1.000000e-01 + endloop + endfacet + facet normal 9.996791e-01 2.533271e-02 0.000000e+00 + outer loop + vertex -7.989732e-02 -4.051934e-03 8.000000e-02 + vertex -8.000000e-02 9.797174e-18 1.000000e-01 + vertex -7.989732e-02 -4.051934e-03 1.000000e-01 + endloop + endfacet + facet normal 9.971129e-01 7.593311e-02 -0.000000e+00 + outer loop + vertex -7.958955e-02 -8.093466e-03 8.000000e-02 + vertex -7.989732e-02 -4.051934e-03 8.000000e-02 + vertex -7.989732e-02 -4.051934e-03 1.000000e-01 + endloop + endfacet + facet normal 9.971129e-01 7.593311e-02 0.000000e+00 + outer loop + vertex -7.958955e-02 -8.093466e-03 8.000000e-02 + vertex -7.989732e-02 -4.051934e-03 1.000000e-01 + vertex -7.958955e-02 -8.093466e-03 1.000000e-01 + endloop + endfacet + facet normal 9.919872e-01 1.263386e-01 -0.000000e+00 + outer loop + vertex -7.907747e-02 -1.211422e-02 8.000000e-02 + vertex -7.958955e-02 -8.093466e-03 8.000000e-02 + vertex -7.958955e-02 -8.093466e-03 1.000000e-01 + endloop + endfacet + facet normal 9.919872e-01 1.263386e-01 0.000000e+00 + outer loop + vertex -7.907747e-02 -1.211422e-02 8.000000e-02 + vertex -7.958955e-02 -8.093466e-03 1.000000e-01 + vertex -7.907747e-02 -1.211422e-02 1.000000e-01 + endloop + endfacet + facet normal 9.843150e-01 1.764198e-01 -0.000000e+00 + outer loop + vertex -7.836240e-02 -1.610388e-02 8.000000e-02 + vertex -7.907747e-02 -1.211422e-02 8.000000e-02 + vertex -7.907747e-02 -1.211422e-02 1.000000e-01 + endloop + endfacet + facet normal 9.843150e-01 1.764198e-01 0.000000e+00 + outer loop + vertex -7.836240e-02 -1.610388e-02 8.000000e-02 + vertex -7.907747e-02 -1.211422e-02 1.000000e-01 + vertex -7.836240e-02 -1.610388e-02 1.000000e-01 + endloop + endfacet + facet normal 9.741161e-01 2.260481e-01 -0.000000e+00 + outer loop + vertex -7.744617e-02 -2.005220e-02 8.000000e-02 + vertex -7.836240e-02 -1.610388e-02 8.000000e-02 + vertex -7.836240e-02 -1.610388e-02 1.000000e-01 + endloop + endfacet + facet normal 9.741161e-01 2.260481e-01 0.000000e+00 + outer loop + vertex -7.744617e-02 -2.005220e-02 8.000000e-02 + vertex -7.836240e-02 -1.610388e-02 1.000000e-01 + vertex -7.744617e-02 -2.005220e-02 1.000000e-01 + endloop + endfacet + facet normal 9.614167e-01 2.750961e-01 -0.000000e+00 + outer loop + vertex -7.633114e-02 -2.394905e-02 8.000000e-02 + vertex -7.744617e-02 -2.005220e-02 8.000000e-02 + vertex -7.744617e-02 -2.005220e-02 1.000000e-01 + endloop + endfacet + facet normal 9.614167e-01 2.750961e-01 0.000000e+00 + outer loop + vertex -7.633114e-02 -2.394905e-02 8.000000e-02 + vertex -7.744617e-02 -2.005220e-02 1.000000e-01 + vertex -7.633114e-02 -2.394905e-02 1.000000e-01 + endloop + endfacet + facet normal 9.462494e-01 3.234380e-01 -0.000000e+00 + outer loop + vertex -7.502017e-02 -2.778442e-02 8.000000e-02 + vertex -7.633114e-02 -2.394905e-02 8.000000e-02 + vertex -7.633114e-02 -2.394905e-02 1.000000e-01 + endloop + endfacet + facet normal 9.462494e-01 3.234380e-01 0.000000e+00 + outer loop + vertex -7.502017e-02 -2.778442e-02 8.000000e-02 + vertex -7.633114e-02 -2.394905e-02 1.000000e-01 + vertex -7.502017e-02 -2.778442e-02 1.000000e-01 + endloop + endfacet + facet normal 9.286530e-01 3.709496e-01 -0.000000e+00 + outer loop + vertex -7.351662e-02 -3.154847e-02 8.000000e-02 + vertex -7.502017e-02 -2.778442e-02 8.000000e-02 + vertex -7.502017e-02 -2.778442e-02 1.000000e-01 + endloop + endfacet + facet normal 9.286530e-01 3.709496e-01 0.000000e+00 + outer loop + vertex -7.351662e-02 -3.154847e-02 8.000000e-02 + vertex -7.502017e-02 -2.778442e-02 1.000000e-01 + vertex -7.351662e-02 -3.154847e-02 1.000000e-01 + endloop + endfacet + facet normal 9.086728e-01 4.175090e-01 -0.000000e+00 + outer loop + vertex -7.182436e-02 -3.523153e-02 8.000000e-02 + vertex -7.351662e-02 -3.154847e-02 8.000000e-02 + vertex -7.351662e-02 -3.154847e-02 1.000000e-01 + endloop + endfacet + facet normal 9.086728e-01 4.175090e-01 0.000000e+00 + outer loop + vertex -7.182436e-02 -3.523153e-02 8.000000e-02 + vertex -7.351662e-02 -3.154847e-02 1.000000e-01 + vertex -7.182436e-02 -3.523153e-02 1.000000e-01 + endloop + endfacet + facet normal 8.863600e-01 4.629966e-01 -0.000000e+00 + outer loop + vertex -6.994773e-02 -3.882416e-02 8.000000e-02 + vertex -7.182436e-02 -3.523153e-02 8.000000e-02 + vertex -7.182436e-02 -3.523153e-02 1.000000e-01 + endloop + endfacet + facet normal 8.863600e-01 4.629966e-01 0.000000e+00 + outer loop + vertex -6.994773e-02 -3.882416e-02 8.000000e-02 + vertex -7.182436e-02 -3.523153e-02 1.000000e-01 + vertex -6.994773e-02 -3.882416e-02 1.000000e-01 + endloop + endfacet + facet normal 8.617720e-01 5.072958e-01 -0.000000e+00 + outer loop + vertex -6.789154e-02 -4.231712e-02 8.000000e-02 + vertex -6.994773e-02 -3.882416e-02 8.000000e-02 + vertex -6.994773e-02 -3.882416e-02 1.000000e-01 + endloop + endfacet + facet normal 8.617720e-01 5.072958e-01 0.000000e+00 + outer loop + vertex -6.789154e-02 -4.231712e-02 8.000000e-02 + vertex -6.994773e-02 -3.882416e-02 1.000000e-01 + vertex -6.789154e-02 -4.231712e-02 1.000000e-01 + endloop + endfacet + facet normal 8.349718e-01 5.502927e-01 -0.000000e+00 + outer loop + vertex -6.566108e-02 -4.570146e-02 8.000000e-02 + vertex -6.789154e-02 -4.231712e-02 8.000000e-02 + vertex -6.789154e-02 -4.231712e-02 1.000000e-01 + endloop + endfacet + facet normal 8.349718e-01 5.502927e-01 0.000000e+00 + outer loop + vertex -6.566108e-02 -4.570146e-02 8.000000e-02 + vertex -6.789154e-02 -4.231712e-02 1.000000e-01 + vertex -6.566108e-02 -4.570146e-02 1.000000e-01 + endloop + endfacet + facet normal 8.060283e-01 5.918770e-01 -0.000000e+00 + outer loop + vertex -6.326206e-02 -4.896848e-02 8.000000e-02 + vertex -6.566108e-02 -4.570146e-02 8.000000e-02 + vertex -6.566108e-02 -4.570146e-02 1.000000e-01 + endloop + endfacet + facet normal 8.060283e-01 5.918770e-01 0.000000e+00 + outer loop + vertex -6.326206e-02 -4.896848e-02 8.000000e-02 + vertex -6.566108e-02 -4.570146e-02 1.000000e-01 + vertex -6.326206e-02 -4.896848e-02 1.000000e-01 + endloop + endfacet + facet normal 7.750157e-01 6.319420e-01 -0.000000e+00 + outer loop + vertex -6.070065e-02 -5.210980e-02 8.000000e-02 + vertex -6.326206e-02 -4.896848e-02 8.000000e-02 + vertex -6.326206e-02 -4.896848e-02 1.000000e-01 + endloop + endfacet + facet normal 7.750157e-01 6.319420e-01 0.000000e+00 + outer loop + vertex -6.070065e-02 -5.210980e-02 8.000000e-02 + vertex -6.326206e-02 -4.896848e-02 1.000000e-01 + vertex -6.070065e-02 -5.210980e-02 1.000000e-01 + endloop + endfacet + facet normal 7.420136e-01 6.703848e-01 -0.000000e+00 + outer loop + vertex -5.798342e-02 -5.511735e-02 8.000000e-02 + vertex -6.070065e-02 -5.210980e-02 8.000000e-02 + vertex -6.070065e-02 -5.210980e-02 1.000000e-01 + endloop + endfacet + facet normal 7.420136e-01 6.703848e-01 0.000000e+00 + outer loop + vertex -5.798342e-02 -5.511735e-02 8.000000e-02 + vertex -6.070065e-02 -5.210980e-02 1.000000e-01 + vertex -5.798342e-02 -5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal 7.071068e-01 7.071068e-01 -0.000000e+00 + outer loop + vertex -5.511735e-02 -5.798342e-02 8.000000e-02 + vertex -5.798342e-02 -5.511735e-02 8.000000e-02 + vertex -5.798342e-02 -5.511735e-02 1.000000e-01 + endloop + endfacet + facet normal 7.071068e-01 7.071068e-01 0.000000e+00 + outer loop + vertex -5.511735e-02 -5.798342e-02 8.000000e-02 + vertex -5.798342e-02 -5.511735e-02 1.000000e-01 + vertex -5.511735e-02 -5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal 6.703848e-01 7.420136e-01 -0.000000e+00 + outer loop + vertex -5.210980e-02 -6.070065e-02 8.000000e-02 + vertex -5.511735e-02 -5.798342e-02 8.000000e-02 + vertex -5.511735e-02 -5.798342e-02 1.000000e-01 + endloop + endfacet + facet normal 6.703848e-01 7.420136e-01 0.000000e+00 + outer loop + vertex -5.210980e-02 -6.070065e-02 8.000000e-02 + vertex -5.511735e-02 -5.798342e-02 1.000000e-01 + vertex -5.210980e-02 -6.070065e-02 1.000000e-01 + endloop + endfacet + facet normal 6.319420e-01 7.750157e-01 -0.000000e+00 + outer loop + vertex -4.896848e-02 -6.326206e-02 8.000000e-02 + vertex -5.210980e-02 -6.070065e-02 8.000000e-02 + vertex -5.210980e-02 -6.070065e-02 1.000000e-01 + endloop + endfacet + facet normal 6.319420e-01 7.750157e-01 0.000000e+00 + outer loop + vertex -4.896848e-02 -6.326206e-02 8.000000e-02 + vertex -5.210980e-02 -6.070065e-02 1.000000e-01 + vertex -4.896848e-02 -6.326206e-02 1.000000e-01 + endloop + endfacet + facet normal 5.918770e-01 8.060283e-01 -0.000000e+00 + outer loop + vertex -4.570146e-02 -6.566108e-02 8.000000e-02 + vertex -4.896848e-02 -6.326206e-02 8.000000e-02 + vertex -4.896848e-02 -6.326206e-02 1.000000e-01 + endloop + endfacet + facet normal 5.918770e-01 8.060283e-01 0.000000e+00 + outer loop + vertex -4.570146e-02 -6.566108e-02 8.000000e-02 + vertex -4.896848e-02 -6.326206e-02 1.000000e-01 + vertex -4.570146e-02 -6.566108e-02 1.000000e-01 + endloop + endfacet + facet normal 5.502927e-01 8.349718e-01 -0.000000e+00 + outer loop + vertex -4.231712e-02 -6.789154e-02 8.000000e-02 + vertex -4.570146e-02 -6.566108e-02 8.000000e-02 + vertex -4.570146e-02 -6.566108e-02 1.000000e-01 + endloop + endfacet + facet normal 5.502927e-01 8.349718e-01 0.000000e+00 + outer loop + vertex -4.231712e-02 -6.789154e-02 8.000000e-02 + vertex -4.570146e-02 -6.566108e-02 1.000000e-01 + vertex -4.231712e-02 -6.789154e-02 1.000000e-01 + endloop + endfacet + facet normal 5.072958e-01 8.617720e-01 0.000000e+00 + outer loop + vertex -3.882416e-02 -6.994773e-02 8.000000e-02 + vertex -4.231712e-02 -6.789154e-02 1.000000e-01 + vertex -3.882416e-02 -6.994773e-02 1.000000e-01 + endloop + endfacet + facet normal 5.072958e-01 8.617720e-01 -0.000000e+00 + outer loop + vertex -3.882416e-02 -6.994773e-02 8.000000e-02 + vertex -4.231712e-02 -6.789154e-02 8.000000e-02 + vertex -4.231712e-02 -6.789154e-02 1.000000e-01 + endloop + endfacet + facet normal 4.629966e-01 8.863600e-01 0.000000e+00 + outer loop + vertex -3.523153e-02 -7.182436e-02 8.000000e-02 + vertex -3.882416e-02 -6.994773e-02 1.000000e-01 + vertex -3.523153e-02 -7.182436e-02 1.000000e-01 + endloop + endfacet + facet normal 4.629966e-01 8.863600e-01 -0.000000e+00 + outer loop + vertex -3.523153e-02 -7.182436e-02 8.000000e-02 + vertex -3.882416e-02 -6.994773e-02 8.000000e-02 + vertex -3.882416e-02 -6.994773e-02 1.000000e-01 + endloop + endfacet + facet normal 4.175090e-01 9.086728e-01 0.000000e+00 + outer loop + vertex -3.154847e-02 -7.351662e-02 8.000000e-02 + vertex -3.523153e-02 -7.182436e-02 1.000000e-01 + vertex -3.154847e-02 -7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal 4.175090e-01 9.086728e-01 -0.000000e+00 + outer loop + vertex -3.154847e-02 -7.351662e-02 8.000000e-02 + vertex -3.523153e-02 -7.182436e-02 8.000000e-02 + vertex -3.523153e-02 -7.182436e-02 1.000000e-01 + endloop + endfacet + facet normal 3.709496e-01 9.286530e-01 0.000000e+00 + outer loop + vertex -2.778442e-02 -7.502017e-02 8.000000e-02 + vertex -3.154847e-02 -7.351662e-02 1.000000e-01 + vertex -2.778442e-02 -7.502017e-02 1.000000e-01 + endloop + endfacet + facet normal 3.709496e-01 9.286530e-01 -0.000000e+00 + outer loop + vertex -2.778442e-02 -7.502017e-02 8.000000e-02 + vertex -3.154847e-02 -7.351662e-02 8.000000e-02 + vertex -3.154847e-02 -7.351662e-02 1.000000e-01 + endloop + endfacet + facet normal 3.234380e-01 9.462494e-01 0.000000e+00 + outer loop + vertex -2.394905e-02 -7.633114e-02 8.000000e-02 + vertex -2.778442e-02 -7.502017e-02 1.000000e-01 + vertex -2.394905e-02 -7.633114e-02 1.000000e-01 + endloop + endfacet + facet normal 3.234380e-01 9.462494e-01 -0.000000e+00 + outer loop + vertex -2.394905e-02 -7.633114e-02 8.000000e-02 + vertex -2.778442e-02 -7.502017e-02 8.000000e-02 + vertex -2.778442e-02 -7.502017e-02 1.000000e-01 + endloop + endfacet + facet normal 2.750961e-01 9.614167e-01 -0.000000e+00 + outer loop + vertex -2.005220e-02 -7.744617e-02 8.000000e-02 + vertex -2.394905e-02 -7.633114e-02 8.000000e-02 + vertex -2.394905e-02 -7.633114e-02 1.000000e-01 + endloop + endfacet + facet normal 2.750961e-01 9.614167e-01 0.000000e+00 + outer loop + vertex -2.005220e-02 -7.744617e-02 8.000000e-02 + vertex -2.394905e-02 -7.633114e-02 1.000000e-01 + vertex -2.005220e-02 -7.744617e-02 1.000000e-01 + endloop + endfacet + facet normal 2.260481e-01 9.741161e-01 -0.000000e+00 + outer loop + vertex -1.610388e-02 -7.836240e-02 8.000000e-02 + vertex -2.005220e-02 -7.744617e-02 8.000000e-02 + vertex -2.005220e-02 -7.744617e-02 1.000000e-01 + endloop + endfacet + facet normal 2.260481e-01 9.741161e-01 0.000000e+00 + outer loop + vertex -1.610388e-02 -7.836240e-02 8.000000e-02 + vertex -2.005220e-02 -7.744617e-02 1.000000e-01 + vertex -1.610388e-02 -7.836240e-02 1.000000e-01 + endloop + endfacet + facet normal 1.764198e-01 9.843150e-01 -0.000000e+00 + outer loop + vertex -1.211422e-02 -7.907747e-02 8.000000e-02 + vertex -1.610388e-02 -7.836240e-02 8.000000e-02 + vertex -1.610388e-02 -7.836240e-02 1.000000e-01 + endloop + endfacet + facet normal 1.764198e-01 9.843150e-01 0.000000e+00 + outer loop + vertex -1.211422e-02 -7.907747e-02 8.000000e-02 + vertex -1.610388e-02 -7.836240e-02 1.000000e-01 + vertex -1.211422e-02 -7.907747e-02 1.000000e-01 + endloop + endfacet +endsolid diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/parCFDDEMrun.sh b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/parCFDDEMrun.sh new file mode 100755 index 00000000..b6487e2f --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/parCFDDEMrun.sh @@ -0,0 +1,29 @@ +#!/bin/bash + +#===================================================================# +# allrun script for testcase as part of test routine +# run CFD part +#===================================================================# + +#- source CFDEM env vars +. ~/.bashrc + +#- include functions +source $CFDEM_PROJECT_DIR/etc/functions.sh + +#--------------------------------------------------------------------------------# +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" +logpath=$casePath +headerText="run_parallel_cfdemSolverMultiphase_test" +logfileName="log_$headerText" +solverName="cfdemSolverMultiphase" +nrProcs="4" +machineFileName="none" # yourMachinefileName | none +debugMode="off" # on | off| strict +testHarnessPath="$CFDEM_TEST_HARNESS_PATH" +#--------------------------------------------------------------------------------# + +#- call function to run a parallel CFD-DEM case +parCFDDEMrun $logpath $logfileName $casePath $headerText $solverName $nrProcs $machineFileName $debugMode + diff --git a/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/postrun.sh b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/postrun.sh new file mode 100755 index 00000000..eff06cbf --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/small_scale_hearth_drainage/postrun.sh @@ -0,0 +1,15 @@ +#!/bin/bash + +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" + +#- get VTK data from liggghts dump file +cd $casePath/DEM/post +python $CFDEM_LPP_DIR/lpp.py dump*.liggghts_run + +#- get VTK data from CFD sim +cd $casePath/CFD +reconstructPar -noLagrangian +foamToVTK + +#rm -r $casePath/CFD/processor* diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/Allclean.sh b/tutorials/cfdemSolverMultiphase/tankDrainage/Allclean.sh new file mode 100755 index 00000000..ca0e0a6e --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/Allclean.sh @@ -0,0 +1,23 @@ +#!/bin/bash + +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" + +#- clean up case +echo "deleting data at: $casePath :\n" +source $WM_PROJECT_DIR/bin/tools/CleanFunctions +cd $casePath/CFD +cleanCase +rm -r $casePath/CFD/clockData +rm $casePath/DEM/post/*.* +touch $casePath/DEM/post/.gitignore +rm -r $casePath/CFD/0 +rm $casePath/log* +rm $casePath/*.png + +echo "Remove restart file?" +echo "Enter: yes, Ctrl + C: no" +read +rm $casePath/DEM/post/restart/*.* +rm $casePath/DEM/post/restart/liggghts.restartCFDEM* + diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/Allrun.sh b/tutorials/cfdemSolverMultiphase/tankDrainage/Allrun.sh new file mode 100755 index 00000000..c2eae317 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/Allrun.sh @@ -0,0 +1,39 @@ +#!/bin/bash + +#===================================================================# +# allrun script for testcase as part of test routine +# run tankDrainage +#===================================================================# + +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" +postProcessing=true + +# check if mesh was built +if [ -f "$casePath/CFD/constant/polyMesh/points" ]; then + echo "mesh was built before - using old mesh" +else + echo "mesh needs to be built" + cd $casePath/CFD + blockMesh +fi + +cd $casePath/CFD +cp -r 0.org 0 +setFields + +if [ -f "$casePath/DEM/post/restart/liggghts.restart" ]; then + echo "LIGGGHTS init was run before - using existing restart file" +else + #- run DEM in new terminal + $casePath/parDEMrun.sh +fi + +#- run parallel CFD-DEM in new terminal +bash $casePath/parCFDDEMrun.sh + +if [ "$postProcessing" = true ]; then + cd $casePath + bash $casePath/postrun.sh + octave $casePath/volFlow.m +fi diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/Ksl b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/Ksl new file mode 100644 index 00000000..1c54de44 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/Ksl @@ -0,0 +1,40 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object Ksl; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 -3 -1 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type zeroGradient; + } + outlet + { + type zeroGradient; + } + atmosphere + { + type zeroGradient; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/U b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/U new file mode 100644 index 00000000..4f3072a8 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/U @@ -0,0 +1,43 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.x | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volVectorField; + location "0"; + object U; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -1 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + atmosphere + { + type pressureInletOutletVelocity; + value uniform (0 0 0); + } + outlet + { + type inletOutlet; + inletValue uniform (0 0 0); + value uniform (0 0 0); + } + walls + { + type fixedValue; + value uniform (0 0 0); + } +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/Us b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/Us new file mode 100644 index 00000000..5ea6f6ae --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/Us @@ -0,0 +1,39 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volVectorField; + location "0"; + object Us; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -1 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + walls + { + type zeroGradient; + } + outlet + { + type zeroGradient; + } + atmosphere + { + type zeroGradient; + } +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/alpha.air b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/alpha.air new file mode 100644 index 00000000..2456dde4 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/alpha.air @@ -0,0 +1,48 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object alpha.air; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type alphaContactAngle; + thetaProperties + ( + ( water air ) 90 0 0 0 + ( water oil ) 90 0 0 0 + ( air oil ) 90 0 0 0 + + ); + value uniform 0; + } + atmosphere + { + type fixedValue; + value uniform 1; + } + outlet + { + type zeroGradient; + } +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/alpha.oil b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/alpha.oil new file mode 100644 index 00000000..ea56b807 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/alpha.oil @@ -0,0 +1,39 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object alpha.oil; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type zeroGradient; + } + outlet + { + type zeroGradient; + } + atmosphere + { + type fixedValue; + value uniform 0; + } +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/alpha.water b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/alpha.water new file mode 100644 index 00000000..7a06c95e --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/alpha.water @@ -0,0 +1,39 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object alpha.water; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type zeroGradient; + } + outlet + { + type zeroGradient; + } + atmosphere + { + type fixedValue; + value uniform 0; + } +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/alphas b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/alphas new file mode 100644 index 00000000..58dae6a2 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/alphas @@ -0,0 +1,40 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.x | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object alphas; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + outlet + { + type zeroGradient; + } + walls + { + type zeroGradient; + } + atmosphere + { + type zeroGradient; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/epsilon b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/epsilon new file mode 100644 index 00000000..ab29b736 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/epsilon @@ -0,0 +1,52 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object epsilon; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 2 -3 0 0 0 0]; + +internalField uniform 0.003; + +boundaryField +{ + walls + { + type epsilonWallFunction; + Cmu 0.09; + kappa 0.41; + E 9.8; + value uniform 0.003; + } + outlet + { + type inletOutlet; + inletValue uniform 0.003; + value uniform 0.003; + } +/* frontAndBack + { + type empty; + } +*/ + atmosphere + { + type fixedValue; + value uniform 0.003; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/k b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/k new file mode 100644 index 00000000..3347d063 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/k @@ -0,0 +1,48 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object k; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 2 -2 0 0 0 0]; + +internalField uniform 0.001; + +boundaryField +{ + walls + { + type kqRWallFunction; + value uniform 0.001; + } + outlet + { + type inletOutlet; + inletValue uniform 0.001; + value uniform 0.001; + } +/* frontAndBack + { + type empty; + } +*/ + atmosphere + { + type fixedValue; + value uniform 0.001; + } +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/nut b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/nut new file mode 100644 index 00000000..be85f9b0 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/nut @@ -0,0 +1,51 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object nut; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 2 -1 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + walls + { + type nutWallFunction; + Cmu 0.09; + kappa 0.41; + E 9.8; + value uniform 0; + } + + outlet + { + type calculated; + value uniform 0; + } +/* frontAndBack + { + type empty; + } +*/ + atmosphere + { + type calculated; + value uniform 0; + } +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/p_rgh b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/p_rgh new file mode 100644 index 00000000..6ec9869d --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/p_rgh @@ -0,0 +1,42 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + object p_rgh; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 -1 -2 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + + walls + { + type fixedFluxPressure; + value uniform 0; + } + + outlet + { + type fixedValue; + value uniform 0; + } + atmosphere + { + type fixedValue; + value uniform 0; + } +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/sSmoothField b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/sSmoothField new file mode 100644 index 00000000..1fe79ce1 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/sSmoothField @@ -0,0 +1,40 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + object sSmoothField; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + + walls + { + type zeroGradient; + } + + outlet + { + type zeroGradient; + } + atmosphere + { + type zeroGradient; + } + +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/vSmoothField b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/vSmoothField new file mode 100644 index 00000000..13f4cf1d --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/vSmoothField @@ -0,0 +1,40 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volVectorField; + object vSmoothField; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 0 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + + walls + { + type zeroGradient; + } + + outlet + { + type zeroGradient; + } + atmosphere + { + type zeroGradient; + } + +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/voidfraction b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/voidfraction new file mode 100644 index 00000000..c0910e6e --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/0.org/voidfraction @@ -0,0 +1,40 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object voidfraction; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 1; + +boundaryField +{ + walls + { + type zeroGradient; + } + outlet + { + type zeroGradient; + } + atmosphere + { + type fixedValue; + value uniform 1; + } +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/RASProperties b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/RASProperties new file mode 100644 index 00000000..daec1829 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/RASProperties @@ -0,0 +1,25 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object RASProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +RASModel laminar; + +turbulence off; + +printCoeffs on; + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/couplingProperties b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/couplingProperties new file mode 100644 index 00000000..66cd341c --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/couplingProperties @@ -0,0 +1,311 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.4 | +| \\ / A nd | Web: http://www.openfoam.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ + + +FoamFile +{ + version 2.0; + format ascii; + + root ""; + case ""; + instance ""; + local ""; + + class dictionary; + object couplingProperties; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +//===========================================================================// +// sub-models & settings + +syncMode false; +//verbose; + +modelType "A"; // A or B + +couplingInterval 50; + +voidFractionModel divided; //bigParticle; //trilinear; //centre; //divided; + +locateModel engine;//turboEngineM2M;// + +meshMotionModel noMeshMotion; + +regionModel allRegion; + +IOModel basicIO; + +probeModel off; //particleProbe; //off; + +dataExchangeModel twoWayMPI;//twoWayFiles;//twoWayM2M;//oneWayVTK;// + +averagingModel dense;//dilute;// + +clockModel standardClock;//off; + +smoothingModel constDiffSmoothing; //off;// localPSizeDiffSmoothing;// + +forceModels +( + //GidaspowDrag + //BeetstraDrag + //DiFeliceDrag + gradPForce + viscForce + KochHillDrag + //interface + //DEMbasedDrag + //RongDrag + //Archimedes + //volWeightedAverage + //totalMomentumExchange + //particleCellVolume + //fieldTimeAverage + surfaceTensionForce +); + +momCoupleModels +( + implicitCouple +); + +turbulenceModelType "turbulenceProperties"; + +//===========================================================================// +// sub-model properties + +localPSizeDiffSmoothingProps +{ + lowerLimit 0.1; + upperLimit 1e10; + dSmoothingLength 1.5e-3; + Csmoothing 1.0; +} + +constDiffSmoothingProps +{ + lowerLimit 0.1; + upperLimit 1e10; + smoothingLength 20e-3; +} + +implicitCoupleProps +{ + velFieldName "U"; + granVelFieldName "Us"; + voidfractionFieldName "voidfraction"; +} + +ArchimedesProps +{ + gravityFieldName "g"; + treatForceDEM true; +} +gradPForceProps +{ + pFieldName "p"; + voidfractionFieldName "voidfraction"; + velocityFieldName "U"; + //interpolation true; +} + +viscForceProps +{ + velocityFieldName "U"; + //interpolation false; + verbose true; +} +volWeightedAverageProps +{ + scalarFieldNames + ( + voidfraction + ); + vectorFieldNames + ( + ); + upperThreshold 0.999; + lowerThreshold 0; + verbose true; +} +totalMomentumExchangeProps +{ + implicitMomExFieldName "Ksl"; + explicitMomExFieldName "none"; + fluidVelFieldName "U"; + granVelFieldName "Us"; +} +GidaspowDragProps +{ + verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + interpolation true; + phi 1; +} +DEMbasedDragProps +{ + velFieldName "U"; + voidfractionFieldName "voidfraction"; +} + +DiFeliceDragProps +{ + //verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + granVelFieldName "Us"; + interpolation true; +} + +KochHillDragProps +{ + //verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + //interpolation true; + //forceSubModels + //( + // ImExCorr + //); + implForceDEM true; + //implForceDEMaccumulated true; + //explicitCorr true; +} + +BeetstraDragProps +{ + velFieldName "U"; + gravityFieldName "g"; + rhoParticle 2000.; + voidfractionFieldName "voidfraction"; + interpolation ; + useFilteredDragModel ; + useParcelSizeDependentFilteredDrag ; + k 0.05; + aLimit 0.0; +// verbose true; +} + +RongDragProps +{ + verbose true; + velFieldName "U"; + voidfractionFieldName "voidfraction"; + interpolation true; + implForceDEM true; + implForceDEMaccumulated true; + granVelFieldName "Us"; +} + +virtualMassForceProps +{ + velFieldName "U"; +} + +particleCellVolumeProps +{ + upperThreshold 0.999; + lowerThreshold 0.; + verbose true; +} + +fieldStoreProps +{ + scalarFieldNames + ( + ); + + vectorFieldNames + ( + "U" + ); +} + +oneWayVTKProps +{ + couplingFilename "vtk_out%4.4d.vtk"; + maxNumberOfParticles 30000; +} + +twoWayFilesProps +{ + maxNumberOfParticles 10100; +} + +centreProps +{ + alphaMin 0.1; +} + +engineProps +{ + treeSearch true; +} + +turboEngineM2MProps +{ + turboEngineProps + { + treeSearch true; + } +} + +dividedProps +{ + alphaMin 0.01; + // porosity 0.5; + //interpolation true; +} + +twoWayMPIProps +{ + liggghtsPath "../DEM/in.liggghts_run"; +} +twoWayM2MProps +{ + maxNumberOfParticles 10100; + liggghtsPath "../DEM/in.liggghts_run"; +} +surfaceTensionForceProps +{ +} + +trilinearProps +{ + alphaMin 0.01; +} + +bigParticleProps +{ + alphaMin 0.01; + maxCellsPerParticle 1000; + porosity 100.0; +} + +gradPForceSmoothProps +{ + pFieldName "p"; + voidfractionFieldName "voidfraction"; + velocityFieldName "U"; + smoothingModel "constDiffSmoothing"; + //interpolation true; + constDiffSmoothingProps + { + lowerLimit 0.1; + upperLimit 1e10; + smoothingLength 20e-3; + } + +} + +} +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/g b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/g new file mode 100644 index 00000000..317bdd50 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/g @@ -0,0 +1,22 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class uniformDimensionedVectorField; + location "constant"; + object g; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -2 0 0 0 0]; +value ( 0 0 -9.81 ); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/liggghtsCommands b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/liggghtsCommands new file mode 100644 index 00000000..d9e1ce81 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/liggghtsCommands @@ -0,0 +1,43 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.4 | +| \\ / A nd | Web: http://www.openfoam.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ + + +FoamFile +{ + version 2.0; + format ascii; + + root ""; + case ""; + instance ""; + local ""; + + class dictionary; + object liggghtsCommands; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +liggghtsCommandModels +( + runLiggghts + writeLiggghts +); +// ************************************************************************* // + +/*runLiggghtsProps +{ + preNo false; +}*/ + +writeLiggghtsProps +{ + writeLast off; + writeName "post/restart/liggghts.restartCFDEM"; + overwrite on; +} diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/transportProperties b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/transportProperties new file mode 100644 index 00000000..a86a2bd9 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/transportProperties @@ -0,0 +1,51 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object transportProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +phases +( + water + { + transportModel Newtonian; + nu nu [ 0 2 -1 0 0 0 0 ] 1e-06; + rho rho [ 1 -3 0 0 0 0 0 ] 1000; + } + + oil + { + transportModel Newtonian; + nu nu [ 0 2 -1 0 0 0 0 ] 1e-06; + rho rho [ 1 -3 0 0 0 0 0 ] 700; + } + + air + { + transportModel Newtonian; + nu nu [ 0 2 -1 0 0 0 0 ] 1e-05; + rho rho [ 1 -3 0 0 0 0 0 ] 1; + } +); + +sigmas +( + (water oil) 0.07 + (air water) 0.07 + (air oil) 0.07 + +); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/turbulenceProperties b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/turbulenceProperties new file mode 100644 index 00000000..9cfc50a3 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/constant/turbulenceProperties @@ -0,0 +1,21 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object turbulenceProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +simulationType laminar; + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/blockMeshDict b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/blockMeshDict new file mode 100644 index 00000000..2973114d --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/blockMeshDict @@ -0,0 +1,170 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + object blockMeshDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +// General m4 macros + + + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +// User-defined parameters + +convertToMeters 0.01; + + + + + + + + + + + + + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +// Derived parameters + + + + + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +// Parametric description + +vertices +( + (0 0 0) //0 + (0 2.82190275490383 0) //1 + (0 5.17809724509617 0) //2 + (0 8.0 0) //3 + (0 0 3) //4 + (0 2.82190275490383 3) //5 + (0 5.17809724509617 3) //6 + (0 8.0 3) //7 + (0 0 20.0) //8 + (0 2.82190275490383 20.0) //9 + (0 5.17809724509617 20.0) //10 + (0 8.0 20.0) //11 + (0 0 25.0) //12 + (0 2.82190275490383 25.0) //13 + (0 5.17809724509617 25.0) //14 + (0 8.0 25.0) //15 + (30.0 0 0) //16 + (30.0 2.82190275490383 0) //17 + (30.0 5.17809724509617 0) //18 + (30.0 8.0 0) //19 + (30.0 0 3) //20 + (30.0 2.82190275490383 3) //21 + (30.0 5.17809724509617 3) //22 + (30.0 8.0 3) //23 + (30.0 0 20.0) //24 + (30.0 2.82190275490383 20.0)//25 + (30.0 5.17809724509617 20.0) //26 + (30.0 8.0 20.0) //27 + (30.0 0 25.0) //28 + (30.0 2.82190275490383 25.0) //29 + (30.0 5.17809724509617 25.0) //30 + (30.0 8.0 25.0) //31 +); + +blocks +( + hex (0 16 17 1 4 20 21 5) (22 2 2) simpleGrading (1 1 1) + hex (1 17 18 2 5 21 22 6) (22 2 2) simpleGrading (1 1 1) + hex (2 18 19 3 6 22 23 7) (22 2 2) simpleGrading (1 1 1) + hex (4 20 21 5 8 24 25 9) (22 2 10) simpleGrading (1 1 1) + hex (5 21 22 6 9 25 26 10) (22 2 10) simpleGrading (1 1 1) + hex (6 22 23 7 10 26 27 11) (22 2 10) simpleGrading (1 1 1) + hex (8 24 25 9 12 28 29 13) (22 2 3) simpleGrading (1 1 1) + hex (9 25 26 10 13 29 30 14) (22 2 3) simpleGrading (1 1 1) + hex (10 26 27 11 14 30 31 15) (22 2 3) simpleGrading (1 1 1) +); + +edges +( +); + +boundary +( + atmosphere + { + type patch; + faces + ( + (12 28 29 13) + (13 29 30 14) + (14 30 31 15) + ); + } + + outlet + { + type patch; + faces + ( + (1 5 6 2) + ); + } + + walls + { + type wall; + faces + ( + //Left + (0 4 5 1) + (2 6 7 3) + (4 8 9 5) + (5 9 10 6) + (6 10 11 7) + (8 12 13 9) + (9 13 14 10) + (10 14 15 11) + + //Back + (3 7 23 19) + (7 11 27 23) + (11 15 31 27) + + //Right + (16 17 21 20) + (17 18 22 21) + (18 19 23 22) + (20 21 25 24) + (21 22 26 25) + (22 23 27 26) + (24 25 29 28) + (25 26 30 29) + (26 27 31 30) + + //Front + (0 16 20 4) + (4 20 24 8) + (8 24 28 12) + + //Bottom + (0 16 17 1) + (1 17 18 2) + (2 18 19 3) + ); + } +); + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/controlDict b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/controlDict new file mode 100644 index 00000000..e9638c20 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/controlDict @@ -0,0 +1,64 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 1.6 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object controlDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +application cfdemSolverMultiphase; + +startFrom startTime; + +startTime 0; + +stopAt endTime; + +endTime 20.0; + +deltaT 0.005; + +writeControl adjustableRunTime; + +writeInterval 1.0; + +purgeWrite 0; + +writeFormat ascii; + +writePrecision 6; + +writeCompression uncompressed; + +timeFormat general; + +timePrecision 6; + +runTimeModifiable yes; + +adjustTimeStep no; + +maxCo 0.1; +maxAlphaCo 0.1; + + +libs ( + "libfieldFunctionObjects.so" + ); + +functions +{ + #includeFunc flowRatePatch + #includeFunc patchAverage +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/decomposeParDict b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/decomposeParDict new file mode 100644 index 00000000..4de14078 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/decomposeParDict @@ -0,0 +1,86 @@ +/*-------------------------------*- C++ -*---------------------------------*\ +| ========= | +| \\ / OpenFOAM | +| \\ / | +| \\ / The Open Source CFD Toolbox | +| \\/ http://www.OpenFOAM.org | +\*-------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + note "mesh decomposition control dictionary"; + location "system"; + object decomposeParDict; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +numberOfSubdomains 4; + +//- Keep owner and neighbour on same processor for faces in zones: +// preserveFaceZones (heater solid1 solid3); + +//method scotch; +// method hierarchical; + method simple; +// method metis; +// method manual; + +simpleCoeffs +{ + n (2 2 1); + delta 0.001; +} + +hierarchicalCoeffs +{ + n (2 2 1); + delta 0.001; + order xyz; +} + +metisCoeffs +{ + /* + processorWeights + ( + 1 + 1 + 1 + 1 + ); + */ +} + +scotchCoeffs +{ + //processorWeights + //( + // 1 + // 1 + // 1 + // 1 + //); + //writeGraph true; + //strategy "b"; +} + +manualCoeffs +{ + dataFile "decompositionData"; +} + + +//// Is the case distributed +//distributed yes; +//// Per slave (so nProcs-1 entries) the directory above the case. +//roots +//( +// "/tmp" +// "/tmp" +//); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/flowRatePatch b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/flowRatePatch new file mode 100644 index 00000000..3a097f3e --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/flowRatePatch @@ -0,0 +1,19 @@ +/*--------------------------------*- C++ -*----------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Web: www.OpenFOAM.org + \\/ M anipulation | +------------------------------------------------------------------------------- +Description + Calculates the flow rate through a specified patch by summing the flux on + patch faces. For solvers where the flux is volumetric, the flow rate is + volumetric; where flux is mass flux, the flow rate is mass flow rate. + +\*---------------------------------------------------------------------------*/ + +name outlet; + +#includeEtc "caseDicts/postProcessing/flowRate/flowRatePatch.cfg" + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/fvSchemes b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/fvSchemes new file mode 100644 index 00000000..d0a271ce --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/fvSchemes @@ -0,0 +1,68 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSchemes; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +ddtSchemes +{ + default Euler; +} + +gradSchemes +{ + default Gauss linear; + grad(U) Gauss linear; + grad(gamma) Gauss linear; +} + +divSchemes +{ + div(rhoPhi,U) Gauss upwind; + div(phi,alpha) Gauss vanLeer; + div(phirb,alpha) Gauss linear; + div((muEff*dev(T(grad(U))))) Gauss linear; + div((viscousTerm*dev2(grad(U).T()))) Gauss linear; + div(((grad(U)*rho)*dev(grad(U).T()))) Gauss linear; + div(((dev(grad(U).T())*rho)*dev(grad(U).T()))) Gauss linear; + div((((((alpha.water*rho)*nu.water)|(alpha.water*rho))*rho)*dev(grad(U).T()))) Gauss linear; + div(((nu*rho)*dev(grad(U).T()))) Gauss linear; + default Gauss linear; +} + +laplacianSchemes +{ + default Gauss linear corrected; +} + +interpolationSchemes +{ + default linear; +} + +snGradSchemes +{ + default corrected; +} + +fluxRequired +{ + default no; + pcorr; + p_rgh; + "alpha.*"; +} + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/fvSolution b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/fvSolution new file mode 100644 index 00000000..4bcd2197 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/fvSolution @@ -0,0 +1,138 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSolution; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +solvers +{ + "alpha.*" + { + nAlphaSubCycles 1; + cAlpha 1; + } + + pcorr + { + solver PCG; + preconditioner + { + preconditioner GAMG; + tolerance 1e-05; + relTol 0; + smoother GaussSeidel; + nPreSweeps 0; + nPostSweeps 2; + nFinestSweeps 2; + cacheAgglomeration on; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + } + tolerance 1e-05; + relTol 0; + maxIter 100; + } + + p_rgh + { + solver GAMG; + tolerance 1e-07; + relTol 0.05; + smoother GaussSeidel; + nPreSweeps 0; + nPostSweeps 2; + nFinestSweeps 2; + cacheAgglomeration on; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + } + + p_rghFinal + { + solver PCG; + preconditioner + { + preconditioner GAMG; + tolerance 1e-07; + relTol 0; + nVcycles 2; + smoother GaussSeidel; + nPreSweeps 0; + nPostSweeps 2; + nFinestSweeps 2; + cacheAgglomeration on; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + } + tolerance 1e-07; + relTol 0; + maxIter 20; + } + + "(k|epsilon|R|nuTilda)" + { + solver smoothSolver; + smoother GaussSeidel; + tolerance 1e-9; + relTol 0; + nSweeps 1; + } + + "(voidfraction|Us|Ksl|vSmoothField|sSmoothField|UsNext|voidfractionNext)" + { + solver PCG; + preconditioner DIC; + tolerance 1e-05; + relTol 0; + } + + U + { + solver smoothSolver; + smoother GaussSeidel; + tolerance 1e-08; + relTol 0.1; + nSweeps 1; + } + + UFinal + { + $U; + tolerance 1e-08; + relTol 0; + } + +} + +PIMPLE +{ + nCorrectors 2; + nNonOrthogonalCorrectors 0; +} + +relaxationFactors +{ + fields + { + } + equations + { + "U.*" 1; + } +} + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/patchAverage b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/patchAverage new file mode 100644 index 00000000..69c4a772 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/patchAverage @@ -0,0 +1,19 @@ +/*--------------------------------*- C++ -*----------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Web: www.OpenFOAM.org + \\/ M anipulation | +------------------------------------------------------------------------------- +Description + Calculates the average value of one or more fields on a patch. + +\*---------------------------------------------------------------------------*/ + +name outlet; +fields (alpha.air alpha.water alpha.oil); + +operation average; +#includeEtc "caseDicts/postProcessing/surfaceRegion/patch.cfg" + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/setFieldsDict b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/setFieldsDict new file mode 100644 index 00000000..ec73259f --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/CFD/system/setFieldsDict @@ -0,0 +1,51 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: 2.3.0 | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object setFieldsDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +defaultFieldValues +( + volScalarFieldValue alpha.air 1 + volScalarFieldValue alpha.water 0 + volScalarFieldValue alpha.oil 0 + volVectorFieldValue U ( 0 0 0 ) +); + +regions +( + boxToCell + { + box ( 0 0 0 ) ( 0.3 0.08 0.18 ); + fieldValues + ( + volScalarFieldValue alpha.water 1 + volScalarFieldValue alpha.air 0 + ); + } + + boxToCell + { + box ( 0 0 0.18 ) ( 0.3 0.08 0.22 ); + fieldValues + ( + volScalarFieldValue alpha.oil 1 + volScalarFieldValue alpha.air 0 + ); + } + +); + + +// ************************************************************************* // diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/DEM/in.liggghts_init b/tutorials/cfdemSolverMultiphase/tankDrainage/DEM/in.liggghts_init new file mode 100644 index 00000000..5ed37a81 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/DEM/in.liggghts_init @@ -0,0 +1,71 @@ +# Pour granular particles into chute container, then induce flow +echo both +atom_style granular +atom_modify map array +communicate single vel yes + +boundary f f f +newton off + +units si + +region reg block 0 0.3 0 0.08 0 0.25 units box +create_box 1 reg + +neighbor 0.001 bin +neigh_modify delay 0 + + +# Material properties required for granular pair styles + +fix m1 all property/global youngsModulus peratomtype 5.e6 +fix m2 all property/global poissonsRatio peratomtype 0.45 +fix m3 all property/global coefficientRestitution peratomtypepair 1 0.3 +fix m4 all property/global coefficientFriction peratomtypepair 1 0.5 + +# pair style +pair_style gran model hertz tangential history # Hertzian without cohesion +pair_coeff * * + +# timestep, gravity +timestep 0.00001 +fix gravi all gravity 9.81 vector 0.0 0.0 -1.0 + +# walls +fix zwalls1 all wall/gran model hertz tangential history primitive type 1 zplane 0 +fix zwalls2 all wall/gran model hertz tangential history primitive type 1 zplane 0.25 +fix xwalls1 all wall/gran model hertz tangential history primitive type 1 xplane 0 +fix xwalls2 all wall/gran model hertz tangential history primitive type 1 xplane 0.3 +fix ywalls1 all wall/gran model hertz tangential history primitive type 1 yplane 0 +fix ywalls2 all wall/gran model hertz tangential history primitive type 1 yplane 0.08 +#fix cfdmesh all mesh/surface file ../CFD/mesh.stl type 1 +#fix walls all wall/gran model hertz tangential history mesh n_meshes 1 meshes cfdmesh + +# particle distributions and insertion +#region bc block -0.05 0.05 -0.0025 0.0025 0.05 0.1 units box +region bc block 0 0.3 0 0.08 0 0.25 units box +fix pts1 all particletemplate/sphere 1 atom_type 1 density constant 200 radius constant 0.005 +fix pdd1 all particledistribution/discrete 1 1 pts1 1.0 + +fix ins all insert/pack seed 100001 distributiontemplate pdd1 vel constant 0. 0. -1.0 insert_every 100 overlapcheck yes particles_in_region 4000 region bc + +# apply nve integration to all particles that are inserted as single particles +fix integr all nve/sphere + +# screen output +compute rke all erotate/sphere +thermo_style custom step atoms ke c_rke vol +thermo 1000 +thermo_modify lost ignore norm no +compute_modify thermo_temp dynamic yes + +compute pos all property/atom x y z +# insert the first particles so that dump is not empty +run 1 +dump dmp all custom 500 post/dump*.liggghts_init id type x y z ix iy iz vx vy vz fx fy fz omegax omegay omegaz radius c_pos[1] c_pos[2] c_pos[3] +#force : f_couple_cfd[0] f_couple_cfd[1] f_couple_cfd[2] +#node : f_couple_cfd[6] +#cell id : f_couple_cfd[7] + +run 30000 upto +write_restart post/restart/liggghts.restart diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/DEM/in.liggghts_run b/tutorials/cfdemSolverMultiphase/tankDrainage/DEM/in.liggghts_run new file mode 100644 index 00000000..5ab9da0b --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/DEM/in.liggghts_run @@ -0,0 +1,80 @@ +# Pour granular particles into chute container, then induce flow +log ../DEM/log.liggghts +thermo_log ../DEM/post/thermo.txt + +atom_style granular +atom_modify map array +communicate single vel yes + +boundary m m m +newton off + +units si +processors 2 2 1 + +# read the restart file +read_restart ../DEM/post/restart/liggghts.restart + +neighbor 0.005 bin +neigh_modify delay 0 + +# Material properties required for granular pair styles + +fix m1 all property/global youngsModulus peratomtype 5.e6 +fix m2 all property/global poissonsRatio peratomtype 0.45 +fix m3 all property/global coefficientRestitution peratomtypepair 1 0.3 +fix m4 all property/global coefficientFriction peratomtypepair 1 0.5 + +# pair style +pair_style gran model hertz tangential history # Hertzian without cohesion +pair_coeff * * + +# timestep, gravity +timestep 0.0001 +fix gravi all gravity 9.81 vector 0.0 0.0 -1.0 + +# walls +fix zwalls1 all wall/gran model hertz tangential history primitive type 1 zplane 0 +fix zwalls2 all wall/gran model hertz tangential history primitive type 1 zplane 0.25 +fix xwalls1 all wall/gran model hertz tangential history primitive type 1 xplane 0 +fix xwalls2 all wall/gran model hertz tangential history primitive type 1 xplane 0.3 +fix ywalls1 all wall/gran model hertz tangential history primitive type 1 yplane 0 +fix ywalls2 all wall/gran model hertz tangential history primitive type 1 yplane 0.08 +#fix cfdmesh all mesh/surface file ../CFD/mesh.stl type 1 +#fix walls all wall/gran model hertz tangential history mesh n_meshes 1 meshes cfdmesh + +# change the particles density +set group all density 2500 + +# cfd coupling +fix cfd all couple/cfd couple_every 100000000 mpi +fix cfd2 all couple/cfd/force/implicit +#fix cfd2 all couple/cfd/force/accumulator RongDrag 10 1.5e-3 +#fix cfd2 all couple/cfd/force/implicit/accumulated #CrankNicolson 0.5 + +# apply nve integration to all particles that are inserted as single particles +fix integr all nve/sphere + +# center of mass +compute centerOfMass all com + +# compute total dragforce +compute dragtotal all reduce sum f_dragforce[1] f_dragforce[2] f_dragforce[3] + +# screen output +compute rke all erotate/sphere +thermo_style custom step atoms ke c_rke vol c_centerOfMass[3] c_dragtotal[1] c_dragtotal[2] c_dragtotal[3] +thermo 100 +thermo_modify lost ignore norm no +compute_modify thermo_temp dynamic yes + +#compute position all property/atom x y z +fix ts_check all check/timestep/gran 100 0.1 0.1 +dump dmp all custom 1000 ../DEM/post/dump*.liggghts_run id type x y z vx vy vz fx fy fz f_dragforce[1] f_dragforce[2] f_dragforce[3] radius +#dump dmpStl all mesh/stl 500 ../DEM/post/dump*.stl + +run 1 + +#compute rad all property/atom radius +#compute red all reduce sum c_rad +#fix print all ave/time 100 1 100 c_red file ../DEM/radius.dat mode scalar diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/DEM/post/.gitignore b/tutorials/cfdemSolverMultiphase/tankDrainage/DEM/post/.gitignore new file mode 100644 index 00000000..e69de29b diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/DEM/post/restart/.gitignore b/tutorials/cfdemSolverMultiphase/tankDrainage/DEM/post/restart/.gitignore new file mode 100644 index 00000000..e69de29b diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/parCFDDEMrun.sh b/tutorials/cfdemSolverMultiphase/tankDrainage/parCFDDEMrun.sh new file mode 100755 index 00000000..2d92d1bb --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/parCFDDEMrun.sh @@ -0,0 +1,29 @@ +#!/bin/bash + +#===================================================================# +# allrun script for testcase as part of test routine +# run tankDrainage CFD part +#===================================================================# + +#- source CFDEM env vars +. ~/.bashrc + +#- include functions +source $CFDEM_PROJECT_DIR/etc/functions.sh + +#--------------------------------------------------------------------------------# +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" +logpath=$casePath +headerText="run_parallel_cfdemSolverMultiphase_test" +logfileName="log_$headerText" +solverName="cfdemSolverMultiphase" +nrProcs="4" +machineFileName="none" # yourMachinefileName | none +debugMode="off" # on | off| strict +testHarnessPath="$CFDEM_TEST_HARNESS_PATH" +#--------------------------------------------------------------------------------# + +#- call function to run a parallel CFD-DEM case +parCFDDEMrun $logpath $logfileName $casePath $headerText $solverName $nrProcs $machineFileName $debugMode + diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/parDEMrun.sh b/tutorials/cfdemSolverMultiphase/tankDrainage/parDEMrun.sh new file mode 100755 index 00000000..8be90dee --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/parDEMrun.sh @@ -0,0 +1,29 @@ +#!/bin/bash + +#===================================================================# +# DEMrun script for tankDrainage testcase +# init tankDrainage +#===================================================================# + +#- source CFDEM env vars +. ~/.bashrc + +#- include functions +source $CFDEM_PROJECT_DIR/etc/functions.sh + +echo "starting DEM run in parallel..." +#--------------------------------------------------------------------------------# +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" +logpath="$casePath" +headerText="run_liggghts_init_DEM" +logfileName="log_$headerText" +solverName="in.liggghts_init" +nrProcs=4 +machineFileName="none" +debugMode="off" +#--------------------------------------------------------------------------------# + +#- call function to run DEM case +parDEMrun $logpath $logfileName $casePath $headerText $solverName $nrProcs $machineFileName $debugMode + diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/postrun.sh b/tutorials/cfdemSolverMultiphase/tankDrainage/postrun.sh new file mode 100755 index 00000000..1d70b883 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/postrun.sh @@ -0,0 +1,13 @@ +#!/bin/bash + +#- define variables +casePath="$(dirname "$(readlink -f ${BASH_SOURCE[0]})")" + +#- get VTK data from liggghts dump file +cd $casePath/DEM/post +python $CFDEM_LPP_DIR/lpp.py dump*.liggghts_run + +#- get VTK data from CFD sim +cd $casePath/CFD +reconstructPar -zeroTime -noLagrangian +foamToVTK diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/prerun.sh b/tutorials/cfdemSolverMultiphase/tankDrainage/prerun.sh new file mode 100755 index 00000000..567d6388 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/prerun.sh @@ -0,0 +1,9 @@ +#!/bin/bash + +pushd CFD + +cp -r 0.org 0 +setFields + +popd + diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/run.config b/tutorials/cfdemSolverMultiphase/tankDrainage/run.config new file mode 100644 index 00000000..3b8f66a3 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/run.config @@ -0,0 +1,19 @@ +{ + "type" : "CFDEMcoupling", + "runs" : [ + { + "name" : "liggghts-init", + "input_script" : "DEM/in.liggghts_init", + "type" : "liggghts/serial" + }, + { + "name" : "cfdemrun", + "depends_on" : "liggghts-init", + "solver" : "cfdemSolverMultiphase", + "type" : "CFDEMcoupling/mpi", + "nprocs" : 4, + "pre_scripts" : ["prerun.sh"], + "post_scripts" : ["postrun.sh"] + } + ] +} diff --git a/tutorials/cfdemSolverMultiphase/tankDrainage/volFlow.m b/tutorials/cfdemSolverMultiphase/tankDrainage/volFlow.m new file mode 100644 index 00000000..2d8de325 --- /dev/null +++ b/tutorials/cfdemSolverMultiphase/tankDrainage/volFlow.m @@ -0,0 +1,38 @@ +clear all +clc +close all + +graphics_toolkit gnuplot + +time = dlmread('./CFD/postProcessing/flowRatePatch/0/surfaceRegion.dat','\t',4,0)(:,1); +phi = dlmread('./CFD/postProcessing/flowRatePatch/0/surfaceRegion.dat','\t',4,0)(:,2); +alphaAir = dlmread('./CFD/postProcessing/patchAverage/0/surfaceRegion.dat','\t',4,0)(:,2); +alphaWater = dlmread('./CFD/postProcessing/patchAverage/0/surfaceRegion.dat','\t',4,0)(:,3); +alphaOil = dlmread('./CFD/postProcessing/patchAverage/0/surfaceRegion.dat','\t',4,0)(:,4); + +volflowAir = phi.*alphaAir; +volflowWater = phi.*alphaWater; +volflowOil = phi.*alphaOil; + +figure +hold on +plot(time,volflowAir*1000,'linewidth',5) +plot(time,volflowWater*1000,'r','linewidth',5) +plot(time,volflowOil*1000,'k','linewidth',5) +axis([0 20 0 0.45]) +xlabel('Time, s','FontSize',14,'FontWeight','Bold') +ylabel('Volumetric flow rate, dm^3/s','FontSize',14,'FontWeight','Bold') +h=legend('Air ', 'Water ', 'Oil '); +set(h,'FontWeight','Bold') +set(gca,'FontSize',14) +set(gca,'FontWeight','bold') + +print -dpng volFlow.png +pause + + + + + + + diff --git a/tutorials/cfdemSolverRhoPimple/ErgunTestMPI/CFD/constant/couplingProperties b/tutorials/cfdemSolverRhoPimple/ErgunTestMPI/CFD/constant/couplingProperties index debd08bf..2e09e57e 100644 --- a/tutorials/cfdemSolverRhoPimple/ErgunTestMPI/CFD/constant/couplingProperties +++ b/tutorials/cfdemSolverRhoPimple/ErgunTestMPI/CFD/constant/couplingProperties @@ -72,7 +72,10 @@ energyModels heatTransferGunn ); -chemistryModel off; +chemistryModels +( + off +); thermCondModel SyamlalThermCond; diff --git a/tutorials/cfdemSolverRhoPimple/FinesColumn/CFD/constant/couplingProperties b/tutorials/cfdemSolverRhoPimple/FinesColumn/CFD/constant/couplingProperties index 60023537..6569a646 100755 --- a/tutorials/cfdemSolverRhoPimple/FinesColumn/CFD/constant/couplingProperties +++ b/tutorials/cfdemSolverRhoPimple/FinesColumn/CFD/constant/couplingProperties @@ -80,7 +80,10 @@ energyModels thermCondModel SyamlalThermCond; -chemistryModel off; +chemistryModels +( + off +); turbulenceModelType "turbulenceProperties";