Code style: Updated line comments to start with a space
//This is a comment -> // This is a comment
This commit is contained in:
@ -111,7 +111,7 @@ void PDRkEpsilon::correct()
|
|||||||
|
|
||||||
// Re-calculate thermal diffusivity
|
// Re-calculate thermal diffusivity
|
||||||
//***HGWalphat_ = mut_/Prt_;
|
//***HGWalphat_ = mut_/Prt_;
|
||||||
//alphat_.correctBoundaryConditions();
|
// alphat_.correctBoundaryConditions();
|
||||||
|
|
||||||
return;
|
return;
|
||||||
}
|
}
|
||||||
@ -192,7 +192,7 @@ void PDRkEpsilon::correct()
|
|||||||
|
|
||||||
// Re-calculate thermal diffusivity
|
// Re-calculate thermal diffusivity
|
||||||
//***HGWalphat_ = mut_/Prt_;
|
//***HGWalphat_ = mut_/Prt_;
|
||||||
//alphat_.correctBoundaryConditions();
|
// alphat_.correctBoundaryConditions();
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
|
|||||||
@ -30,7 +30,7 @@ if (ign.ignited())
|
|||||||
// Calculate flame normal etc.
|
// Calculate flame normal etc.
|
||||||
// ~~~~~~~~~~~~~~~~~~~~~~~~~~~
|
// ~~~~~~~~~~~~~~~~~~~~~~~~~~~
|
||||||
|
|
||||||
//volVectorField n(fvc::grad(b));
|
// volVectorField n(fvc::grad(b));
|
||||||
volVectorField n(fvc::reconstruct(fvc::snGrad(b)*mesh.magSf()));
|
volVectorField n(fvc::reconstruct(fvc::snGrad(b)*mesh.magSf()));
|
||||||
|
|
||||||
volScalarField mgb("mgb", mag(n));
|
volScalarField mgb("mgb", mag(n));
|
||||||
|
|||||||
@ -80,7 +80,7 @@ if (ign.ignited())
|
|||||||
// ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
|
// ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
|
||||||
|
|
||||||
volScalarField up(uPrimeCoef*sqrt((2.0/3.0)*turbulence->k()));
|
volScalarField up(uPrimeCoef*sqrt((2.0/3.0)*turbulence->k()));
|
||||||
//volScalarField up(sqrt(mag(diag(n * n) & diag(turbulence->r()))));
|
// volScalarField up(sqrt(mag(diag(n * n) & diag(turbulence->r()))));
|
||||||
|
|
||||||
volScalarField epsilon(pow(uPrimeCoef, 3)*turbulence->epsilon());
|
volScalarField epsilon(pow(uPrimeCoef, 3)*turbulence->epsilon());
|
||||||
|
|
||||||
@ -95,8 +95,8 @@ if (ign.ignited())
|
|||||||
)
|
)
|
||||||
);
|
);
|
||||||
|
|
||||||
//volScalarField l = 0.337*k*sqrt(k)/epsilon;
|
// volScalarField l = 0.337*k*sqrt(k)/epsilon;
|
||||||
//Reta *= max((l - dimensionedScalar("dl", dimLength, 1.5e-3))/l, 0.0);
|
// Reta *= max((l - dimensionedScalar("dl", dimLength, 1.5e-3))/l, 0.0);
|
||||||
|
|
||||||
// Calculate Xi flux
|
// Calculate Xi flux
|
||||||
// ~~~~~~~~~~~~~~~~~
|
// ~~~~~~~~~~~~~~~~~
|
||||||
@ -226,7 +226,7 @@ if (ign.ignited())
|
|||||||
volScalarField R(Gstar*XiEqStar/(XiEqStar - scalar(1)));
|
volScalarField R(Gstar*XiEqStar/(XiEqStar - scalar(1)));
|
||||||
volScalarField G(R*(XiEq - scalar(1.001))/XiEq);
|
volScalarField G(R*(XiEq - scalar(1.001))/XiEq);
|
||||||
|
|
||||||
//R *= (Gstar + 2*mag(dev(symm(fvc::grad(U)))))/Gstar;
|
// R *= (Gstar + 2*mag(dev(symm(fvc::grad(U)))))/Gstar;
|
||||||
|
|
||||||
// Solve for the flame wrinkling
|
// Solve for the flame wrinkling
|
||||||
// ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
|
// ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
|
||||||
|
|||||||
@ -100,7 +100,7 @@ void Foam::adjointOutletVelocityFvPatchVectorField::updateCoeffs()
|
|||||||
vectorField Uan(patch().nf()*(patch().nf() & patchInternalField()));
|
vectorField Uan(patch().nf()*(patch().nf() & patchInternalField()));
|
||||||
|
|
||||||
vectorField::operator=(phiap*patch().Sf()/sqr(patch().magSf()) + UtHat);
|
vectorField::operator=(phiap*patch().Sf()/sqr(patch().magSf()) + UtHat);
|
||||||
//vectorField::operator=(Uan + UtHat);
|
// vectorField::operator=(Uan + UtHat);
|
||||||
|
|
||||||
fixedValueFvPatchVectorField::updateCoeffs();
|
fixedValueFvPatchVectorField::updateCoeffs();
|
||||||
}
|
}
|
||||||
|
|||||||
@ -91,7 +91,7 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
laminarTransport.lookup("lambda") >> lambda;
|
laminarTransport.lookup("lambda") >> lambda;
|
||||||
|
|
||||||
//alpha +=
|
// alpha +=
|
||||||
// mesh.relaxationFactor("alpha")
|
// mesh.relaxationFactor("alpha")
|
||||||
// *(lambda*max(Ua & U, zeroSensitivity) - alpha);
|
// *(lambda*max(Ua & U, zeroSensitivity) - alpha);
|
||||||
alpha +=
|
alpha +=
|
||||||
@ -99,7 +99,7 @@ int main(int argc, char *argv[])
|
|||||||
*(min(max(alpha + lambda*(Ua & U), zeroAlpha), alphaMax) - alpha);
|
*(min(max(alpha + lambda*(Ua & U), zeroAlpha), alphaMax) - alpha);
|
||||||
|
|
||||||
zeroCells(alpha, inletCells);
|
zeroCells(alpha, inletCells);
|
||||||
//zeroCells(alpha, outletCells);
|
// zeroCells(alpha, outletCells);
|
||||||
|
|
||||||
// Pressure-velocity SIMPLE corrector
|
// Pressure-velocity SIMPLE corrector
|
||||||
{
|
{
|
||||||
@ -165,7 +165,7 @@ int main(int argc, char *argv[])
|
|||||||
// Adjoint Momentum predictor
|
// Adjoint Momentum predictor
|
||||||
|
|
||||||
volVectorField adjointTransposeConvection((fvc::grad(Ua) & U));
|
volVectorField adjointTransposeConvection((fvc::grad(Ua) & U));
|
||||||
//volVectorField adjointTransposeConvection
|
// volVectorField adjointTransposeConvection
|
||||||
//(
|
//(
|
||||||
// fvc::reconstruct
|
// fvc::reconstruct
|
||||||
// (
|
// (
|
||||||
|
|||||||
@ -16,5 +16,5 @@
|
|||||||
|
|
||||||
psiModel->correct();
|
psiModel->correct();
|
||||||
|
|
||||||
//Info<< "min a: " << 1.0/sqrt(max(psi)).value() << endl;
|
// Info<< "min a: " << 1.0/sqrt(max(psi)).value() << endl;
|
||||||
}
|
}
|
||||||
|
|||||||
@ -33,8 +33,8 @@ else
|
|||||||
{
|
{
|
||||||
volScalarField rhoNew(alpha1*rho1 + alpha2*rho2 + alpha3*rho3);
|
volScalarField rhoNew(alpha1*rho1 + alpha2*rho2 + alpha3*rho3);
|
||||||
|
|
||||||
//solve(fvm::ddt(rho) + fvc::div(rhoPhi));
|
// solve(fvm::ddt(rho) + fvc::div(rhoPhi));
|
||||||
//Info<< "density error = "
|
// Info<< "density error = "
|
||||||
// << max((mag(rho - rhoNew)/mag(rhoNew))().primitiveField()) << endl;
|
// << max((mag(rho - rhoNew)/mag(rhoNew))().primitiveField()) << endl;
|
||||||
|
|
||||||
rho == rhoNew;
|
rho == rhoNew;
|
||||||
|
|||||||
@ -56,7 +56,7 @@ forAllIter(PtrDictionary<phaseModel>, fluid.phases(), iter)
|
|||||||
alpha*(1 + (1/phase.rho())*fluid.Cvm(phase)),
|
alpha*(1 + (1/phase.rho())*fluid.Cvm(phase)),
|
||||||
UEqns[phasei]
|
UEqns[phasei]
|
||||||
);
|
);
|
||||||
//UEqns[phasei].relax();
|
// UEqns[phasei].relax();
|
||||||
|
|
||||||
phasei++;
|
phasei++;
|
||||||
}
|
}
|
||||||
|
|||||||
@ -687,8 +687,8 @@ Foam::multiphaseSystem::dragCoeffs() const
|
|||||||
(
|
(
|
||||||
max
|
max
|
||||||
(
|
(
|
||||||
//fvc::average(dm.phase1()*dm.phase2()),
|
// fvc::average(dm.phase1()*dm.phase2()),
|
||||||
//fvc::average(dm.phase1())*fvc::average(dm.phase2()),
|
// fvc::average(dm.phase1())*fvc::average(dm.phase2()),
|
||||||
dm.phase1()*dm.phase2(),
|
dm.phase1()*dm.phase2(),
|
||||||
dm.residualPhaseFraction()
|
dm.residualPhaseFraction()
|
||||||
)
|
)
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -210,7 +210,7 @@ Foam::autoPtr<Foam::phaseModel> Foam::phaseModel::clone() const
|
|||||||
|
|
||||||
void Foam::phaseModel::correct()
|
void Foam::phaseModel::correct()
|
||||||
{
|
{
|
||||||
//nuModel_->correct();
|
// nuModel_->correct();
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
@ -218,7 +218,7 @@ bool Foam::phaseModel::read(const dictionary& phaseDict)
|
|||||||
{
|
{
|
||||||
phaseDict_ = phaseDict;
|
phaseDict_ = phaseDict;
|
||||||
|
|
||||||
//if (nuModel_->read(phaseDict_))
|
// if (nuModel_->read(phaseDict_))
|
||||||
{
|
{
|
||||||
phaseDict_.lookup("nu") >> nu_.value();
|
phaseDict_.lookup("nu") >> nu_.value();
|
||||||
phaseDict_.lookup("kappa") >> kappa_.value();
|
phaseDict_.lookup("kappa") >> kappa_.value();
|
||||||
|
|||||||
@ -5,10 +5,10 @@
|
|||||||
// tmp<fvScalarMatrix> pEqnComp1;
|
// tmp<fvScalarMatrix> pEqnComp1;
|
||||||
// tmp<fvScalarMatrix> pEqnComp2;
|
// tmp<fvScalarMatrix> pEqnComp2;
|
||||||
|
|
||||||
// //if (transonic)
|
// // if (transonic)
|
||||||
// //{
|
// //{
|
||||||
// //}
|
// //}
|
||||||
// //else
|
// // else
|
||||||
// {
|
// {
|
||||||
// surfaceScalarField phid1("phid1", fvc::interpolate(psi1)*phi1);
|
// surfaceScalarField phid1("phid1", fvc::interpolate(psi1)*phi1);
|
||||||
// surfaceScalarField phid2("phid2", fvc::interpolate(psi2)*phi2);
|
// surfaceScalarField phid2("phid2", fvc::interpolate(psi2)*phi2);
|
||||||
@ -288,7 +288,7 @@
|
|||||||
)
|
)
|
||||||
)/phase.rho();
|
)/phase.rho();
|
||||||
|
|
||||||
//phase.U() = fvc::reconstruct(phase.phi());
|
// phase.U() = fvc::reconstruct(phase.phi());
|
||||||
phase.U().correctBoundaryConditions();
|
phase.U().correctBoundaryConditions();
|
||||||
|
|
||||||
U += alpha*phase.U();
|
U += alpha*phase.U();
|
||||||
@ -298,7 +298,7 @@
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
//p = max(p, pMin);
|
// p = max(p, pMin);
|
||||||
|
|
||||||
#include "continuityErrs.H"
|
#include "continuityErrs.H"
|
||||||
|
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -89,8 +89,8 @@ int main(int argc, char *argv[])
|
|||||||
DEqn += fvc::grad(threeKalpha*T);
|
DEqn += fvc::grad(threeKalpha*T);
|
||||||
}
|
}
|
||||||
|
|
||||||
//DEqn.setComponentReference(1, 0, vector::X, 0);
|
// DEqn.setComponentReference(1, 0, vector::X, 0);
|
||||||
//DEqn.setComponentReference(1, 0, vector::Z, 0);
|
// DEqn.setComponentReference(1, 0, vector::Z, 0);
|
||||||
|
|
||||||
initialResidual = DEqn.solve().max().initialResidual();
|
initialResidual = DEqn.solve().max().initialResidual();
|
||||||
|
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -51,11 +51,11 @@ int main(int argc, char *argv[])
|
|||||||
samples[3] = 3;
|
samples[3] = 3;
|
||||||
scalarField values(4);
|
scalarField values(4);
|
||||||
values = 1.0;
|
values = 1.0;
|
||||||
//values[0] = 0.0;
|
// values[0] = 0.0;
|
||||||
//values[1] = 1.0;
|
// values[1] = 1.0;
|
||||||
|
|
||||||
linearInterpolationWeights interpolator
|
linearInterpolationWeights interpolator
|
||||||
//splineInterpolationWeights interpolator
|
// splineInterpolationWeights interpolator
|
||||||
(
|
(
|
||||||
samples
|
samples
|
||||||
);
|
);
|
||||||
@ -84,9 +84,9 @@ int main(int argc, char *argv[])
|
|||||||
//
|
//
|
||||||
//
|
//
|
||||||
// interpolator.integrationWeights(-0.01, 1, indices, weights);
|
// interpolator.integrationWeights(-0.01, 1, indices, weights);
|
||||||
// //Pout<< "samples:" << samples << endl;
|
// // Pout<< "samples:" << samples << endl;
|
||||||
// //Pout<< "indices:" << indices << endl;
|
// // Pout<< "indices:" << indices << endl;
|
||||||
// //Pout<< "weights:" << weights << endl;
|
// // Pout<< "weights:" << weights << endl;
|
||||||
// scalar sum = interpolator.weightedSum
|
// scalar sum = interpolator.weightedSum
|
||||||
// (
|
// (
|
||||||
// weights,
|
// weights,
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -48,7 +48,7 @@ int main(int argc, char *argv[])
|
|||||||
Map<bool>::const_iterator bananaIter = banana.find(5);
|
Map<bool>::const_iterator bananaIter = banana.find(5);
|
||||||
|
|
||||||
// This works but now I can change the value.
|
// This works but now I can change the value.
|
||||||
//Map<bool>::iterator bananaIter = banana.find(5);
|
// Map<bool>::iterator bananaIter = banana.find(5);
|
||||||
|
|
||||||
if (bananaIter == banana.end())
|
if (bananaIter == banana.end())
|
||||||
{
|
{
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -50,7 +50,7 @@ int main(int argc, char *argv[])
|
|||||||
hmm(2, 1) = 6.0;
|
hmm(2, 1) = 6.0;
|
||||||
hmm(2, 2) = 1.0;
|
hmm(2, 2) = 1.0;
|
||||||
|
|
||||||
//Info<< hmm << endl << hmm - 2.0*(-hmm) << endl;
|
// Info<< hmm << endl << hmm - 2.0*(-hmm) << endl;
|
||||||
Info<< max(hmm) << endl;
|
Info<< max(hmm) << endl;
|
||||||
Info<< min(hmm) << endl;
|
Info<< min(hmm) << endl;
|
||||||
|
|
||||||
@ -60,9 +60,9 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
Info<< hmm << endl;
|
Info<< hmm << endl;
|
||||||
|
|
||||||
//SquareMatrix<scalar> hmm3(Sin);
|
// SquareMatrix<scalar> hmm3(Sin);
|
||||||
|
|
||||||
//Info<< hmm3 << endl;
|
// Info<< hmm3 << endl;
|
||||||
|
|
||||||
SquareMatrix<scalar> hmm4;
|
SquareMatrix<scalar> hmm4;
|
||||||
|
|
||||||
|
|||||||
@ -242,7 +242,7 @@ int main(int argc, char *argv[])
|
|||||||
forAll(en, patchEdgeI)
|
forAll(en, patchEdgeI)
|
||||||
{
|
{
|
||||||
const edge& patchE = pp.edges()[patchEdgeI];
|
const edge& patchE = pp.edges()[patchEdgeI];
|
||||||
//str.write(pp.localPoints()[pointi], en[pointi]);
|
// str.write(pp.localPoints()[pointi], en[pointi]);
|
||||||
const point pt = patchE.centre(pp.localPoints());
|
const point pt = patchE.centre(pp.localPoints());
|
||||||
str.write(linePointRef(pt, pt + 0.1*en[patchEdgeI]));
|
str.write(linePointRef(pt, pt + 0.1*en[patchEdgeI]));
|
||||||
}
|
}
|
||||||
|
|||||||
@ -24,7 +24,7 @@ keyY parentValue5;
|
|||||||
"(.*)Dict"
|
"(.*)Dict"
|
||||||
{
|
{
|
||||||
foo subdictValue0;
|
foo subdictValue0;
|
||||||
//bar $f.*; // should this really match 'foo'?
|
// bar $f.*; // should this really match 'foo'?
|
||||||
|
|
||||||
// result is dependent on insert order!
|
// result is dependent on insert order!
|
||||||
"a.*c" subdictValue3;
|
"a.*c" subdictValue3;
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -146,8 +146,8 @@ int main(int argc, char *argv[])
|
|||||||
// ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
|
// ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
|
||||||
|
|
||||||
// {
|
// {
|
||||||
// //const FECCellToFaceStencil cfcStencil(mesh);
|
// // const FECCellToFaceStencil cfcStencil(mesh);
|
||||||
// //const extendedCentredCellToFaceStencil addressing
|
// // const extendedCentredCellToFaceStencil addressing
|
||||||
// //(
|
// //(
|
||||||
// // cfcStencil
|
// // cfcStencil
|
||||||
// //);
|
// //);
|
||||||
@ -249,25 +249,25 @@ int main(int argc, char *argv[])
|
|||||||
// // ~~~~~~~~~~~~~~~~~~~~~~
|
// // ~~~~~~~~~~~~~~~~~~~~~~
|
||||||
//
|
//
|
||||||
// {
|
// {
|
||||||
// //const extendedCentredCellToFaceStencil& addressing =
|
// // const extendedCentredCellToFaceStencil& addressing =
|
||||||
// //centredCPCStencilObject::New
|
// // centredCPCStencilObject::New
|
||||||
// //(
|
// //(
|
||||||
// // mesh
|
// // mesh
|
||||||
// //);
|
// //);
|
||||||
// //
|
// //
|
||||||
// //Info<< "cellPointCell:" << endl;
|
// // Info<< "cellPointCell:" << endl;
|
||||||
// //writeStencilStats(addressing.stencil());
|
// // writeStencilStats(addressing.stencil());
|
||||||
// //
|
// //
|
||||||
// //
|
// //
|
||||||
// //// Collect stencil cell centres
|
// //// Collect stencil cell centres
|
||||||
// //List<List<point>> stencilPoints(mesh.nFaces());
|
// // List<List<point>> stencilPoints(mesh.nFaces());
|
||||||
// //addressing.collectData
|
// // addressing.collectData
|
||||||
// //(
|
// //(
|
||||||
// // mesh.C(),
|
// // mesh.C(),
|
||||||
// // stencilPoints
|
// // stencilPoints
|
||||||
// //);
|
// //);
|
||||||
// //
|
// //
|
||||||
// //forAll(stencilPoints, facei)
|
// // forAll(stencilPoints, facei)
|
||||||
// //{
|
// //{
|
||||||
// // writeStencilOBJ
|
// // writeStencilOBJ
|
||||||
// // (
|
// // (
|
||||||
@ -284,25 +284,25 @@ int main(int argc, char *argv[])
|
|||||||
// // ~~~~~~~~~~~~~~~~~~~~~~
|
// // ~~~~~~~~~~~~~~~~~~~~~~
|
||||||
//
|
//
|
||||||
// {
|
// {
|
||||||
// //const extendedCentredCellToFaceStencil& addressing =
|
// // const extendedCentredCellToFaceStencil& addressing =
|
||||||
// //centredCECStencilObject::New
|
// // centredCECStencilObject::New
|
||||||
// //(
|
// //(
|
||||||
// // mesh
|
// // mesh
|
||||||
// //);
|
// //);
|
||||||
// //
|
// //
|
||||||
// //Info<< "cellEdgeCell:" << endl;
|
// // Info<< "cellEdgeCell:" << endl;
|
||||||
// //writeStencilStats(addressing.stencil());
|
// // writeStencilStats(addressing.stencil());
|
||||||
// //
|
// //
|
||||||
// //
|
// //
|
||||||
// //// Collect stencil cell centres
|
// //// Collect stencil cell centres
|
||||||
// //List<List<point>> stencilPoints(mesh.nFaces());
|
// // List<List<point>> stencilPoints(mesh.nFaces());
|
||||||
// //addressing.collectData
|
// // addressing.collectData
|
||||||
// //(
|
// //(
|
||||||
// // mesh.C(),
|
// // mesh.C(),
|
||||||
// // stencilPoints
|
// // stencilPoints
|
||||||
// //);
|
// //);
|
||||||
// //
|
// //
|
||||||
// //forAll(stencilPoints, facei)
|
// // forAll(stencilPoints, facei)
|
||||||
// //{
|
// //{
|
||||||
// // writeStencilOBJ
|
// // writeStencilOBJ
|
||||||
// // (
|
// // (
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -72,7 +72,7 @@ int main(int argc, char *argv[])
|
|||||||
{
|
{
|
||||||
indexedOctree<treeDataCell> ioc
|
indexedOctree<treeDataCell> ioc
|
||||||
(
|
(
|
||||||
treeDataCell(true, mesh, decompMode), //FACEDIAGTETS),
|
treeDataCell(true, mesh, decompMode), // FACEDIAGTETS),
|
||||||
shiftedBb,
|
shiftedBb,
|
||||||
10, // maxLevel
|
10, // maxLevel
|
||||||
100, // leafsize
|
100, // leafsize
|
||||||
|
|||||||
@ -54,8 +54,8 @@ multiLevelCoeffs
|
|||||||
level0
|
level0
|
||||||
{
|
{
|
||||||
numberOfSubdomains 64;
|
numberOfSubdomains 64;
|
||||||
//method simple;
|
// method simple;
|
||||||
//simpleCoeffs
|
// simpleCoeffs
|
||||||
//{
|
//{
|
||||||
// n (2 1 1);
|
// n (2 1 1);
|
||||||
// delta 0.001;
|
// delta 0.001;
|
||||||
@ -100,15 +100,15 @@ metisCoeffs
|
|||||||
|
|
||||||
scotchCoeffs
|
scotchCoeffs
|
||||||
{
|
{
|
||||||
//processorWeights
|
// processorWeights
|
||||||
//(
|
//(
|
||||||
// 1
|
// 1
|
||||||
// 1
|
// 1
|
||||||
// 1
|
// 1
|
||||||
// 1
|
// 1
|
||||||
//);
|
//);
|
||||||
//writeGraph true;
|
// writeGraph true;
|
||||||
//strategy "b";
|
// strategy "b";
|
||||||
}
|
}
|
||||||
|
|
||||||
manualCoeffs
|
manualCoeffs
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2013-2017 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -150,7 +150,7 @@ int main(int argc, char *argv[])
|
|||||||
top.append(i);
|
top.append(i);
|
||||||
}
|
}
|
||||||
|
|
||||||
//Pout<< "bottom:" << bottom << endl;
|
// Pout<< "bottom:" << bottom << endl;
|
||||||
Pout<< "top :" << top << endl;
|
Pout<< "top :" << top << endl;
|
||||||
|
|
||||||
|
|
||||||
@ -171,9 +171,9 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
if (Pstream::myProcNo(comm) != -1)
|
if (Pstream::myProcNo(comm) != -1)
|
||||||
{
|
{
|
||||||
//scalar sum = sumReduce(comm, localValue);
|
// scalar sum = sumReduce(comm, localValue);
|
||||||
//scalar sum = localValue;
|
// scalar sum = localValue;
|
||||||
//reduce
|
// reduce
|
||||||
//(
|
//(
|
||||||
// UPstream::treeCommunication(comm),
|
// UPstream::treeCommunication(comm),
|
||||||
// sum,
|
// sum,
|
||||||
|
|||||||
@ -54,8 +54,8 @@ multiLevelCoeffs
|
|||||||
level0
|
level0
|
||||||
{
|
{
|
||||||
numberOfSubdomains 64;
|
numberOfSubdomains 64;
|
||||||
//method simple;
|
// method simple;
|
||||||
//simpleCoeffs
|
// simpleCoeffs
|
||||||
//{
|
//{
|
||||||
// n (2 1 1);
|
// n (2 1 1);
|
||||||
// delta 0.001;
|
// delta 0.001;
|
||||||
@ -99,15 +99,15 @@ metisCoeffs
|
|||||||
|
|
||||||
scotchCoeffs
|
scotchCoeffs
|
||||||
{
|
{
|
||||||
//processorWeights
|
// processorWeights
|
||||||
//(
|
//(
|
||||||
// 1
|
// 1
|
||||||
// 1
|
// 1
|
||||||
// 1
|
// 1
|
||||||
// 1
|
// 1
|
||||||
//);
|
//);
|
||||||
//writeGraph true;
|
// writeGraph true;
|
||||||
//strategy "b";
|
// strategy "b";
|
||||||
}
|
}
|
||||||
|
|
||||||
manualCoeffs
|
manualCoeffs
|
||||||
|
|||||||
@ -19,8 +19,8 @@ solvers
|
|||||||
{
|
{
|
||||||
p
|
p
|
||||||
{
|
{
|
||||||
//solver PCG;
|
// solver PCG;
|
||||||
//preconditioner DIC;
|
// preconditioner DIC;
|
||||||
|
|
||||||
solver GAMG;
|
solver GAMG;
|
||||||
smoother GaussSeidel;
|
smoother GaussSeidel;
|
||||||
@ -31,8 +31,8 @@ solvers
|
|||||||
nCellsInCoarsestLevel 3;
|
nCellsInCoarsestLevel 3;
|
||||||
mergeLevels 1;
|
mergeLevels 1;
|
||||||
|
|
||||||
processorAgglomerator none; //procFaces;
|
processorAgglomerator none; // procFaces;
|
||||||
//nAgglomeratingCells 20;
|
// nAgglomeratingCells 20;
|
||||||
|
|
||||||
tolerance 1e-06;
|
tolerance 1e-06;
|
||||||
relTol 0;
|
relTol 0;
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -47,7 +47,7 @@ int main(int argc, char *argv[])
|
|||||||
{
|
{
|
||||||
argList args(argc, argv);
|
argList args(argc, argv);
|
||||||
|
|
||||||
//Pout.prefix() = '[' + name(Pstream::myProcNo()) + "] ";
|
// Pout.prefix() = '[' + name(Pstream::myProcNo()) + "] ";
|
||||||
|
|
||||||
List<vector> list(IStringStream("1 ((0 1 2))")());
|
List<vector> list(IStringStream("1 ((0 1 2))")());
|
||||||
Info<< list << endl;
|
Info<< list << endl;
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -60,7 +60,7 @@ class Gather
|
|||||||
label nProcs_;
|
label nProcs_;
|
||||||
|
|
||||||
//- Storage of type 0
|
//- Storage of type 0
|
||||||
//List<T0> data0_;
|
// List<T0> data0_;
|
||||||
|
|
||||||
public:
|
public:
|
||||||
|
|
||||||
|
|||||||
@ -309,7 +309,7 @@ bool Foam::router::route(const labelList& path, const label pathValue)
|
|||||||
{
|
{
|
||||||
if (weights_[path[leafI]] == labelMax)
|
if (weights_[path[leafI]] == labelMax)
|
||||||
{
|
{
|
||||||
//Info<< "Cannot route leaf from " << path[0]
|
// Info<< "Cannot route leaf from " << path[0]
|
||||||
// << " to " << path[leafI] << " of path " << path
|
// << " to " << path[leafI] << " of path " << path
|
||||||
// << " since there is no valid route between them" << endl;
|
// << " since there is no valid route between them" << endl;
|
||||||
|
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -56,7 +56,7 @@ int main(int argc, char *argv[])
|
|||||||
mesh
|
mesh
|
||||||
);
|
);
|
||||||
|
|
||||||
//Info<< min(p, p);
|
// Info<< min(p, p);
|
||||||
|
|
||||||
Info<< "Reading field U\n" << endl;
|
Info<< "Reading field U\n" << endl;
|
||||||
volVectorField U
|
volVectorField U
|
||||||
@ -110,7 +110,7 @@ int main(int argc, char *argv[])
|
|||||||
mesh.faceAreas()
|
mesh.faceAreas()
|
||||||
);
|
);
|
||||||
|
|
||||||
//Info<< Sf << endl;
|
// Info<< Sf << endl;
|
||||||
|
|
||||||
return 0;
|
return 0;
|
||||||
}
|
}
|
||||||
|
|||||||
@ -177,7 +177,7 @@ int main()
|
|||||||
|
|
||||||
for (int j=0; j<nIter; j++)
|
for (int j=0; j<nIter; j++)
|
||||||
{
|
{
|
||||||
//sf4 = sf1 + sf2 - sf3;
|
// sf4 = sf1 + sf2 - sf3;
|
||||||
sf4 = sf1;
|
sf4 = sf1;
|
||||||
sf4 += sf2;
|
sf4 += sf2;
|
||||||
sf4 -= sf3;
|
sf4 -= sf3;
|
||||||
|
|||||||
@ -221,7 +221,7 @@ void testSparseData(const polyMesh& mesh, Random& rndGen)
|
|||||||
fullData[meshPointi] = pt;
|
fullData[meshPointi] = pt;
|
||||||
}
|
}
|
||||||
|
|
||||||
//Pout<< "sparseData:" << sparseData << endl;
|
// Pout<< "sparseData:" << sparseData << endl;
|
||||||
|
|
||||||
syncTools::syncPointMap
|
syncTools::syncPointMap
|
||||||
(
|
(
|
||||||
@ -306,7 +306,7 @@ void testSparseData(const polyMesh& mesh, Random& rndGen)
|
|||||||
fullData[meshEdgeI] = pt;
|
fullData[meshEdgeI] = pt;
|
||||||
}
|
}
|
||||||
|
|
||||||
//Pout<< "sparseData:" << sparseData << endl;
|
// Pout<< "sparseData:" << sparseData << endl;
|
||||||
|
|
||||||
syncTools::syncEdgeMap
|
syncTools::syncEdgeMap
|
||||||
(
|
(
|
||||||
|
|||||||
@ -23,7 +23,7 @@ int main()
|
|||||||
Info<< t1.x() << t1.y() << t1.z() << endl;
|
Info<< t1.x() << t1.y() << t1.z() << endl;
|
||||||
|
|
||||||
tensor t6(1,0,-4,0,5,4,-4,4,3);
|
tensor t6(1,0,-4,0,5,4,-4,4,3);
|
||||||
//tensor t6(1,2,0,2,5,0,0,0,0);
|
// tensor t6(1,2,0,2,5,0,0,0,0);
|
||||||
|
|
||||||
Info<< "tensor " << t6 << endl;
|
Info<< "tensor " << t6 << endl;
|
||||||
vector e = eigenValues(t6);
|
vector e = eigenValues(t6);
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -181,7 +181,7 @@ void Foam::cellSplitter::setRefinement
|
|||||||
);
|
);
|
||||||
addedPoints_.insert(celli, addedPointi);
|
addedPoints_.insert(celli, addedPointi);
|
||||||
|
|
||||||
//Pout<< "Added point " << addedPointi
|
// Pout<< "Added point " << addedPointi
|
||||||
// << iter() << " in cell " << celli << " with centre "
|
// << iter() << " in cell " << celli << " with centre "
|
||||||
// << mesh_.cellCentres()[celli] << endl;
|
// << mesh_.cellCentres()[celli] << endl;
|
||||||
}
|
}
|
||||||
@ -226,7 +226,7 @@ void Foam::cellSplitter::setRefinement
|
|||||||
|
|
||||||
cellToCells.insert(celli, newCells);
|
cellToCells.insert(celli, newCells);
|
||||||
|
|
||||||
//Pout<< "Split cell " << celli
|
// Pout<< "Split cell " << celli
|
||||||
// << " with centre " << mesh_.cellCentres()[celli] << nl
|
// << " with centre " << mesh_.cellCentres()[celli] << nl
|
||||||
// << " faces:" << cFaces << nl
|
// << " faces:" << cFaces << nl
|
||||||
// << " into :" << newCells << endl;
|
// << " into :" << newCells << endl;
|
||||||
|
|||||||
@ -624,7 +624,7 @@ int main(int argc, char *argv[])
|
|||||||
}
|
}
|
||||||
|
|
||||||
// Not implemented yet:
|
// Not implemented yet:
|
||||||
//cutter.updateMesh(morphMap());
|
// cutter.updateMesh(morphMap());
|
||||||
|
|
||||||
|
|
||||||
if (!overwrite)
|
if (!overwrite)
|
||||||
|
|||||||
@ -662,7 +662,7 @@ int main(int argc, char *argv[])
|
|||||||
{
|
{
|
||||||
if (cuts.cellLoops()[celli].size())
|
if (cuts.cellLoops()[celli].size())
|
||||||
{
|
{
|
||||||
//Info<< "Removing cut cell " << celli << " from wishlist"
|
// Info<< "Removing cut cell " << celli << " from wishlist"
|
||||||
// << endl;
|
// << endl;
|
||||||
cellsToCut.erase(celli);
|
cellsToCut.erase(celli);
|
||||||
}
|
}
|
||||||
|
|||||||
@ -204,12 +204,12 @@ void ReadVertices
|
|||||||
);
|
);
|
||||||
CCMIOReadMap(&err, mapID, mapData.begin(), offset, offsetPlusSize);
|
CCMIOReadMap(&err, mapID, mapData.begin(), offset, offsetPlusSize);
|
||||||
|
|
||||||
//CCMIOSize size;
|
// CCMIOSize size;
|
||||||
//CCMIOEntityDescription(&err, vertices, &size, nullptr);
|
// CCMIOEntityDescription(&err, vertices, &size, nullptr);
|
||||||
//char *desc = new char[size + 1];
|
// char *desc = new char[size + 1];
|
||||||
//CCMIOEntityDescription(&err, vertices, nullptr, desc);
|
// CCMIOEntityDescription(&err, vertices, nullptr, desc);
|
||||||
//Pout<< "label: '" << desc << "'" << endl;
|
// Pout<< "label: '" << desc << "'" << endl;
|
||||||
//delete [] desc;
|
// delete [] desc;
|
||||||
|
|
||||||
// Convert to foamPoints
|
// Convert to foamPoints
|
||||||
foamPoints.setSize(nVertices);
|
foamPoints.setSize(nVertices);
|
||||||
@ -336,7 +336,7 @@ void ReadProblem
|
|||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
//foamPatchMap.append(prostarI);
|
// foamPatchMap.append(prostarI);
|
||||||
|
|
||||||
|
|
||||||
// Read boundary name:
|
// Read boundary name:
|
||||||
|
|||||||
@ -666,7 +666,7 @@ endOfSection {space}")"{space}
|
|||||||
}
|
}
|
||||||
|
|
||||||
<readZoneBlock>{lbrac} {
|
<readZoneBlock>{lbrac} {
|
||||||
//Warning
|
// Warning
|
||||||
// << "Found unknown block in zone: " << YYText() << nl
|
// << "Found unknown block in zone: " << YYText() << nl
|
||||||
// << " on line " << lineNo << endl;
|
// << " on line " << lineNo << endl;
|
||||||
yy_push_state(ignoreBlock);
|
yy_push_state(ignoreBlock);
|
||||||
@ -916,7 +916,7 @@ int main(int argc, char *argv[])
|
|||||||
// It is ok if the periodics are already ordered. We should read the
|
// It is ok if the periodics are already ordered. We should read the
|
||||||
// periodic shadow faces section (section 18) to give use the ordering
|
// periodic shadow faces section (section 18) to give use the ordering
|
||||||
// For now just disable.
|
// For now just disable.
|
||||||
//fluentToFoamType.insert("periodic", cyclicPolyPatch::typeName);
|
// fluentToFoamType.insert("periodic", cyclicPolyPatch::typeName);
|
||||||
|
|
||||||
|
|
||||||
// Foam patch type for Fluent zone type
|
// Foam patch type for Fluent zone type
|
||||||
@ -1389,13 +1389,13 @@ int main(int argc, char *argv[])
|
|||||||
faces[facei],
|
faces[facei],
|
||||||
owner[facei],
|
owner[facei],
|
||||||
neighbour[facei],
|
neighbour[facei],
|
||||||
-1, //masterPointID
|
-1, // masterPointID
|
||||||
-1, //masterEdgeID
|
-1, // masterEdgeID
|
||||||
facei, //masterFace
|
facei, // masterFace
|
||||||
false, //flipFaceFlux
|
false, // flipFaceFlux
|
||||||
-1, //patchID
|
-1, // patchID
|
||||||
-1, //zoneID
|
-1, // zoneID
|
||||||
false //zoneFlip
|
false // zoneFlip
|
||||||
);
|
);
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|||||||
@ -1151,7 +1151,7 @@ int main(int argc, char *argv[])
|
|||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
//make patchless mesh before analysing boundaries
|
// make patchless mesh before analysing boundaries
|
||||||
|
|
||||||
faceListList patches(0);
|
faceListList patches(0);
|
||||||
wordList patchNames(0);
|
wordList patchNames(0);
|
||||||
@ -1191,9 +1191,9 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
|
|
||||||
Info<< endl << "Building boundary and internal patches." << endl;
|
Info<< endl << "Building boundary and internal patches." << endl;
|
||||||
//adding patches after mesh construction allows topological checks
|
// adding patches after mesh construction allows topological checks
|
||||||
//on whether a patch is internal or external, something fluent
|
// on whether a patch is internal or external, something fluent
|
||||||
//doesn't seem to mind
|
// doesn't seem to mind
|
||||||
|
|
||||||
// Make boundary patches
|
// Make boundary patches
|
||||||
|
|
||||||
@ -1223,7 +1223,7 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
label nPatches = 0;
|
label nPatches = 0;
|
||||||
|
|
||||||
//colate information for all patches (internal and external)
|
// colate information for all patches (internal and external)
|
||||||
for
|
for
|
||||||
(
|
(
|
||||||
;
|
;
|
||||||
@ -1271,7 +1271,7 @@ int main(int argc, char *argv[])
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
//inlets and outlets
|
// inlets and outlets
|
||||||
if
|
if
|
||||||
(
|
(
|
||||||
curPatchType == "pressure"
|
curPatchType == "pressure"
|
||||||
@ -1293,7 +1293,7 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
nPatches++;
|
nPatches++;
|
||||||
}
|
}
|
||||||
else if (curPatchType == "wall" ) //wall boundaries
|
else if (curPatchType == "wall" ) // wall boundaries
|
||||||
{
|
{
|
||||||
patches[nPatches] = patchFaces;
|
patches[nPatches] = patchFaces;
|
||||||
patchTypes[nPatches] = wallPolyPatch::typeName;
|
patchTypes[nPatches] = wallPolyPatch::typeName;
|
||||||
@ -1305,7 +1305,7 @@ int main(int argc, char *argv[])
|
|||||||
(
|
(
|
||||||
curPatchType == "symmetry"
|
curPatchType == "symmetry"
|
||||||
|| curPatchType == "axis"
|
|| curPatchType == "axis"
|
||||||
) //symmetry planes
|
) // symmetry planes
|
||||||
{
|
{
|
||||||
patches[nPatches] = patchFaces;
|
patches[nPatches] = patchFaces;
|
||||||
patchTypes[nPatches] = symmetryPolyPatch::typeName;
|
patchTypes[nPatches] = symmetryPolyPatch::typeName;
|
||||||
@ -1322,7 +1322,7 @@ int main(int argc, char *argv[])
|
|||||||
|| curPatchType == "fan"
|
|| curPatchType == "fan"
|
||||||
|| curPatchType == "radiator"
|
|| curPatchType == "radiator"
|
||||||
|| curPatchType == "porous-jump"
|
|| curPatchType == "porous-jump"
|
||||||
) //interior boundaries - will not be added as patches
|
) // interior boundaries - will not be added as patches
|
||||||
{
|
{
|
||||||
patches[nPatches] = patchFaces;
|
patches[nPatches] = patchFaces;
|
||||||
patchTypes[nPatches] = "internal";
|
patchTypes[nPatches] = "internal";
|
||||||
@ -1333,7 +1333,7 @@ int main(int argc, char *argv[])
|
|||||||
else if
|
else if
|
||||||
(
|
(
|
||||||
curPatchType == ""
|
curPatchType == ""
|
||||||
) //unnamed face regions default to interior patches
|
) // unnamed face regions default to interior patches
|
||||||
{
|
{
|
||||||
Info<< "Patch " << faceGroupZoneIDIter()
|
Info<< "Patch " << faceGroupZoneIDIter()
|
||||||
<< ": Faces are defined but "
|
<< ": Faces are defined but "
|
||||||
@ -1347,7 +1347,7 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
nPatches++;
|
nPatches++;
|
||||||
}
|
}
|
||||||
else //unknown face regions are not handled
|
else // unknown face regions are not handled
|
||||||
{
|
{
|
||||||
FatalErrorInFunction
|
FatalErrorInFunction
|
||||||
<< "fluent patch type " << curPatchType << " not recognised."
|
<< "fluent patch type " << curPatchType << " not recognised."
|
||||||
@ -1355,7 +1355,7 @@ int main(int argc, char *argv[])
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
//add front and back boundaries for 2D meshes
|
// add front and back boundaries for 2D meshes
|
||||||
if (dimensionOfGrid == 2)
|
if (dimensionOfGrid == 2)
|
||||||
{
|
{
|
||||||
Info<< "Creating patch for front and back planes" << endl << endl;
|
Info<< "Creating patch for front and back planes" << endl << endl;
|
||||||
@ -1367,16 +1367,16 @@ int main(int argc, char *argv[])
|
|||||||
nPatches++;
|
nPatches++;
|
||||||
}
|
}
|
||||||
|
|
||||||
//Now have all patch information,
|
// Now have all patch information,
|
||||||
//check whether each patch is internal or external
|
// check whether each patch is internal or external
|
||||||
//and add boundaries to mesh
|
// and add boundaries to mesh
|
||||||
//also write face sets of all patches
|
// also write face sets of all patches
|
||||||
patches.setSize(nPatches);
|
patches.setSize(nPatches);
|
||||||
patchTypes.setSize(nPatches);
|
patchTypes.setSize(nPatches);
|
||||||
patchNames.setSize(nPatches);
|
patchNames.setSize(nPatches);
|
||||||
|
|
||||||
|
|
||||||
//old polyBoundary
|
// old polyBoundary
|
||||||
const polyBoundaryMesh& oPatches = pShapeMesh.boundaryMesh();
|
const polyBoundaryMesh& oPatches = pShapeMesh.boundaryMesh();
|
||||||
// new patches.
|
// new patches.
|
||||||
DynamicList<polyPatch*> newPatches(nPatches);
|
DynamicList<polyPatch*> newPatches(nPatches);
|
||||||
@ -1403,12 +1403,12 @@ int main(int argc, char *argv[])
|
|||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
//check if patch is internal
|
// check if patch is internal
|
||||||
//also check internal/external-ness of first patch face
|
// also check internal/external-ness of first patch face
|
||||||
//internal faces cannot become foam boundaries
|
// internal faces cannot become foam boundaries
|
||||||
//if a face is defined as internal but is actually external
|
// if a face is defined as internal but is actually external
|
||||||
//it will be put in a default wall boundary
|
// it will be put in a default wall boundary
|
||||||
//internal boundaries are simply ignored
|
// internal boundaries are simply ignored
|
||||||
|
|
||||||
if
|
if
|
||||||
(
|
(
|
||||||
@ -1416,10 +1416,10 @@ int main(int argc, char *argv[])
|
|||||||
&& !pShapeMesh.isInternalFace(meshFaces[0])
|
&& !pShapeMesh.isInternalFace(meshFaces[0])
|
||||||
)
|
)
|
||||||
{
|
{
|
||||||
//first face is external and has valid non-internal type
|
// first face is external and has valid non-internal type
|
||||||
|
|
||||||
//check all faces for externalness just to be sure
|
// check all faces for externalness just to be sure
|
||||||
//and mark patch number to global list
|
// and mark patch number to global list
|
||||||
forAll(meshFaces, i)
|
forAll(meshFaces, i)
|
||||||
{
|
{
|
||||||
label facei = meshFaces[i];
|
label facei = meshFaces[i];
|
||||||
@ -1446,7 +1446,7 @@ int main(int argc, char *argv[])
|
|||||||
facePatchID[facei - pShapeMesh.nInternalFaces()] = nBoundaries;
|
facePatchID[facei - pShapeMesh.nInternalFaces()] = nBoundaries;
|
||||||
}
|
}
|
||||||
|
|
||||||
//add to boundary patch
|
// add to boundary patch
|
||||||
|
|
||||||
Info<< "Adding new patch " << patchNames[patchi]
|
Info<< "Adding new patch " << patchNames[patchi]
|
||||||
<< " of type " << patchTypes[patchi]
|
<< " of type " << patchTypes[patchi]
|
||||||
|
|||||||
@ -1001,7 +1001,7 @@ int main(int argc, char *argv[])
|
|||||||
Info<< endl;
|
Info<< endl;
|
||||||
|
|
||||||
|
|
||||||
//Get polyMesh to write to constant
|
// Get polyMesh to write to constant
|
||||||
|
|
||||||
runTime.setTime(instant(runTime.constant()), 0);
|
runTime.setTime(instant(runTime.constant()), 0);
|
||||||
|
|
||||||
|
|||||||
@ -683,7 +683,7 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
|
|
||||||
// Switch on additional debug info
|
// Switch on additional debug info
|
||||||
const bool verbose = false; //true;
|
const bool verbose = false; // true;
|
||||||
|
|
||||||
// Unit scale factors
|
// Unit scale factors
|
||||||
scalar lengthScale = 1;
|
scalar lengthScale = 1;
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -44,7 +44,7 @@ void Foam::sammMesh::fillSammCellShapeTable()
|
|||||||
sammShapeLookup[64] = sammTrim1Ptr_;
|
sammShapeLookup[64] = sammTrim1Ptr_;
|
||||||
sammShapeLookup[128] = sammTrim1Ptr_;
|
sammShapeLookup[128] = sammTrim1Ptr_;
|
||||||
|
|
||||||
//SAMM trim type 2: 12 models
|
// SAMM trim type 2: 12 models
|
||||||
sammShapeLookup[3] = sammTrim2Ptr_;
|
sammShapeLookup[3] = sammTrim2Ptr_;
|
||||||
sammShapeLookup[12] = sammTrim2Ptr_;
|
sammShapeLookup[12] = sammTrim2Ptr_;
|
||||||
sammShapeLookup[192] = sammTrim2Ptr_;
|
sammShapeLookup[192] = sammTrim2Ptr_;
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -171,7 +171,7 @@ void Foam::sammMesh::readBoundary()
|
|||||||
pointLabels[2] == pointLabels[3]
|
pointLabels[2] == pointLabels[3]
|
||||||
)
|
)
|
||||||
{
|
{
|
||||||
//Info<< "Converting collapsed quad into triangle"
|
// Info<< "Converting collapsed quad into triangle"
|
||||||
// << " for face " << facei
|
// << " for face " << facei
|
||||||
// << " in Samm boundary " << lineIndex << endl;
|
// << " in Samm boundary " << lineIndex << endl;
|
||||||
|
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -169,7 +169,7 @@ void Foam::starMesh::readBoundary()
|
|||||||
pointLabels[2] == pointLabels[3]
|
pointLabels[2] == pointLabels[3]
|
||||||
)
|
)
|
||||||
{
|
{
|
||||||
//Info<< "Converting collapsed quad into triangle"
|
// Info<< "Converting collapsed quad into triangle"
|
||||||
// << " for face " << facei
|
// << " for face " << facei
|
||||||
// << " in Star boundary " << lineIndex << endl;
|
// << " in Star boundary " << lineIndex << endl;
|
||||||
|
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -243,7 +243,7 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
forAll(cellCentres, celli)
|
forAll(cellCentres, celli)
|
||||||
{
|
{
|
||||||
//point cc = b.blockShape().centre(b.points());
|
// point cc = b.blockShape().centre(b.points());
|
||||||
const point& cc = cellCentres[celli];
|
const point& cc = cellCentres[celli];
|
||||||
|
|
||||||
str << "v " << cc.x() << ' ' << cc.y() << ' ' << cc.z() << nl;
|
str << "v " << cc.x() << ' ' << cc.y() << ' ' << cc.z() << nl;
|
||||||
|
|||||||
@ -810,7 +810,7 @@ void addCouplingPatches
|
|||||||
<< '\t' << newPatches[interRegionBottomPatch[zoneI]]->type()
|
<< '\t' << newPatches[interRegionBottomPatch[zoneI]]->type()
|
||||||
<< nl;
|
<< nl;
|
||||||
}
|
}
|
||||||
else //patch using shadow face zones.
|
else // patch using shadow face zones.
|
||||||
{
|
{
|
||||||
interRegionTopPatch[zoneI] = addPatch<mappedWallPolyPatch>
|
interRegionTopPatch[zoneI] = addPatch<mappedWallPolyPatch>
|
||||||
(
|
(
|
||||||
@ -1256,7 +1256,7 @@ void extrudeGeometricProperties
|
|||||||
)
|
)
|
||||||
);
|
);
|
||||||
|
|
||||||
//forAll(extrudePatch.edges(), edgeI)
|
// forAll(extrudePatch.edges(), edgeI)
|
||||||
//{
|
//{
|
||||||
// const edge& e = extrudePatch.edges()[edgeI];
|
// const edge& e = extrudePatch.edges()[edgeI];
|
||||||
// Pout<< "Edge:" << e.centre(extrudePatch.localPoints()) << nl
|
// Pout<< "Edge:" << e.centre(extrudePatch.localPoints()) << nl
|
||||||
@ -1599,49 +1599,49 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
|
|
||||||
//// Read objects in time directory
|
//// Read objects in time directory
|
||||||
//IOobjectList objects(mesh, runTime.timeName());
|
// IOobjectList objects(mesh, runTime.timeName());
|
||||||
//
|
//
|
||||||
//// Read vol fields.
|
//// Read vol fields.
|
||||||
//
|
//
|
||||||
//PtrList<volScalarField> vsFlds;
|
// PtrList<volScalarField> vsFlds;
|
||||||
//ReadFields(mesh, objects, vsFlds);
|
// ReadFields(mesh, objects, vsFlds);
|
||||||
//
|
//
|
||||||
//PtrList<volVectorField> vvFlds;
|
// PtrList<volVectorField> vvFlds;
|
||||||
//ReadFields(mesh, objects, vvFlds);
|
// ReadFields(mesh, objects, vvFlds);
|
||||||
//
|
//
|
||||||
//PtrList<volSphericalTensorField> vstFlds;
|
// PtrList<volSphericalTensorField> vstFlds;
|
||||||
//ReadFields(mesh, objects, vstFlds);
|
// ReadFields(mesh, objects, vstFlds);
|
||||||
//
|
//
|
||||||
//PtrList<volSymmTensorField> vsymtFlds;
|
// PtrList<volSymmTensorField> vsymtFlds;
|
||||||
//ReadFields(mesh, objects, vsymtFlds);
|
// ReadFields(mesh, objects, vsymtFlds);
|
||||||
//
|
//
|
||||||
//PtrList<volTensorField> vtFlds;
|
// PtrList<volTensorField> vtFlds;
|
||||||
//ReadFields(mesh, objects, vtFlds);
|
// ReadFields(mesh, objects, vtFlds);
|
||||||
//
|
//
|
||||||
//// Read surface fields.
|
//// Read surface fields.
|
||||||
//
|
//
|
||||||
//PtrList<surfaceScalarField> ssFlds;
|
// PtrList<surfaceScalarField> ssFlds;
|
||||||
//ReadFields(mesh, objects, ssFlds);
|
// ReadFields(mesh, objects, ssFlds);
|
||||||
//
|
//
|
||||||
//PtrList<surfaceVectorField> svFlds;
|
// PtrList<surfaceVectorField> svFlds;
|
||||||
//ReadFields(mesh, objects, svFlds);
|
// ReadFields(mesh, objects, svFlds);
|
||||||
//
|
//
|
||||||
//PtrList<surfaceSphericalTensorField> sstFlds;
|
// PtrList<surfaceSphericalTensorField> sstFlds;
|
||||||
//ReadFields(mesh, objects, sstFlds);
|
// ReadFields(mesh, objects, sstFlds);
|
||||||
//
|
//
|
||||||
//PtrList<surfaceSymmTensorField> ssymtFlds;
|
// PtrList<surfaceSymmTensorField> ssymtFlds;
|
||||||
//ReadFields(mesh, objects, ssymtFlds);
|
// ReadFields(mesh, objects, ssymtFlds);
|
||||||
//
|
//
|
||||||
//PtrList<surfaceTensorField> stFlds;
|
// PtrList<surfaceTensorField> stFlds;
|
||||||
//ReadFields(mesh, objects, stFlds);
|
// ReadFields(mesh, objects, stFlds);
|
||||||
//
|
//
|
||||||
//// Read point fields.
|
//// Read point fields.
|
||||||
//
|
//
|
||||||
//PtrList<pointScalarField> psFlds;
|
// PtrList<pointScalarField> psFlds;
|
||||||
//ReadFields(pointMesh::New(mesh), objects, psFlds);
|
// ReadFields(pointMesh::New(mesh), objects, psFlds);
|
||||||
//
|
//
|
||||||
//PtrList<pointVectorField> pvFlds;
|
// PtrList<pointVectorField> pvFlds;
|
||||||
//ReadFields(pointMesh::New(mesh), objects, pvFlds);
|
// ReadFields(pointMesh::New(mesh), objects, pvFlds);
|
||||||
|
|
||||||
|
|
||||||
|
|
||||||
@ -2136,12 +2136,12 @@ int main(int argc, char *argv[])
|
|||||||
// << " name:" << newPatches[patchi]->name()
|
// << " name:" << newPatches[patchi]->name()
|
||||||
// << endl;
|
// << endl;
|
||||||
// }
|
// }
|
||||||
// //label nOldPatches = mesh.boundary().size();
|
// // label nOldPatches = mesh.boundary().size();
|
||||||
// mesh.clearOut();
|
// mesh.clearOut();
|
||||||
// mesh.removeFvBoundary();
|
// mesh.removeFvBoundary();
|
||||||
// mesh.addFvPatches(newPatches, true);
|
// mesh.addFvPatches(newPatches, true);
|
||||||
// //// Add calculated fvPatchFields for the added patches
|
// //// Add calculated fvPatchFields for the added patches
|
||||||
// //for
|
// // for
|
||||||
// //(
|
// //(
|
||||||
// // label patchi = nOldPatches;
|
// // label patchi = nOldPatches;
|
||||||
// // patchi < mesh.boundary().size();
|
// // patchi < mesh.boundary().size();
|
||||||
@ -2152,7 +2152,7 @@ int main(int argc, char *argv[])
|
|||||||
// // << endl;
|
// // << endl;
|
||||||
// // addCalculatedPatchFields(mesh);
|
// // addCalculatedPatchFields(mesh);
|
||||||
// //}
|
// //}
|
||||||
// //Pout<< "** Added " << mesh.boundary().size()-nOldPatches
|
// // Pout<< "** Added " << mesh.boundary().size()-nOldPatches
|
||||||
// // << " patches." << endl;
|
// // << " patches." << endl;
|
||||||
// }
|
// }
|
||||||
|
|
||||||
@ -2368,7 +2368,7 @@ int main(int argc, char *argv[])
|
|||||||
vectorField firstDisp(localRegionNormals.size());
|
vectorField firstDisp(localRegionNormals.size());
|
||||||
forAll(firstDisp, regionI)
|
forAll(firstDisp, regionI)
|
||||||
{
|
{
|
||||||
//const point& regionPt = regionCentres[regionI];
|
// const point& regionPt = regionCentres[regionI];
|
||||||
const point& regionPt = extrudePatch.points()
|
const point& regionPt = extrudePatch.points()
|
||||||
[
|
[
|
||||||
extrudePatch.meshPoints()
|
extrudePatch.meshPoints()
|
||||||
@ -2724,7 +2724,7 @@ int main(int argc, char *argv[])
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
if (zoneShadowNames.size() > 0) //if there is a top faceZone specified
|
if (zoneShadowNames.size() > 0) // if there is a top faceZone specified
|
||||||
{
|
{
|
||||||
forAll(extrudeMeshFaces, zoneFacei)
|
forAll(extrudeMeshFaces, zoneFacei)
|
||||||
{
|
{
|
||||||
@ -2788,7 +2788,7 @@ int main(int argc, char *argv[])
|
|||||||
true, // flip flux
|
true, // flip flux
|
||||||
interMeshTopPatch[zoneI], // patch for face
|
interMeshTopPatch[zoneI], // patch for face
|
||||||
-1, // zone for face
|
-1, // zone for face
|
||||||
false //face flip in zone
|
false // face flip in zone
|
||||||
);
|
);
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|||||||
@ -49,7 +49,7 @@ sampleMode nearestPatchFace;
|
|||||||
oneD false;
|
oneD false;
|
||||||
|
|
||||||
//- If oneD: specify which boundary is wanted between the layers
|
//- If oneD: specify which boundary is wanted between the layers
|
||||||
//oneDPolyPatchType empty; //wedge
|
// oneDPolyPatchType empty; // wedge
|
||||||
|
|
||||||
//- If oneD: specify whether to duplicate points (i.e. disconnect 1D
|
//- If oneD: specify whether to duplicate points (i.e. disconnect 1D
|
||||||
// columns) or only on non-manifold extrusion areas. Default is false.
|
// columns) or only on non-manifold extrusion areas. Default is false.
|
||||||
|
|||||||
@ -88,7 +88,7 @@ Foam::extrude2DMesh::extrude2DMesh
|
|||||||
:
|
:
|
||||||
mesh_(mesh),
|
mesh_(mesh),
|
||||||
dict_(dict),
|
dict_(dict),
|
||||||
//patchDict_(dict.subDict("patchInfo")),
|
// patchDict_(dict.subDict("patchInfo")),
|
||||||
model_(model),
|
model_(model),
|
||||||
modelType_(dict.lookup("extrudeModel")),
|
modelType_(dict.lookup("extrudeModel")),
|
||||||
patchType_(dict.lookup("patchType")),
|
patchType_(dict.lookup("patchType")),
|
||||||
@ -209,11 +209,11 @@ void Foam::extrude2DMesh::setRefinement
|
|||||||
{
|
{
|
||||||
meshMod.addCell
|
meshMod.addCell
|
||||||
(
|
(
|
||||||
-1, //masterPointID,
|
-1, // masterPointID,
|
||||||
-1, //masterEdgeID,
|
-1, // masterEdgeID,
|
||||||
-1, //masterFaceID,
|
-1, // masterFaceID,
|
||||||
celli + offset, //masterCellID,
|
celli + offset, // masterCellID,
|
||||||
mesh_.cellZones().whichZone(celli) //zoneID
|
mesh_.cellZones().whichZone(celli) // zoneID
|
||||||
);
|
);
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -68,7 +68,7 @@ class extrude2DMesh
|
|||||||
|
|
||||||
const dictionary dict_;
|
const dictionary dict_;
|
||||||
|
|
||||||
//const dictionary patchDict_;
|
// const dictionary patchDict_;
|
||||||
|
|
||||||
const extrudeModel& model_;
|
const extrudeModel& model_;
|
||||||
|
|
||||||
@ -85,7 +85,7 @@ class extrude2DMesh
|
|||||||
void check2D() const;
|
void check2D() const;
|
||||||
|
|
||||||
//- Find extrusion direction
|
//- Find extrusion direction
|
||||||
//void findExtrudeDirection();
|
// void findExtrudeDirection();
|
||||||
|
|
||||||
//- Disallow default bitwise copy construct
|
//- Disallow default bitwise copy construct
|
||||||
extrude2DMesh(const extrude2DMesh&);
|
extrude2DMesh(const extrude2DMesh&);
|
||||||
|
|||||||
@ -1074,7 +1074,7 @@ bool Foam::backgroundMeshDecomposition::overlapsThisProcessor
|
|||||||
const scalar radiusSqr
|
const scalar radiusSqr
|
||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
//return bFTreePtr_().findAnyOverlap(centre, radiusSqr);
|
// return bFTreePtr_().findAnyOverlap(centre, radiusSqr);
|
||||||
|
|
||||||
return bFTreePtr_().findNearest(centre, radiusSqr).hit();
|
return bFTreePtr_().findNearest(centre, radiusSqr).hit();
|
||||||
}
|
}
|
||||||
@ -1448,7 +1448,7 @@ Foam::labelList Foam::backgroundMeshDecomposition::overlapProcessors
|
|||||||
////
|
////
|
||||||
//// if (flagOverlap)
|
//// if (flagOverlap)
|
||||||
//// {
|
//// {
|
||||||
//// //if (vertexOctree.findAnyOverlap(c, rSqr))
|
//// // if (vertexOctree.findAnyOverlap(c, rSqr))
|
||||||
////// if (vertexOctree.findNearest(c, rSqr*1.001).hit())
|
////// if (vertexOctree.findNearest(c, rSqr*1.001).hit())
|
||||||
////// {
|
////// {
|
||||||
////// sphereOverlapsCandidate[sI] = true;
|
////// sphereOverlapsCandidate[sI] = true;
|
||||||
@ -1565,7 +1565,7 @@ Foam::labelList Foam::backgroundMeshDecomposition::overlapProcessors
|
|||||||
//
|
//
|
||||||
// if (flagOverlap)
|
// if (flagOverlap)
|
||||||
// {
|
// {
|
||||||
// //if (vertexOctree.findAnyOverlap(c, rSqr))
|
// // if (vertexOctree.findAnyOverlap(c, rSqr))
|
||||||
//// if (vertexOctree.findNearest(c, rSqr*1.001).hit())
|
//// if (vertexOctree.findNearest(c, rSqr*1.001).hit())
|
||||||
//// {
|
//// {
|
||||||
//// sphereOverlapsCandidate[sI] = true;
|
//// sphereOverlapsCandidate[sI] = true;
|
||||||
|
|||||||
@ -95,7 +95,7 @@ class backgroundMeshDecomposition
|
|||||||
// Private data
|
// Private data
|
||||||
|
|
||||||
//- Method details dictionary
|
//- Method details dictionary
|
||||||
//dictionary coeffsDict_;
|
// dictionary coeffsDict_;
|
||||||
|
|
||||||
//- Reference to runtime
|
//- Reference to runtime
|
||||||
const Time& runTime_;
|
const Time& runTime_;
|
||||||
|
|||||||
@ -142,7 +142,7 @@ word cellShapeControlMesh::meshSubDir = "cellShapeControlMesh";
|
|||||||
// }
|
// }
|
||||||
// }
|
// }
|
||||||
//
|
//
|
||||||
// //external spoke
|
// // external spoke
|
||||||
//
|
//
|
||||||
// Foam::point mirrorPt = pt + 2*d;
|
// Foam::point mirrorPt = pt + 2*d;
|
||||||
//
|
//
|
||||||
@ -769,17 +769,17 @@ Foam::label Foam::cellShapeControlMesh::estimateCellCount
|
|||||||
scalar volume = CGAL::to_double(tet.volume());
|
scalar volume = CGAL::to_double(tet.volume());
|
||||||
|
|
||||||
scalar averagedPointCellSize = 0;
|
scalar averagedPointCellSize = 0;
|
||||||
//scalar averagedPointCellSize = 1;
|
// scalar averagedPointCellSize = 1;
|
||||||
|
|
||||||
// Get an average volume by averaging the cell size of the vertices
|
// Get an average volume by averaging the cell size of the vertices
|
||||||
for (label vI = 0; vI < 4; ++vI)
|
for (label vI = 0; vI < 4; ++vI)
|
||||||
{
|
{
|
||||||
averagedPointCellSize += cit->vertex(vI)->targetCellSize();
|
averagedPointCellSize += cit->vertex(vI)->targetCellSize();
|
||||||
//averagedPointCellSize *= cit->vertex(vI)->targetCellSize();
|
// averagedPointCellSize *= cit->vertex(vI)->targetCellSize();
|
||||||
}
|
}
|
||||||
|
|
||||||
averagedPointCellSize /= 4;
|
averagedPointCellSize /= 4;
|
||||||
//averagedPointCellSize = ::sqrt(averagedPointCellSize);
|
// averagedPointCellSize = ::sqrt(averagedPointCellSize);
|
||||||
|
|
||||||
// if (averagedPointCellSize < small)
|
// if (averagedPointCellSize < small)
|
||||||
// {
|
// {
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -122,7 +122,7 @@ Foam::fileControl::~fileControl()
|
|||||||
// tensor alignment = Zero;
|
// tensor alignment = Zero;
|
||||||
// forAll(bary, pI)
|
// forAll(bary, pI)
|
||||||
// {
|
// {
|
||||||
// //alignment += bary[pI]*ch->vertex(pI)->alignment();
|
// // alignment += bary[pI]*ch->vertex(pI)->alignment();
|
||||||
//
|
//
|
||||||
// // Find nearest point
|
// // Find nearest point
|
||||||
// if (bary[pI] > nearest)
|
// if (bary[pI] > nearest)
|
||||||
|
|||||||
@ -429,7 +429,7 @@ void Foam::controlMeshRefinement::initialMeshPopulation
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
//mesh_.rangeInsertWithInfo(vertices.begin(), vertices.end());
|
// mesh_.rangeInsertWithInfo(vertices.begin(), vertices.end());
|
||||||
|
|
||||||
Info<< " Inserted "
|
Info<< " Inserted "
|
||||||
<< returnReduce
|
<< returnReduce
|
||||||
@ -623,7 +623,7 @@ void Foam::controlMeshRefinement::initialMeshPopulation
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
//mesh_.rangeInsertWithInfo(vertices.begin(), vertices.end());
|
// mesh_.rangeInsertWithInfo(vertices.begin(), vertices.end());
|
||||||
|
|
||||||
Info<< " Inserted extra points "
|
Info<< " Inserted extra points "
|
||||||
<< returnReduce
|
<< returnReduce
|
||||||
|
|||||||
@ -272,7 +272,7 @@ Foam::tmp<Foam::triSurfacePointScalarField> Foam::automatic::load()
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
//smoothField(surfaceCellSize);
|
// smoothField(surfaceCellSize);
|
||||||
|
|
||||||
pointCellSize.write();
|
pointCellSize.write();
|
||||||
|
|
||||||
|
|||||||
@ -530,7 +530,7 @@ void Foam::conformalVoronoiMesh::buildCellSizeAndAlignmentMesh()
|
|||||||
for (label i = 0; i < nMaxIter; ++i)
|
for (label i = 0; i < nMaxIter; ++i)
|
||||||
{
|
{
|
||||||
label nAdded = meshRefinement.refineMesh(decomposition_);
|
label nAdded = meshRefinement.refineMesh(decomposition_);
|
||||||
//cellShapeControl_.refineMesh(decomposition_);
|
// cellShapeControl_.refineMesh(decomposition_);
|
||||||
reduce(nAdded, sumOp<label>());
|
reduce(nAdded, sumOp<label>());
|
||||||
|
|
||||||
if (Pstream::parRun())
|
if (Pstream::parRun())
|
||||||
@ -572,7 +572,7 @@ void Foam::conformalVoronoiMesh::buildCellSizeAndAlignmentMesh()
|
|||||||
|
|
||||||
if (foamyHexMeshControls().writeCellShapeControlMesh())
|
if (foamyHexMeshControls().writeCellShapeControlMesh())
|
||||||
{
|
{
|
||||||
//cellSizeMesh.writeTriangulation();
|
// cellSizeMesh.writeTriangulation();
|
||||||
cellSizeMesh.write();
|
cellSizeMesh.write();
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|||||||
@ -824,7 +824,7 @@ void Foam::conformalVoronoiMesh::checkCellSizing()
|
|||||||
autoPtr<polyMesh> meshPtr = createPolyMeshFromPoints(ptsField);
|
autoPtr<polyMesh> meshPtr = createPolyMeshFromPoints(ptsField);
|
||||||
const polyMesh& pMesh = meshPtr();
|
const polyMesh& pMesh = meshPtr();
|
||||||
|
|
||||||
//pMesh.write();
|
// pMesh.write();
|
||||||
|
|
||||||
// Find cells with poor quality
|
// Find cells with poor quality
|
||||||
DynamicList<label> checkFaces(identity(pMesh.nFaces()));
|
DynamicList<label> checkFaces(identity(pMesh.nFaces()));
|
||||||
@ -921,7 +921,7 @@ void Foam::conformalVoronoiMesh::checkCellSizing()
|
|||||||
Info<< " DISABLED: Automatically re-sizing " << cellsToResize.size()
|
Info<< " DISABLED: Automatically re-sizing " << cellsToResize.size()
|
||||||
<< " cells that are attached to the bad faces: " << endl;
|
<< " cells that are attached to the bad faces: " << endl;
|
||||||
|
|
||||||
//cellSizeControl_.setCellSizes(cellsToResize);
|
// cellSizeControl_.setCellSizes(cellsToResize);
|
||||||
}
|
}
|
||||||
|
|
||||||
timeCheck("End of Cell Sizing");
|
timeCheck("End of Cell Sizing");
|
||||||
@ -1291,9 +1291,9 @@ void Foam::conformalVoronoiMesh::indexDualVertices
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
//OBJstream snapping1("snapToSurface1.obj");
|
// OBJstream snapping1("snapToSurface1.obj");
|
||||||
//OBJstream snapping2("snapToSurface2.obj");
|
// OBJstream snapping2("snapToSurface2.obj");
|
||||||
//OFstream tetToSnapTo("tetsToSnapTo.obj");
|
// OFstream tetToSnapTo("tetsToSnapTo.obj");
|
||||||
|
|
||||||
for
|
for
|
||||||
(
|
(
|
||||||
@ -1490,9 +1490,9 @@ void Foam::conformalVoronoiMesh::indexDualVertices
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
//pts.setSize(this->cellCount());
|
// pts.setSize(this->cellCount());
|
||||||
|
|
||||||
//boundaryPts.setSize(this->cellCount());
|
// boundaryPts.setSize(this->cellCount());
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
|
|||||||
@ -389,7 +389,7 @@ void Foam::conformalVoronoiMesh::buildSurfaceConformation()
|
|||||||
// Re-index the point pairs
|
// Re-index the point pairs
|
||||||
ptPairs_.reIndex(oldToNewIndices);
|
ptPairs_.reIndex(oldToNewIndices);
|
||||||
|
|
||||||
//writePointPairs("pointPairs_initial.obj");
|
// writePointPairs("pointPairs_initial.obj");
|
||||||
|
|
||||||
// Remove location from surface/edge tree
|
// Remove location from surface/edge tree
|
||||||
|
|
||||||
@ -630,7 +630,7 @@ void Foam::conformalVoronoiMesh::buildSurfaceConformation()
|
|||||||
// Reindex the point pairs
|
// Reindex the point pairs
|
||||||
ptPairs_.reIndex(oldToNewIndices);
|
ptPairs_.reIndex(oldToNewIndices);
|
||||||
|
|
||||||
//writePointPairs("pointPairs_" + name(iterationNo) + ".obj");
|
// writePointPairs("pointPairs_" + name(iterationNo) + ".obj");
|
||||||
|
|
||||||
if (Pstream::parRun())
|
if (Pstream::parRun())
|
||||||
{
|
{
|
||||||
@ -1955,8 +1955,8 @@ bool Foam::conformalVoronoiMesh::nearFeatureEdgeLocation
|
|||||||
&& (mag(lineBetweenPoints) > pointPairDistance(pt))
|
&& (mag(lineBetweenPoints) > pointPairDistance(pt))
|
||||||
)
|
)
|
||||||
{
|
{
|
||||||
//pt = edgeHit.hitPoint();
|
// pt = edgeHit.hitPoint();
|
||||||
//pHit.setPoint(pt);
|
// pHit.setPoint(pt);
|
||||||
closeToFeatureEdge = false;
|
closeToFeatureEdge = false;
|
||||||
}
|
}
|
||||||
else
|
else
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -432,8 +432,8 @@ Foam::autoPtr<Foam::fvMesh> Foam::conformalVoronoiMesh::createDummyMesh
|
|||||||
{
|
{
|
||||||
patches[patchi] = new processorPolyPatch
|
patches[patchi] = new processorPolyPatch
|
||||||
(
|
(
|
||||||
0, //patchSizes[p],
|
0, // patchSizes[p],
|
||||||
0, //patchStarts[p],
|
0, // patchStarts[p],
|
||||||
patchi,
|
patchi,
|
||||||
mesh.boundaryMesh(),
|
mesh.boundaryMesh(),
|
||||||
readLabel(patchDicts[patchi].lookup("myProcNo")),
|
readLabel(patchDicts[patchi].lookup("myProcNo")),
|
||||||
@ -447,8 +447,8 @@ Foam::autoPtr<Foam::fvMesh> Foam::conformalVoronoiMesh::createDummyMesh
|
|||||||
(
|
(
|
||||||
patchDicts[patchi].lookup("type"),
|
patchDicts[patchi].lookup("type"),
|
||||||
patchNames[patchi],
|
patchNames[patchi],
|
||||||
0, //patchSizes[p],
|
0, // patchSizes[p],
|
||||||
0, //patchStarts[p],
|
0, // patchStarts[p],
|
||||||
patchi,
|
patchi,
|
||||||
mesh.boundaryMesh()
|
mesh.boundaryMesh()
|
||||||
).ptr();
|
).ptr();
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -148,7 +148,7 @@ void Foam::featurePointConformer::addMasterAndSlavePoints
|
|||||||
|
|
||||||
const label masterIndex = pts.last().index();
|
const label masterIndex = pts.last().index();
|
||||||
|
|
||||||
//meshTools::writeOBJ(strMasters, masterPt);
|
// meshTools::writeOBJ(strMasters, masterPt);
|
||||||
|
|
||||||
const planeDynList& masterPointPlanes = masterPointReflections[pI];
|
const planeDynList& masterPointPlanes = masterPointReflections[pI];
|
||||||
|
|
||||||
@ -186,7 +186,7 @@ void Foam::featurePointConformer::addMasterAndSlavePoints
|
|||||||
pts.last().index()
|
pts.last().index()
|
||||||
);
|
);
|
||||||
|
|
||||||
//meshTools::writeOBJ(strSlaves, slavePt);
|
// meshTools::writeOBJ(strSlaves, slavePt);
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
@ -279,7 +279,7 @@ void Foam::featurePointConformer::createMasterAndSlavePoints
|
|||||||
: Vb::vtInternalFeaturePoint // false
|
: Vb::vtInternalFeaturePoint // false
|
||||||
);
|
);
|
||||||
|
|
||||||
//Info<< " " << " " << firstPlane << endl;
|
// Info<< " " << " " << firstPlane << endl;
|
||||||
|
|
||||||
// const Foam::point reflectedPoint = reflectPointInPlane
|
// const Foam::point reflectedPoint = reflectPointInPlane
|
||||||
// (
|
// (
|
||||||
@ -500,7 +500,7 @@ void Foam::featurePointConformer::createFeaturePoints(DynamicList<Vb>& pts)
|
|||||||
{
|
{
|
||||||
for
|
for
|
||||||
(
|
(
|
||||||
//label ptI = feMesh.convexStart();
|
// label ptI = feMesh.convexStart();
|
||||||
label ptI = feMesh.mixedStart();
|
label ptI = feMesh.mixedStart();
|
||||||
ptI < feMesh.nonFeatureStart();
|
ptI < feMesh.nonFeatureStart();
|
||||||
ptI++
|
ptI++
|
||||||
@ -561,7 +561,7 @@ Foam::featurePointConformer::featurePointConformer
|
|||||||
{
|
{
|
||||||
Vb& pt = pts[pI];
|
Vb& pt = pts[pI];
|
||||||
|
|
||||||
//if (pt.featureEdgePoint())
|
// if (pt.featureEdgePoint())
|
||||||
{
|
{
|
||||||
if (pt.internalBoundaryPoint())
|
if (pt.internalBoundaryPoint())
|
||||||
{
|
{
|
||||||
|
|||||||
@ -394,7 +394,7 @@ bool Foam::featurePointConformer::createSpecialisedFeaturePoint
|
|||||||
if (totalAngle > foamyHexMeshControls_.maxQuadAngle())
|
if (totalAngle > foamyHexMeshControls_.maxQuadAngle())
|
||||||
{
|
{
|
||||||
// Add additional mitreing points
|
// Add additional mitreing points
|
||||||
//scalar angleSign = 1.0;
|
// scalar angleSign = 1.0;
|
||||||
|
|
||||||
|
|
||||||
vector convexEdgesPlaneNormal =
|
vector convexEdgesPlaneNormal =
|
||||||
@ -828,7 +828,7 @@ bool Foam::featurePointConformer::createSpecialisedFeaturePoint
|
|||||||
if (totalAngle > foamyHexMeshControls_.maxQuadAngle())
|
if (totalAngle > foamyHexMeshControls_.maxQuadAngle())
|
||||||
{
|
{
|
||||||
// Add additional mitreing points
|
// Add additional mitreing points
|
||||||
//scalar angleSign = 1.0;
|
// scalar angleSign = 1.0;
|
||||||
|
|
||||||
|
|
||||||
vector convexEdgesPlaneNormal =
|
vector convexEdgesPlaneNormal =
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -274,7 +274,7 @@ public:
|
|||||||
{
|
{
|
||||||
return
|
return
|
||||||
(
|
(
|
||||||
//this->point() == rhs.point()
|
// this->point() == rhs.point()
|
||||||
this->type_ == rhs.type()
|
this->type_ == rhs.type()
|
||||||
&& this->index_ == rhs.index()
|
&& this->index_ == rhs.index()
|
||||||
&& this->processor_ == rhs.procIndex()
|
&& this->processor_ == rhs.procIndex()
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2012-2015 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -230,7 +230,7 @@ inline bool CGAL::indexedVertex<Gt, Vb>::referred() const
|
|||||||
{
|
{
|
||||||
// Can't be zero as the first few points are far points which won't be
|
// Can't be zero as the first few points are far points which won't be
|
||||||
// referred
|
// referred
|
||||||
//return index_ < 0;
|
// return index_ < 0;
|
||||||
|
|
||||||
// processor_ will be take the value of the processor that this vertex is
|
// processor_ will be take the value of the processor that this vertex is
|
||||||
// from, so it cannot be on this processor.
|
// from, so it cannot be on this processor.
|
||||||
|
|||||||
@ -558,7 +558,7 @@ Foam::conformationSurfaces::conformationSurfaces
|
|||||||
|
|
||||||
// Extend the global bounds to stop the bound box sitting on the surfaces
|
// Extend the global bounds to stop the bound box sitting on the surfaces
|
||||||
// to be conformed to
|
// to be conformed to
|
||||||
//globalBounds_ = globalBounds_.extend(rndGen_, 1e-4);
|
// globalBounds_ = globalBounds_.extend(rndGen_, 1e-4);
|
||||||
|
|
||||||
vector newSpan = 1e-4*globalBounds_.span();
|
vector newSpan = 1e-4*globalBounds_.span();
|
||||||
|
|
||||||
@ -652,7 +652,7 @@ bool Foam::conformationSurfaces::outside
|
|||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
return wellOutside(pointField(1, samplePt), scalarField(1, 0))[0];
|
return wellOutside(pointField(1, samplePt), scalarField(1, 0))[0];
|
||||||
//return !inside(samplePt);
|
// return !inside(samplePt);
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
@ -693,7 +693,7 @@ Foam::Field<bool> Foam::conformationSurfaces::wellInOutSide
|
|||||||
// Assume that the point is wellInside until demonstrated otherwise.
|
// Assume that the point is wellInside until demonstrated otherwise.
|
||||||
Field<bool> insideOutsidePoint(samplePts.size(), testForInside);
|
Field<bool> insideOutsidePoint(samplePts.size(), testForInside);
|
||||||
|
|
||||||
//Check if the points are inside the surface by the given distance squared
|
// Check if the points are inside the surface by the given distance squared
|
||||||
|
|
||||||
labelList hitSurfaces;
|
labelList hitSurfaces;
|
||||||
List<pointIndexHit> hitInfo;
|
List<pointIndexHit> hitInfo;
|
||||||
@ -1182,9 +1182,9 @@ void Foam::conformationSurfaces::findAllNearestEdges
|
|||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
// Initialise
|
// Initialise
|
||||||
//featuresHit.setSize(features_.size());
|
// featuresHit.setSize(features_.size());
|
||||||
//featuresHit = -1;
|
// featuresHit = -1;
|
||||||
//edgeHitsByFeature.setSize(features_.size());
|
// edgeHitsByFeature.setSize(features_.size());
|
||||||
|
|
||||||
// Work arrays
|
// Work arrays
|
||||||
List<pointIndexHit> hitInfo(extendedFeatureEdgeMesh::nEdgeTypes);
|
List<pointIndexHit> hitInfo(extendedFeatureEdgeMesh::nEdgeTypes);
|
||||||
|
|||||||
@ -89,7 +89,7 @@ scalar rampHoldFall::relaxation()
|
|||||||
}
|
}
|
||||||
else
|
else
|
||||||
{
|
{
|
||||||
//Hold
|
// Hold
|
||||||
|
|
||||||
return holdRelaxation_;
|
return holdRelaxation_;
|
||||||
}
|
}
|
||||||
|
|||||||
@ -179,7 +179,7 @@ surfaceConformation
|
|||||||
// Additional features.
|
// Additional features.
|
||||||
additionalFeatures
|
additionalFeatures
|
||||||
{
|
{
|
||||||
//line
|
// line
|
||||||
//{
|
//{
|
||||||
// featureMethod extendedFeatureEdgeMesh; // or none;
|
// featureMethod extendedFeatureEdgeMesh; // or none;
|
||||||
// extendedFeatureEdgeMesh "line.extendedFeatureEdgeMesh";
|
// extendedFeatureEdgeMesh "line.extendedFeatureEdgeMesh";
|
||||||
@ -309,7 +309,7 @@ motionControl
|
|||||||
// and lowers to 0 (at simulation endTime) to converge points.
|
// and lowers to 0 (at simulation endTime) to converge points.
|
||||||
// adaptiveLinear is preferred choice.
|
// adaptiveLinear is preferred choice.
|
||||||
// Points move by e.g. 10% of tet size.
|
// Points move by e.g. 10% of tet size.
|
||||||
relaxationModel adaptiveLinear; //rampHoldFall
|
relaxationModel adaptiveLinear; // rampHoldFall
|
||||||
|
|
||||||
adaptiveLinearCoeffs
|
adaptiveLinearCoeffs
|
||||||
{
|
{
|
||||||
@ -467,7 +467,7 @@ meshQualityControls
|
|||||||
//- minVolRatio (0 -> 1)
|
//- minVolRatio (0 -> 1)
|
||||||
minVolRatio 0.01;
|
minVolRatio 0.01;
|
||||||
|
|
||||||
//must be >0 for Fluent compatibility
|
// must be >0 for Fluent compatibility
|
||||||
minTriangleTwist -1;
|
minTriangleTwist -1;
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|||||||
@ -562,8 +562,8 @@ int main(int argc, char *argv[])
|
|||||||
autoPtr<mapDistributePolyMesh> map = distributor.distribute(decomp);
|
autoPtr<mapDistributePolyMesh> map = distributor.distribute(decomp);
|
||||||
|
|
||||||
// Print some statistics
|
// Print some statistics
|
||||||
//Info<< "After distribution:" << endl;
|
// Info<< "After distribution:" << endl;
|
||||||
//printMeshData(mesh);
|
// printMeshData(mesh);
|
||||||
|
|
||||||
mesh.setInstance(runTime.constant());
|
mesh.setInstance(runTime.constant());
|
||||||
Info<< "Writing redistributed mesh" << nl << endl;
|
Info<< "Writing redistributed mesh" << nl << endl;
|
||||||
@ -721,8 +721,8 @@ int main(int argc, char *argv[])
|
|||||||
fvm,
|
fvm,
|
||||||
cellDistance,
|
cellDistance,
|
||||||
pointDistance,
|
pointDistance,
|
||||||
0, //distance,
|
0, // distance,
|
||||||
false //regularise
|
false // regularise
|
||||||
);
|
);
|
||||||
|
|
||||||
isoFaces.setSize(iso.size());
|
isoFaces.setSize(iso.size());
|
||||||
|
|||||||
@ -199,14 +199,14 @@ public:
|
|||||||
|
|
||||||
|
|
||||||
////- Surface intersects bb (but not using intersection test)
|
////- Surface intersects bb (but not using intersection test)
|
||||||
//scalar ccDist = signedDistance(bb.midpoint());
|
// scalar ccDist = signedDistance(bb.midpoint());
|
||||||
//scalar ccVal = ccDist - _iso_val;
|
// scalar ccVal = ccDist - _iso_val;
|
||||||
//if (mag(ccVal) < small)
|
// if (mag(ccVal) < small)
|
||||||
//{
|
//{
|
||||||
// return true;
|
// return true;
|
||||||
//}
|
//}
|
||||||
//const pointField points(bb.points());
|
// const pointField points(bb.points());
|
||||||
//forAll(points, pointi)
|
// forAll(points, pointi)
|
||||||
//{
|
//{
|
||||||
// scalar pointVal = signedDistance(points[pointi]) - _iso_val;
|
// scalar pointVal = signedDistance(points[pointi]) - _iso_val;
|
||||||
// if (ccVal*pointVal < 0)
|
// if (ccVal*pointVal < 0)
|
||||||
@ -214,24 +214,24 @@ public:
|
|||||||
// return true;
|
// return true;
|
||||||
// }
|
// }
|
||||||
//}
|
//}
|
||||||
//return false;
|
// return false;
|
||||||
|
|
||||||
|
|
||||||
////- Refinement based on intersection with multiple planes.
|
////- Refinement based on intersection with multiple planes.
|
||||||
//// Does not work well - too high a ratio between
|
//// Does not work well - too high a ratio between
|
||||||
//// neighbouring cubes.
|
//// neighbouring cubes.
|
||||||
//const pointField points(bb.points());
|
// const pointField points(bb.points());
|
||||||
//const edgeList& edges = treeBoundBox::edges;
|
// const edgeList& edges = treeBoundBox::edges;
|
||||||
//pointField start(edges.size());
|
// pointField start(edges.size());
|
||||||
//pointField end(edges.size());
|
// pointField end(edges.size());
|
||||||
//forAll(edges, i)
|
// forAll(edges, i)
|
||||||
//{
|
//{
|
||||||
// start[i] = points[edges[i][0]];
|
// start[i] = points[edges[i][0]];
|
||||||
// end[i] = points[edges[i][1]];
|
// end[i] = points[edges[i][1]];
|
||||||
//}
|
//}
|
||||||
//Foam::List<Foam::List<pointIndexHit>> hitInfo;
|
// Foam::List<Foam::List<pointIndexHit>> hitInfo;
|
||||||
//labelListList hitSurfaces;
|
// labelListList hitSurfaces;
|
||||||
//searchableSurfacesQueries::findAllIntersections
|
// searchableSurfacesQueries::findAllIntersections
|
||||||
//(
|
//(
|
||||||
// geometry,
|
// geometry,
|
||||||
// surfaces,
|
// surfaces,
|
||||||
@ -242,13 +242,13 @@ public:
|
|||||||
//);
|
//);
|
||||||
//
|
//
|
||||||
//// Count number of intersections
|
//// Count number of intersections
|
||||||
//label nInt = 0;
|
// label nInt = 0;
|
||||||
//forAll(hitSurfaces, edgeI)
|
// forAll(hitSurfaces, edgeI)
|
||||||
//{
|
//{
|
||||||
// nInt += hitSurfaces[edgeI].size();
|
// nInt += hitSurfaces[edgeI].size();
|
||||||
//}
|
//}
|
||||||
//
|
//
|
||||||
//if (nInt == 0)
|
// if (nInt == 0)
|
||||||
//{
|
//{
|
||||||
// // No surface intersected. See if there is one inside
|
// // No surface intersected. See if there is one inside
|
||||||
// forAll(surfaces, i)
|
// forAll(surfaces, i)
|
||||||
@ -262,8 +262,8 @@ public:
|
|||||||
//}
|
//}
|
||||||
//
|
//
|
||||||
//// Check multiple surfaces
|
//// Check multiple surfaces
|
||||||
//label baseSurfI = -1;
|
// label baseSurfI = -1;
|
||||||
//forAll(hitSurfaces, edgeI)
|
// forAll(hitSurfaces, edgeI)
|
||||||
//{
|
//{
|
||||||
// const labelList& hSurfs = hitSurfaces[edgeI];
|
// const labelList& hSurfs = hitSurfaces[edgeI];
|
||||||
// forAll(hSurfs, i)
|
// forAll(hSurfs, i)
|
||||||
@ -281,8 +281,8 @@ public:
|
|||||||
//}
|
//}
|
||||||
//
|
//
|
||||||
//// Get normals
|
//// Get normals
|
||||||
//DynamicList<pointIndexHit> baseInfo(nInt);
|
// DynamicList<pointIndexHit> baseInfo(nInt);
|
||||||
//forAll(hitInfo, edgeI)
|
// forAll(hitInfo, edgeI)
|
||||||
//{
|
//{
|
||||||
// const Foam::List<pointIndexHit>& hits = hitInfo[edgeI];
|
// const Foam::List<pointIndexHit>& hits = hitInfo[edgeI];
|
||||||
// forAll(hits, i)
|
// forAll(hits, i)
|
||||||
@ -291,62 +291,62 @@ public:
|
|||||||
// baseInfo.append(hits[i]);
|
// baseInfo.append(hits[i]);
|
||||||
// }
|
// }
|
||||||
//}
|
//}
|
||||||
//vectorField normals;
|
// vectorField normals;
|
||||||
//geometry[surfaces[baseSurfI]].getNormal(baseInfo, normals);
|
// geometry[surfaces[baseSurfI]].getNormal(baseInfo, normals);
|
||||||
//for (label i = 1; i < normals.size(); ++i)
|
// for (label i = 1; i < normals.size(); ++i)
|
||||||
//{
|
//{
|
||||||
// if ((normals[0] & normals[i]) < 0.9)
|
// if ((normals[0] & normals[i]) < 0.9)
|
||||||
// {
|
// {
|
||||||
// return true;
|
// return true;
|
||||||
// }
|
// }
|
||||||
//}
|
//}
|
||||||
//labelList regions;
|
// labelList regions;
|
||||||
//geometry[surfaces[baseSurfI]].getRegion(baseInfo, regions);
|
// geometry[surfaces[baseSurfI]].getRegion(baseInfo, regions);
|
||||||
//for (label i = 1; i < regions.size(); ++i)
|
// for (label i = 1; i < regions.size(); ++i)
|
||||||
//{
|
//{
|
||||||
// if (regions[0] != regions[i])
|
// if (regions[0] != regions[i])
|
||||||
// {
|
// {
|
||||||
// return true;
|
// return true;
|
||||||
// }
|
// }
|
||||||
//}
|
//}
|
||||||
//return false;
|
// return false;
|
||||||
|
|
||||||
|
|
||||||
|
|
||||||
//samples[0] = point(c.xmin(), c.ymin(), c.zmin());
|
// samples[0] = point(c.xmin(), c.ymin(), c.zmin());
|
||||||
//samples[1] = point(c.xmax(), c.ymin(), c.zmin());
|
// samples[1] = point(c.xmax(), c.ymin(), c.zmin());
|
||||||
//samples[2] = point(c.xmax(), c.ymax(), c.zmin());
|
// samples[2] = point(c.xmax(), c.ymax(), c.zmin());
|
||||||
//samples[3] = point(c.xmin(), c.ymax(), c.zmin());
|
// samples[3] = point(c.xmin(), c.ymax(), c.zmin());
|
||||||
//
|
//
|
||||||
//samples[4] = point(c.xmin(), c.ymin(), c.zmax());
|
// samples[4] = point(c.xmin(), c.ymin(), c.zmax());
|
||||||
//samples[5] = point(c.xmax(), c.ymin(), c.zmax());
|
// samples[5] = point(c.xmax(), c.ymin(), c.zmax());
|
||||||
//samples[6] = point(c.xmax(), c.ymax(), c.zmax());
|
// samples[6] = point(c.xmax(), c.ymax(), c.zmax());
|
||||||
//samples[7] = point(c.xmin(), c.ymax(), c.zmax());
|
// samples[7] = point(c.xmin(), c.ymax(), c.zmax());
|
||||||
|
|
||||||
//scalarField nearestDistSqr(8, great);
|
// scalarField nearestDistSqr(8, great);
|
||||||
//
|
//
|
||||||
//Foam::List<pointIndexHit> nearestInfo;
|
// Foam::List<pointIndexHit> nearestInfo;
|
||||||
//surf_.findNearest(samples, nearestDistSqr, nearestInfo);
|
// surf_.findNearest(samples, nearestDistSqr, nearestInfo);
|
||||||
//vectorField normals;
|
// vectorField normals;
|
||||||
//surf_.getNormal(nearestInfo, normals);
|
// surf_.getNormal(nearestInfo, normals);
|
||||||
//
|
//
|
||||||
//for (label i = 1; i < normals.size(); ++i)
|
// for (label i = 1; i < normals.size(); ++i)
|
||||||
//{
|
//{
|
||||||
// if ((normals[0] & normals[i]) < 0.5)
|
// if ((normals[0] & normals[i]) < 0.5)
|
||||||
// {
|
// {
|
||||||
// return true;
|
// return true;
|
||||||
// }
|
// }
|
||||||
//}
|
//}
|
||||||
//return false;
|
// return false;
|
||||||
|
|
||||||
//// Check if surface octree same level
|
//// Check if surface octree same level
|
||||||
//const labelList elems(surf_.tree().findBox(bb));
|
// const labelList elems(surf_.tree().findBox(bb));
|
||||||
//
|
//
|
||||||
//if (elems.size() > 1)
|
// if (elems.size() > 1)
|
||||||
//{
|
//{
|
||||||
// return true;
|
// return true;
|
||||||
//}
|
//}
|
||||||
//else
|
// else
|
||||||
//{
|
//{
|
||||||
// return false;
|
// return false;
|
||||||
//}
|
//}
|
||||||
@ -470,9 +470,9 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
distanceCalc ref
|
distanceCalc ref
|
||||||
(
|
(
|
||||||
8, //maxLevel
|
8, // maxLevel
|
||||||
0.0, //distance
|
0.0, // distance
|
||||||
minLevel, //minLevel
|
minLevel, // minLevel
|
||||||
geometryToConformTo,
|
geometryToConformTo,
|
||||||
converter
|
converter
|
||||||
);
|
);
|
||||||
|
|||||||
@ -52,7 +52,7 @@ int main(int argc, char *argv[])
|
|||||||
(
|
(
|
||||||
"Re-sample surfaces used in foamyHexMesh operation"
|
"Re-sample surfaces used in foamyHexMesh operation"
|
||||||
);
|
);
|
||||||
//argList::validArgs.append("inputFile");
|
// argList::validArgs.append("inputFile");
|
||||||
argList::validArgs.append("(nx ny nz)");
|
argList::validArgs.append("(nx ny nz)");
|
||||||
argList::validArgs.append("outputName");
|
argList::validArgs.append("outputName");
|
||||||
|
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -882,8 +882,8 @@ void Foam::CV2D::newPoints()
|
|||||||
{
|
{
|
||||||
w = magSqr(deltai.x()*ei.y() - deltai.y()*ei.x());
|
w = magSqr(deltai.x()*ei.y() - deltai.y()*ei.x());
|
||||||
// alternative weights
|
// alternative weights
|
||||||
//w = mag(deltai.x()*ei.y() - deltai.y()*ei.x());
|
// w = mag(deltai.x()*ei.y() - deltai.y()*ei.x());
|
||||||
//w = magSqr(ei)*mag(deltai);
|
// w = magSqr(ei)*mag(deltai);
|
||||||
|
|
||||||
// Use the following for an ~square mesh
|
// Use the following for an ~square mesh
|
||||||
// Find the coordinate contributions for this edge delta
|
// Find the coordinate contributions for this edge delta
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -157,7 +157,7 @@ private:
|
|||||||
mutable Random rndGen_;
|
mutable Random rndGen_;
|
||||||
|
|
||||||
//- The surface to mesh
|
//- The surface to mesh
|
||||||
//const querySurface& qSurf_;
|
// const querySurface& qSurf_;
|
||||||
//- All geometry of the meshing process, including surfaces to be
|
//- All geometry of the meshing process, including surfaces to be
|
||||||
// conformed to and those to be used for refinement
|
// conformed to and those to be used for refinement
|
||||||
searchableSurfaces allGeometry_;
|
searchableSurfaces allGeometry_;
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -195,8 +195,8 @@ inline void Foam::CV2D::movePoint(const Vertex_handle& vh, const Point& P)
|
|||||||
// move(vh, P);
|
// move(vh, P);
|
||||||
// vh->index() = i;
|
// vh->index() = i;
|
||||||
|
|
||||||
//vh->set_point(P);
|
// vh->set_point(P);
|
||||||
//fast_restore_Delaunay(vh);
|
// fast_restore_Delaunay(vh);
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
|
|||||||
@ -154,16 +154,16 @@ extrusion
|
|||||||
extrude on;
|
extrude on;
|
||||||
|
|
||||||
extrudeModel linearDirection;
|
extrudeModel linearDirection;
|
||||||
//extrudeModel wedge;
|
// extrudeModel wedge;
|
||||||
|
|
||||||
patchInfo
|
patchInfo
|
||||||
{
|
{
|
||||||
//type empty;
|
// type empty;
|
||||||
//startFace
|
// startFace
|
||||||
}
|
}
|
||||||
|
|
||||||
patchType empty;
|
patchType empty;
|
||||||
//patchType wedge;
|
// patchType wedge;
|
||||||
|
|
||||||
nLayers 1;
|
nLayers 1;
|
||||||
|
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2013-2015 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -227,7 +227,7 @@ void Foam::CV2D::insertFeaturePoints()
|
|||||||
int(totalAngle/meshControls().maxQuadAngle()) + 1;
|
int(totalAngle/meshControls().maxQuadAngle()) + 1;
|
||||||
|
|
||||||
// The number of additional master points needed to
|
// The number of additional master points needed to
|
||||||
//obtain the required number of quadrants.
|
// obtain the required number of quadrants.
|
||||||
int nAddPoints = min(max(nQuads - 2, 0), 2);
|
int nAddPoints = min(max(nQuads - 2, 0), 2);
|
||||||
|
|
||||||
// index of reflMaster
|
// index of reflMaster
|
||||||
|
|||||||
@ -321,7 +321,7 @@ autoPtr<refinementSurfaces> createRefinementSurfaces
|
|||||||
minLevel,
|
minLevel,
|
||||||
maxLevel,
|
maxLevel,
|
||||||
gapLevel,
|
gapLevel,
|
||||||
scalarField(nRegions, -great), //perpendicularAngle,
|
scalarField(nRegions, -great), // perpendicularAngle,
|
||||||
patchInfo
|
patchInfo
|
||||||
)
|
)
|
||||||
);
|
);
|
||||||
@ -872,7 +872,7 @@ int main(int argc, char *argv[])
|
|||||||
(
|
(
|
||||||
"abc", // dummy name
|
"abc", // dummy name
|
||||||
mesh.time().constant(), // instance
|
mesh.time().constant(), // instance
|
||||||
//mesh.time().findInstance("triSurface", word::null),// instance
|
// mesh.time().findInstance("triSurface", word::null),// instance
|
||||||
"triSurface", // local
|
"triSurface", // local
|
||||||
mesh.time(), // registry
|
mesh.time(), // registry
|
||||||
IOobject::MUST_READ,
|
IOobject::MUST_READ,
|
||||||
@ -922,9 +922,9 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
const scalar initialCellSize = ::pow(meshPtr().V()[0], 1.0/3.0);
|
const scalar initialCellSize = ::pow(meshPtr().V()[0], 1.0/3.0);
|
||||||
|
|
||||||
//Info<< "Wanted cell size = " << defaultCellSize << endl;
|
// Info<< "Wanted cell size = " << defaultCellSize << endl;
|
||||||
//Info<< "Current cell size = " << initialCellSize << endl;
|
// Info<< "Current cell size = " << initialCellSize << endl;
|
||||||
//Info<< "Fraction = " << initialCellSize/defaultCellSize
|
// Info<< "Fraction = " << initialCellSize/defaultCellSize
|
||||||
// << endl;
|
// << endl;
|
||||||
|
|
||||||
surfacesPtr =
|
surfacesPtr =
|
||||||
|
|||||||
@ -51,8 +51,8 @@ geometry
|
|||||||
type triSurfaceMesh;
|
type triSurfaceMesh;
|
||||||
file "sphere.stl"
|
file "sphere.stl"
|
||||||
|
|
||||||
//tolerance 1E-5; // optional:non-default tolerance on intersections
|
// tolerance 1E-5; // optional:non-default tolerance on intersections
|
||||||
//maxTreeDepth 10; // optional:depth of octree. Decrease only in case
|
// maxTreeDepth 10; // optional:depth of octree. Decrease only in case
|
||||||
// of memory limitations.
|
// of memory limitations.
|
||||||
|
|
||||||
// Per region the patchname. If not provided will be <surface>_<region>.
|
// Per region the patchname. If not provided will be <surface>_<region>.
|
||||||
@ -130,7 +130,7 @@ castellatedMeshControls
|
|||||||
(
|
(
|
||||||
//{
|
//{
|
||||||
// file "someLine.eMesh";
|
// file "someLine.eMesh";
|
||||||
// //level 2;
|
// // level 2;
|
||||||
// levels ((0.0 2) (1.0 3));
|
// levels ((0.0 2) (1.0 3));
|
||||||
//}
|
//}
|
||||||
);
|
);
|
||||||
@ -171,13 +171,13 @@ castellatedMeshControls
|
|||||||
|
|
||||||
|
|
||||||
//- Optional increment (on top of max level) in small gaps
|
//- Optional increment (on top of max level) in small gaps
|
||||||
//gapLevelIncrement 2;
|
// gapLevelIncrement 2;
|
||||||
|
|
||||||
//- Optional angle to detect small-large cell situation
|
//- Optional angle to detect small-large cell situation
|
||||||
// perpendicular to the surface. Is the angle of face w.r.t.
|
// perpendicular to the surface. Is the angle of face w.r.t.
|
||||||
// the local surface normal. Use on flat(ish) surfaces only.
|
// the local surface normal. Use on flat(ish) surfaces only.
|
||||||
// Otherwise leave out or set to negative number.
|
// Otherwise leave out or set to negative number.
|
||||||
//perpendicularAngle 10;
|
// perpendicularAngle 10;
|
||||||
|
|
||||||
//- Optional faceZone and (for closed surface) cellZone with
|
//- Optional faceZone and (for closed surface) cellZone with
|
||||||
// how to select the cells that are in the cellZone
|
// how to select the cells that are in the cellZone
|
||||||
@ -186,9 +186,9 @@ castellatedMeshControls
|
|||||||
// - if on cellZone(s) : point out of (maximum) cellZone
|
// - if on cellZone(s) : point out of (maximum) cellZone
|
||||||
// - if freestanding : oriented according to surface
|
// - if freestanding : oriented according to surface
|
||||||
|
|
||||||
//faceZone sphere;
|
// faceZone sphere;
|
||||||
//cellZone sphere;
|
// cellZone sphere;
|
||||||
//cellZoneInside inside; //outside/insidePoint
|
// cellZoneInside inside; // outside/insidePoint
|
||||||
|
|
||||||
//- Optional specification of what to do with faceZone faces:
|
//- Optional specification of what to do with faceZone faces:
|
||||||
// internal : keep them as internal faces (default)
|
// internal : keep them as internal faces (default)
|
||||||
@ -196,7 +196,7 @@ castellatedMeshControls
|
|||||||
// freedom in mesh motion
|
// freedom in mesh motion
|
||||||
// boundary : create free-standing boundary faces (baffles
|
// boundary : create free-standing boundary faces (baffles
|
||||||
// but without the shared points)
|
// but without the shared points)
|
||||||
//faceType baffle;
|
// faceType baffle;
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
@ -206,7 +206,7 @@ castellatedMeshControls
|
|||||||
resolveFeatureAngle 30;
|
resolveFeatureAngle 30;
|
||||||
|
|
||||||
//- Optional increment (on top of max level) in small gaps
|
//- Optional increment (on top of max level) in small gaps
|
||||||
//gapLevelIncrement 2;
|
// gapLevelIncrement 2;
|
||||||
|
|
||||||
|
|
||||||
// Planar angle:
|
// Planar angle:
|
||||||
@ -243,7 +243,7 @@ castellatedMeshControls
|
|||||||
mode inside;
|
mode inside;
|
||||||
levels ((1.0 4));
|
levels ((1.0 4));
|
||||||
}
|
}
|
||||||
//sphere
|
// sphere
|
||||||
//{
|
//{
|
||||||
// mode distance;
|
// mode distance;
|
||||||
// levels ((1.0 5) (2.0 3));
|
// levels ((1.0 5) (2.0 3));
|
||||||
@ -271,7 +271,7 @@ castellatedMeshControls
|
|||||||
|
|
||||||
// Optional: switch off topological test for cells to-be-squashed
|
// Optional: switch off topological test for cells to-be-squashed
|
||||||
// and use geometric test instead
|
// and use geometric test instead
|
||||||
//useTopologicalSnapDetection false;
|
// useTopologicalSnapDetection false;
|
||||||
}
|
}
|
||||||
|
|
||||||
// Settings for the snapping.
|
// Settings for the snapping.
|
||||||
@ -344,12 +344,12 @@ addLayersControls
|
|||||||
// Wanted thickness of the layer next to the wall.
|
// Wanted thickness of the layer next to the wall.
|
||||||
// If relativeSizes this is relative to undistorted size of cell
|
// If relativeSizes this is relative to undistorted size of cell
|
||||||
// outside layer.
|
// outside layer.
|
||||||
//firstLayerThickness 0.3;
|
// firstLayerThickness 0.3;
|
||||||
|
|
||||||
// Wanted overall thickness of layers.
|
// Wanted overall thickness of layers.
|
||||||
// If relativeSizes this is relative to undistorted size of cell
|
// If relativeSizes this is relative to undistorted size of cell
|
||||||
// outside layer.
|
// outside layer.
|
||||||
//thickness 0.5
|
// thickness 0.5
|
||||||
|
|
||||||
|
|
||||||
// Minimum overall thickness of total layers. If for any reason layer
|
// Minimum overall thickness of total layers. If for any reason layer
|
||||||
@ -433,15 +433,15 @@ addLayersControls
|
|||||||
|
|
||||||
// Optional: limit the number of steps walking away from the surface.
|
// Optional: limit the number of steps walking away from the surface.
|
||||||
// Default is unlimited.
|
// Default is unlimited.
|
||||||
//nMedialAxisIter 10;
|
// nMedialAxisIter 10;
|
||||||
|
|
||||||
// Optional: smooth displacement after medial axis determination.
|
// Optional: smooth displacement after medial axis determination.
|
||||||
// default is 0.
|
// default is 0.
|
||||||
//nSmoothDisplacement 90;
|
// nSmoothDisplacement 90;
|
||||||
|
|
||||||
// (wip)Optional: do not extrude a point if none of the surrounding points is
|
// (wip)Optional: do not extrude a point if none of the surrounding points is
|
||||||
// not extruded. Default is false.
|
// not extruded. Default is false.
|
||||||
//detectExtrusionIsland true;
|
// detectExtrusionIsland true;
|
||||||
|
|
||||||
|
|
||||||
// Mesh shrinking
|
// Mesh shrinking
|
||||||
@ -473,7 +473,7 @@ addLayersControls
|
|||||||
// Additional reporting: if there are just a few faces where there
|
// Additional reporting: if there are just a few faces where there
|
||||||
// are mesh errors (after adding the layers) print their face centres.
|
// are mesh errors (after adding the layers) print their face centres.
|
||||||
// This helps in tracking down problematic mesh areas.
|
// This helps in tracking down problematic mesh areas.
|
||||||
//additionalReporting true;
|
// additionalReporting true;
|
||||||
}
|
}
|
||||||
|
|
||||||
// Generic mesh quality settings. At any undoable phase these determine
|
// Generic mesh quality settings. At any undoable phase these determine
|
||||||
|
|||||||
@ -343,7 +343,7 @@ bool Foam::checkCoupledPoints
|
|||||||
const polyBoundaryMesh& patches = mesh.boundaryMesh();
|
const polyBoundaryMesh& patches = mesh.boundaryMesh();
|
||||||
|
|
||||||
// Zero'th point on coupled faces
|
// Zero'th point on coupled faces
|
||||||
//pointField nbrZeroPoint(fcs.size()-mesh.nInternalFaces(), vector::max);
|
// pointField nbrZeroPoint(fcs.size()-mesh.nInternalFaces(), vector::max);
|
||||||
List<pointField> nbrPoints(fcs.size() - mesh.nInternalFaces());
|
List<pointField> nbrPoints(fcs.size() - mesh.nInternalFaces());
|
||||||
|
|
||||||
// Exchange zero point
|
// Exchange zero point
|
||||||
@ -395,7 +395,7 @@ bool Foam::checkCoupledPoints
|
|||||||
(
|
(
|
||||||
cpp.calcFaceTol
|
cpp.calcFaceTol
|
||||||
(
|
(
|
||||||
//cpp.matchTolerance(),
|
// cpp.matchTolerance(),
|
||||||
cpp,
|
cpp,
|
||||||
cpp.points(),
|
cpp.points(),
|
||||||
cpp.faceCentres()
|
cpp.faceCentres()
|
||||||
@ -869,7 +869,7 @@ Foam::label Foam::checkGeometry
|
|||||||
pointSet points(mesh, "shortEdges", mesh.nPoints()/1000 + 1);
|
pointSet points(mesh, "shortEdges", mesh.nPoints()/1000 + 1);
|
||||||
if (mesh.checkEdgeLength(true, minDistSqr, &points))
|
if (mesh.checkEdgeLength(true, minDistSqr, &points))
|
||||||
{
|
{
|
||||||
//noFailedChecks++;
|
// noFailedChecks++;
|
||||||
|
|
||||||
label nPoints = returnReduce(points.size(), sumOp<label>());
|
label nPoints = returnReduce(points.size(), sumOp<label>());
|
||||||
|
|
||||||
@ -891,7 +891,7 @@ Foam::label Foam::checkGeometry
|
|||||||
|
|
||||||
if (mesh.checkPointNearness(false, minDistSqr, &points))
|
if (mesh.checkPointNearness(false, minDistSqr, &points))
|
||||||
{
|
{
|
||||||
//noFailedChecks++;
|
// noFailedChecks++;
|
||||||
|
|
||||||
label nPoints = returnReduce(points.size(), sumOp<label>());
|
label nPoints = returnReduce(points.size(), sumOp<label>());
|
||||||
|
|
||||||
@ -916,7 +916,7 @@ Foam::label Foam::checkGeometry
|
|||||||
faceSet faces(mesh, "concaveFaces", mesh.nFaces()/100 + 1);
|
faceSet faces(mesh, "concaveFaces", mesh.nFaces()/100 + 1);
|
||||||
if (mesh.checkFaceAngles(true, 10, &faces))
|
if (mesh.checkFaceAngles(true, 10, &faces))
|
||||||
{
|
{
|
||||||
//noFailedChecks++;
|
// noFailedChecks++;
|
||||||
|
|
||||||
label nFaces = returnReduce(faces.size(), sumOp<label>());
|
label nFaces = returnReduce(faces.size(), sumOp<label>());
|
||||||
|
|
||||||
@ -940,7 +940,7 @@ Foam::label Foam::checkGeometry
|
|||||||
faceSet faces(mesh, "warpedFaces", mesh.nFaces()/100 + 1);
|
faceSet faces(mesh, "warpedFaces", mesh.nFaces()/100 + 1);
|
||||||
if (mesh.checkFaceFlatness(true, 0.8, &faces))
|
if (mesh.checkFaceFlatness(true, 0.8, &faces))
|
||||||
{
|
{
|
||||||
//noFailedChecks++;
|
// noFailedChecks++;
|
||||||
|
|
||||||
label nFaces = returnReduce(faces.size(), sumOp<label>());
|
label nFaces = returnReduce(faces.size(), sumOp<label>());
|
||||||
|
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2015-2017 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2015-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -478,7 +478,7 @@ void Foam::mergeAndWrite
|
|||||||
mkDir(outputDir);
|
mkDir(outputDir);
|
||||||
|
|
||||||
fileName outputFile(outputDir/writer.getFileName(points, wordList()));
|
fileName outputFile(outputDir/writer.getFileName(points, wordList()));
|
||||||
//fileName outputFile(outputDir/set.name());
|
// fileName outputFile(outputDir/set.name());
|
||||||
|
|
||||||
OFstream os(outputFile);
|
OFstream os(outputFile);
|
||||||
|
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -588,7 +588,7 @@ Foam::label Foam::checkTopology
|
|||||||
points.write();
|
points.write();
|
||||||
}
|
}
|
||||||
|
|
||||||
//Info.setf(ios_base::right);
|
// Info.setf(ios_base::right);
|
||||||
}
|
}
|
||||||
|
|
||||||
// Force creation of all addressing if requested.
|
// Force creation of all addressing if requested.
|
||||||
|
|||||||
@ -661,7 +661,7 @@ int main(int argc, char *argv[])
|
|||||||
// Pass 1: add patches
|
// Pass 1: add patches
|
||||||
// ~~~~~~~~~~~~~~~~~~~
|
// ~~~~~~~~~~~~~~~~~~~
|
||||||
|
|
||||||
//HashSet<word> addedPatches;
|
// HashSet<word> addedPatches;
|
||||||
{
|
{
|
||||||
const polyBoundaryMesh& pbm = mesh.boundaryMesh();
|
const polyBoundaryMesh& pbm = mesh.boundaryMesh();
|
||||||
forAll(selectors, selectorI)
|
forAll(selectors, selectorI)
|
||||||
@ -685,7 +685,7 @@ int main(int argc, char *argv[])
|
|||||||
// Note: do not set coupleGroup if constructed from
|
// Note: do not set coupleGroup if constructed from
|
||||||
// baffles so you have freedom specifying it
|
// baffles so you have freedom specifying it
|
||||||
// yourself.
|
// yourself.
|
||||||
//patchDict.set("coupleGroup", groupName);
|
// patchDict.set("coupleGroup", groupName);
|
||||||
|
|
||||||
addPatch(mesh, patchName, groupName, patchDict);
|
addPatch(mesh, patchName, groupName, patchDict);
|
||||||
}
|
}
|
||||||
|
|||||||
@ -62,7 +62,7 @@ baffles
|
|||||||
surface triSurfaceMesh;
|
surface triSurfaceMesh;
|
||||||
name baffle1D.stl;
|
name baffle1D.stl;
|
||||||
//- Optional flip
|
//- Optional flip
|
||||||
//flip false;
|
// flip false;
|
||||||
|
|
||||||
|
|
||||||
// Generate patchGroup baffle1 with two patches:
|
// Generate patchGroup baffle1 with two patches:
|
||||||
|
|||||||
@ -461,7 +461,7 @@ void syncPoints
|
|||||||
|
|
||||||
//- Note: hasTransformation is only used for warning messages so
|
//- Note: hasTransformation is only used for warning messages so
|
||||||
// reduction not strictly necessary.
|
// reduction not strictly necessary.
|
||||||
//reduce(hasTransformation, orOp<bool>());
|
// reduce(hasTransformation, orOp<bool>());
|
||||||
|
|
||||||
// Synchronize multiple shared points.
|
// Synchronize multiple shared points.
|
||||||
const globalMeshData& pd = mesh.globalData();
|
const globalMeshData& pd = mesh.globalData();
|
||||||
|
|||||||
@ -70,7 +70,7 @@ patches
|
|||||||
|
|
||||||
// Optional non-default tolerance to be able to define cyclics
|
// Optional non-default tolerance to be able to define cyclics
|
||||||
// on bad meshes
|
// on bad meshes
|
||||||
//matchTolerance 1E-2;
|
// matchTolerance 1E-2;
|
||||||
}
|
}
|
||||||
|
|
||||||
// How to construct: either from 'patches' or 'set'
|
// How to construct: either from 'patches' or 'set'
|
||||||
|
|||||||
@ -92,33 +92,33 @@ int main(int argc, char *argv[])
|
|||||||
mapPolyMesh map
|
mapPolyMesh map
|
||||||
(
|
(
|
||||||
mesh,
|
mesh,
|
||||||
mesh.nPoints(), //nOldPoints,
|
mesh.nPoints(), // nOldPoints,
|
||||||
mesh.nFaces(), //nOldFaces,
|
mesh.nFaces(), // nOldFaces,
|
||||||
mesh.nCells(), //nOldCells,
|
mesh.nCells(), // nOldCells,
|
||||||
mesh.pointMap(), //pointMap,
|
mesh.pointMap(), // pointMap,
|
||||||
List<objectMap>(0), // pointsFromPoints,
|
List<objectMap>(0), // pointsFromPoints,
|
||||||
labelList(0), //faceMap,
|
labelList(0), // faceMap,
|
||||||
List<objectMap>(0), //facesFromPoints,
|
List<objectMap>(0), // facesFromPoints,
|
||||||
List<objectMap>(0), //facesFromEdges,
|
List<objectMap>(0), // facesFromEdges,
|
||||||
List<objectMap>(0), //facesFromFaces,
|
List<objectMap>(0), // facesFromFaces,
|
||||||
mesh.cellMap(), //cellMap,
|
mesh.cellMap(), // cellMap,
|
||||||
List<objectMap>(0), //cellsFromPoints,
|
List<objectMap>(0), // cellsFromPoints,
|
||||||
List<objectMap>(0), //cellsFromEdges,
|
List<objectMap>(0), // cellsFromEdges,
|
||||||
List<objectMap>(0), //cellsFromFaces,
|
List<objectMap>(0), // cellsFromFaces,
|
||||||
List<objectMap>(0), //cellsFromCells,
|
List<objectMap>(0), // cellsFromCells,
|
||||||
labelList(0), //reversePointMap,
|
labelList(0), // reversePointMap,
|
||||||
labelList(0), //reverseFaceMap,
|
labelList(0), // reverseFaceMap,
|
||||||
labelList(0), //reverseCellMap,
|
labelList(0), // reverseCellMap,
|
||||||
labelHashSet(0), //flipFaceFlux,
|
labelHashSet(0), // flipFaceFlux,
|
||||||
labelListList(0), //patchPointMap,
|
labelListList(0), // patchPointMap,
|
||||||
labelListList(0), //pointZoneMap,
|
labelListList(0), // pointZoneMap,
|
||||||
labelListList(0), //faceZonePointMap,
|
labelListList(0), // faceZonePointMap,
|
||||||
labelListList(0), //faceZoneFaceMap,
|
labelListList(0), // faceZoneFaceMap,
|
||||||
labelListList(0), //cellZoneMap,
|
labelListList(0), // cellZoneMap,
|
||||||
pointField(0), //preMotionPoints,
|
pointField(0), // preMotionPoints,
|
||||||
labelList(0), //oldPatchStarts,
|
labelList(0), // oldPatchStarts,
|
||||||
labelList(0), //oldPatchNMeshPoints,
|
labelList(0), // oldPatchNMeshPoints,
|
||||||
autoPtr<scalarField>() //oldCellVolumesPtr
|
autoPtr<scalarField>() // oldCellVolumesPtr
|
||||||
);
|
);
|
||||||
refData.updateMesh(map);
|
refData.updateMesh(map);
|
||||||
refData.write();
|
refData.write();
|
||||||
|
|||||||
@ -270,10 +270,10 @@ Foam::label Foam::meshDualiser::addInternalFace
|
|||||||
zoneFlip // zoneFlip
|
zoneFlip // zoneFlip
|
||||||
);
|
);
|
||||||
|
|
||||||
//pointField dualPoints(meshMod.points());
|
// pointField dualPoints(meshMod.points());
|
||||||
//vector n(newFace.normal(dualPoints));
|
// vector n(newFace.normal(dualPoints));
|
||||||
//n /= mag(n);
|
// n /= mag(n);
|
||||||
//Pout<< "Generated internal dualFace:" << dualFacei
|
// Pout<< "Generated internal dualFace:" << dualFacei
|
||||||
// << " verts:" << newFace
|
// << " verts:" << newFace
|
||||||
// << " points:" << UIndirectList<point>(meshMod.points(), newFace)()
|
// << " points:" << UIndirectList<point>(meshMod.points(), newFace)()
|
||||||
// << " n:" << n
|
// << " n:" << n
|
||||||
@ -297,10 +297,10 @@ Foam::label Foam::meshDualiser::addInternalFace
|
|||||||
zoneFlip // zoneFlip
|
zoneFlip // zoneFlip
|
||||||
);
|
);
|
||||||
|
|
||||||
//pointField dualPoints(meshMod.points());
|
// pointField dualPoints(meshMod.points());
|
||||||
//vector n(newFace.normal(dualPoints));
|
// vector n(newFace.normal(dualPoints));
|
||||||
//n /= mag(n);
|
// n /= mag(n);
|
||||||
//Pout<< "Generated internal dualFace:" << dualFacei
|
// Pout<< "Generated internal dualFace:" << dualFacei
|
||||||
// << " verts:" << newFace
|
// << " verts:" << newFace
|
||||||
// << " points:" << UIndirectList<point>(meshMod.points(), newFace)()
|
// << " points:" << UIndirectList<point>(meshMod.points(), newFace)()
|
||||||
// << " n:" << n
|
// << " n:" << n
|
||||||
@ -354,10 +354,10 @@ Foam::label Foam::meshDualiser::addBoundaryFace
|
|||||||
zoneFlip // zoneFlip
|
zoneFlip // zoneFlip
|
||||||
);
|
);
|
||||||
|
|
||||||
//pointField dualPoints(meshMod.points());
|
// pointField dualPoints(meshMod.points());
|
||||||
//vector n(newFace.normal(dualPoints));
|
// vector n(newFace.normal(dualPoints));
|
||||||
//n /= mag(n);
|
// n /= mag(n);
|
||||||
//Pout<< "Generated boundary dualFace:" << dualFacei
|
// Pout<< "Generated boundary dualFace:" << dualFacei
|
||||||
// << " verts:" << newFace
|
// << " verts:" << newFace
|
||||||
// << " points:" << UIndirectList<point>(meshMod.points(), newFace)()
|
// << " points:" << UIndirectList<point>(meshMod.points(), newFace)()
|
||||||
// << " n:" << n
|
// << " n:" << n
|
||||||
@ -404,7 +404,7 @@ void Foam::meshDualiser::createFacesAroundEdge
|
|||||||
bool edgeOrder = ie.sameOrder(e[0], e[1]);
|
bool edgeOrder = ie.sameOrder(e[0], e[1]);
|
||||||
label startFaceLabel = ie.faceLabel();
|
label startFaceLabel = ie.faceLabel();
|
||||||
|
|
||||||
//Pout<< "At edge:" << edgeI << " verts:" << e
|
// Pout<< "At edge:" << edgeI << " verts:" << e
|
||||||
// << " points:" << mesh_.points()[e[0]] << mesh_.points()[e[1]]
|
// << " points:" << mesh_.points()[e[0]] << mesh_.points()[e[1]]
|
||||||
// << " started walking at face:" << ie.faceLabel()
|
// << " started walking at face:" << ie.faceLabel()
|
||||||
// << " verts:" << mesh_.faces()[ie.faceLabel()]
|
// << " verts:" << mesh_.faces()[ie.faceLabel()]
|
||||||
@ -552,7 +552,7 @@ void Foam::meshDualiser::createFaceFromInternalFace
|
|||||||
label own = mesh_.faceOwner()[facei];
|
label own = mesh_.faceOwner()[facei];
|
||||||
label nei = mesh_.faceNeighbour()[facei];
|
label nei = mesh_.faceNeighbour()[facei];
|
||||||
|
|
||||||
//Pout<< "createFaceFromInternalFace : At face:" << facei
|
// Pout<< "createFaceFromInternalFace : At face:" << facei
|
||||||
// << " verts:" << f
|
// << " verts:" << f
|
||||||
// << " points:" << UIndirectList<point>(mesh_.points(), f)()
|
// << " points:" << UIndirectList<point>(mesh_.points(), f)()
|
||||||
// << " started walking at edge:" << fEdges[fp]
|
// << " started walking at edge:" << fEdges[fp]
|
||||||
@ -735,13 +735,13 @@ void Foam::meshDualiser::createFacesAroundBoundaryPoint
|
|||||||
|
|
||||||
label dualCelli = findDualCell(own[facei], pointi);
|
label dualCelli = findDualCell(own[facei], pointi);
|
||||||
|
|
||||||
//Bit dodgy: create dualface from the last face (instead of from
|
// Bit dodgy: create dualface from the last face (instead of from
|
||||||
// the central point). This will also use the original faceZone to
|
// the central point). This will also use the original faceZone to
|
||||||
// put the new face (which might span multiple original faces) in.
|
// put the new face (which might span multiple original faces) in.
|
||||||
|
|
||||||
addBoundaryFace
|
addBoundaryFace
|
||||||
(
|
(
|
||||||
//pointi, // masterPointi
|
// pointi, // masterPointi
|
||||||
-1, // masterPointi
|
-1, // masterPointi
|
||||||
-1, // masterEdgeI
|
-1, // masterEdgeI
|
||||||
facei, // masterFacei
|
facei, // masterFacei
|
||||||
@ -1030,11 +1030,11 @@ void Foam::meshDualiser::setRefinement
|
|||||||
pointToDualCells_[pointi].setSize(1);
|
pointToDualCells_[pointi].setSize(1);
|
||||||
pointToDualCells_[pointi][0] = meshMod.addCell
|
pointToDualCells_[pointi][0] = meshMod.addCell
|
||||||
(
|
(
|
||||||
pointi, //masterPointID,
|
pointi, // masterPointID,
|
||||||
-1, //masterEdgeID,
|
-1, // masterEdgeID,
|
||||||
-1, //masterFaceID,
|
-1, // masterFaceID,
|
||||||
-1, //masterCellID,
|
-1, // masterCellID,
|
||||||
-1 //zoneID
|
-1 // zoneID
|
||||||
);
|
);
|
||||||
if (dualCcStr.valid())
|
if (dualCcStr.valid())
|
||||||
{
|
{
|
||||||
@ -1074,11 +1074,11 @@ void Foam::meshDualiser::setRefinement
|
|||||||
{
|
{
|
||||||
pointToDualCells_[pointi][pCelli] = meshMod.addCell
|
pointToDualCells_[pointi][pCelli] = meshMod.addCell
|
||||||
(
|
(
|
||||||
pointi, //masterPointID
|
pointi, // masterPointID
|
||||||
-1, //masterEdgeID
|
-1, // masterEdgeID
|
||||||
-1, //masterFaceID
|
-1, // masterFaceID
|
||||||
-1, //masterCellID
|
-1, // masterCellID
|
||||||
mesh_.cellZones().whichZone(pCells[pCelli]) //zoneID
|
mesh_.cellZones().whichZone(pCells[pCelli]) // zoneID
|
||||||
);
|
);
|
||||||
if (dualCcStr.valid())
|
if (dualCcStr.valid())
|
||||||
{
|
{
|
||||||
@ -1098,11 +1098,11 @@ void Foam::meshDualiser::setRefinement
|
|||||||
pointToDualCells_[pointi].setSize(1);
|
pointToDualCells_[pointi].setSize(1);
|
||||||
pointToDualCells_[pointi][0] = meshMod.addCell
|
pointToDualCells_[pointi][0] = meshMod.addCell
|
||||||
(
|
(
|
||||||
pointi, //masterPointID,
|
pointi, // masterPointID,
|
||||||
-1, //masterEdgeID,
|
-1, // masterEdgeID,
|
||||||
-1, //masterFaceID,
|
-1, // masterFaceID,
|
||||||
-1, //masterCellID,
|
-1, // masterCellID,
|
||||||
-1 //zoneID
|
-1 // zoneID
|
||||||
);
|
);
|
||||||
|
|
||||||
if (dualCcStr.valid())
|
if (dualCcStr.valid())
|
||||||
@ -1301,7 +1301,7 @@ void Foam::meshDualiser::setRefinement
|
|||||||
|
|
||||||
label startFacei = eFaces[i];
|
label startFacei = eFaces[i];
|
||||||
|
|
||||||
//Pout<< "Walking edge:" << edgeI
|
// Pout<< "Walking edge:" << edgeI
|
||||||
// << " points:" << mesh_.points()[e[0]]
|
// << " points:" << mesh_.points()[e[0]]
|
||||||
// << mesh_.points()[e[1]]
|
// << mesh_.points()[e[1]]
|
||||||
// << " startFace:" << startFacei
|
// << " startFace:" << startFacei
|
||||||
@ -1409,7 +1409,7 @@ void Foam::meshDualiser::setRefinement
|
|||||||
// Starting face
|
// Starting face
|
||||||
label startFacei = pp.start()+pFaces[i];
|
label startFacei = pp.start()+pFaces[i];
|
||||||
|
|
||||||
//Pout<< "Walking around point:" << pointi
|
// Pout<< "Walking around point:" << pointi
|
||||||
// << " coord:" << mesh_.points()[pointi]
|
// << " coord:" << mesh_.points()[pointi]
|
||||||
// << " on patch:" << patchi
|
// << " on patch:" << patchi
|
||||||
// << " startFace:" << startFacei
|
// << " startFace:" << startFacei
|
||||||
|
|||||||
@ -156,7 +156,7 @@ void simpleMarkFeatures
|
|||||||
{
|
{
|
||||||
const edge& e = allBoundary.edges()[edgeI];
|
const edge& e = allBoundary.edges()[edgeI];
|
||||||
|
|
||||||
//Info<< "Detected non-manifold boundary edge:" << edgeI
|
// Info<< "Detected non-manifold boundary edge:" << edgeI
|
||||||
// << " coords:"
|
// << " coords:"
|
||||||
// << allBoundary.points()[meshPoints[e[0]]]
|
// << allBoundary.points()[meshPoints[e[0]]]
|
||||||
// << allBoundary.points()[meshPoints[e[1]]] << endl;
|
// << allBoundary.points()[meshPoints[e[1]]] << endl;
|
||||||
|
|||||||
@ -93,8 +93,8 @@ springCoeffs
|
|||||||
blockCoeffs
|
blockCoeffs
|
||||||
{
|
{
|
||||||
method scotch;
|
method scotch;
|
||||||
//method hierarchical;
|
// method hierarchical;
|
||||||
//hierarchicalCoeffs
|
// hierarchicalCoeffs
|
||||||
//{
|
//{
|
||||||
// n (1 2 1);
|
// n (1 2 1);
|
||||||
// delta 0.001;
|
// delta 0.001;
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -105,7 +105,7 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
IOobjectList pointObjects(objects.lookupClass(pointSet::typeName));
|
IOobjectList pointObjects(objects.lookupClass(pointSet::typeName));
|
||||||
|
|
||||||
//Pout<< "pointSets:" << pointObjects.names() << endl;
|
// Pout<< "pointSets:" << pointObjects.names() << endl;
|
||||||
|
|
||||||
forAllConstIter(IOobjectList, pointObjects, iter)
|
forAllConstIter(IOobjectList, pointObjects, iter)
|
||||||
{
|
{
|
||||||
@ -124,10 +124,10 @@ int main(int argc, char *argv[])
|
|||||||
sz,
|
sz,
|
||||||
new pointZone
|
new pointZone
|
||||||
(
|
(
|
||||||
set.name(), //name
|
set.name(), // name
|
||||||
pointLabels, //addressing
|
pointLabels, // addressing
|
||||||
sz, //index
|
sz, // index
|
||||||
mesh.pointZones() //pointZoneMesh
|
mesh.pointZones() // pointZoneMesh
|
||||||
)
|
)
|
||||||
);
|
);
|
||||||
mesh.pointZones().writeOpt() = IOobject::AUTO_WRITE;
|
mesh.pointZones().writeOpt() = IOobject::AUTO_WRITE;
|
||||||
@ -149,7 +149,7 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
HashSet<word> slaveCellSets;
|
HashSet<word> slaveCellSets;
|
||||||
|
|
||||||
//Pout<< "faceSets:" << faceObjects.names() << endl;
|
// Pout<< "faceSets:" << faceObjects.names() << endl;
|
||||||
|
|
||||||
forAllConstIter(IOobjectList, faceObjects, iter)
|
forAllConstIter(IOobjectList, faceObjects, iter)
|
||||||
{
|
{
|
||||||
@ -255,11 +255,11 @@ int main(int argc, char *argv[])
|
|||||||
sz,
|
sz,
|
||||||
new faceZone
|
new faceZone
|
||||||
(
|
(
|
||||||
set.name(), //name
|
set.name(), // name
|
||||||
addressing.shrink(), //addressing
|
addressing.shrink(), // addressing
|
||||||
flipMap.shrink(), //flipmap
|
flipMap.shrink(), // flipmap
|
||||||
sz, //index
|
sz, // index
|
||||||
mesh.faceZones() //pointZoneMesh
|
mesh.faceZones() // pointZoneMesh
|
||||||
)
|
)
|
||||||
);
|
);
|
||||||
mesh.faceZones().writeOpt() = IOobject::AUTO_WRITE;
|
mesh.faceZones().writeOpt() = IOobject::AUTO_WRITE;
|
||||||
@ -283,7 +283,7 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
IOobjectList cellObjects(objects.lookupClass(cellSet::typeName));
|
IOobjectList cellObjects(objects.lookupClass(cellSet::typeName));
|
||||||
|
|
||||||
//Pout<< "cellSets:" << cellObjects.names() << endl;
|
// Pout<< "cellSets:" << cellObjects.names() << endl;
|
||||||
|
|
||||||
forAllConstIter(IOobjectList, cellObjects, iter)
|
forAllConstIter(IOobjectList, cellObjects, iter)
|
||||||
{
|
{
|
||||||
@ -304,10 +304,10 @@ int main(int argc, char *argv[])
|
|||||||
sz,
|
sz,
|
||||||
new cellZone
|
new cellZone
|
||||||
(
|
(
|
||||||
set.name(), //name
|
set.name(), // name
|
||||||
cellLabels, //addressing
|
cellLabels, // addressing
|
||||||
sz, //index
|
sz, // index
|
||||||
mesh.cellZones() //pointZoneMesh
|
mesh.cellZones() // pointZoneMesh
|
||||||
)
|
)
|
||||||
);
|
);
|
||||||
mesh.cellZones().writeOpt() = IOobject::AUTO_WRITE;
|
mesh.cellZones().writeOpt() = IOobject::AUTO_WRITE;
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -365,7 +365,7 @@ void Foam::regionSide::walkAllPointConnectedFaces
|
|||||||
|
|
||||||
visitedPoint.insert(e.start());
|
visitedPoint.insert(e.start());
|
||||||
|
|
||||||
//edgeI = otherEdge(mesh, otherFacei, edgeI, e.start());
|
// edgeI = otherEdge(mesh, otherFacei, edgeI, e.start());
|
||||||
|
|
||||||
walkPointConnectedFaces
|
walkPointConnectedFaces
|
||||||
(
|
(
|
||||||
@ -384,7 +384,7 @@ void Foam::regionSide::walkAllPointConnectedFaces
|
|||||||
|
|
||||||
visitedPoint.insert(e.end());
|
visitedPoint.insert(e.end());
|
||||||
|
|
||||||
//edgeI = otherEdge(mesh, otherFacei, edgeI, e.end());
|
// edgeI = otherEdge(mesh, otherFacei, edgeI, e.end());
|
||||||
|
|
||||||
walkPointConnectedFaces
|
walkPointConnectedFaces
|
||||||
(
|
(
|
||||||
|
|||||||
@ -631,7 +631,7 @@ autoPtr<mapPolyMesh> createRegionMesh
|
|||||||
);
|
);
|
||||||
|
|
||||||
if (!io.typeHeaderOk<IOdictionary>(true))
|
if (!io.typeHeaderOk<IOdictionary>(true))
|
||||||
//if (!exists(io.objectPath()))
|
// if (!exists(io.objectPath()))
|
||||||
{
|
{
|
||||||
Info<< "Writing dummy " << regionName/io.name() << endl;
|
Info<< "Writing dummy " << regionName/io.name() << endl;
|
||||||
dictionary dummyDict;
|
dictionary dummyDict;
|
||||||
@ -926,7 +926,7 @@ void createAndWriteRegion
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
//reorderPatches(newMesh(), oldToNew, nNewPatches);
|
// reorderPatches(newMesh(), oldToNew, nNewPatches);
|
||||||
fvMeshTools::reorderPatches(newMesh(), oldToNew, nNewPatches, true);
|
fvMeshTools::reorderPatches(newMesh(), oldToNew, nNewPatches, true);
|
||||||
|
|
||||||
// Rename shared patches with region name
|
// Rename shared patches with region name
|
||||||
@ -1075,7 +1075,7 @@ labelList addRegionPatches
|
|||||||
const edge& e = interfaces[interI];
|
const edge& e = interfaces[interI];
|
||||||
const Pair<word>& names = interfaceNames[interI];
|
const Pair<word>& names = interfaceNames[interI];
|
||||||
|
|
||||||
//Info<< "For interface " << interI
|
// Info<< "For interface " << interI
|
||||||
// << " between regions " << e
|
// << " between regions " << e
|
||||||
// << " trying to add patches " << names << endl;
|
// << " trying to add patches " << names << endl;
|
||||||
|
|
||||||
@ -1097,9 +1097,9 @@ labelList addRegionPatches
|
|||||||
(
|
(
|
||||||
mesh,
|
mesh,
|
||||||
patch1,
|
patch1,
|
||||||
dictionary(), //optional per field value
|
dictionary(), // optional per field value
|
||||||
calculatedFvPatchField<scalar>::typeName,
|
calculatedFvPatchField<scalar>::typeName,
|
||||||
true //validBoundary
|
true // validBoundary
|
||||||
);
|
);
|
||||||
|
|
||||||
mappedWallPolyPatch patch2
|
mappedWallPolyPatch patch2
|
||||||
@ -1118,9 +1118,9 @@ labelList addRegionPatches
|
|||||||
(
|
(
|
||||||
mesh,
|
mesh,
|
||||||
patch2,
|
patch2,
|
||||||
dictionary(), //optional per field value
|
dictionary(), // optional per field value
|
||||||
calculatedFvPatchField<scalar>::typeName,
|
calculatedFvPatchField<scalar>::typeName,
|
||||||
true //validBoundary
|
true // validBoundary
|
||||||
);
|
);
|
||||||
|
|
||||||
Info<< "For interface between region " << regionNames[e[0]]
|
Info<< "For interface between region " << regionNames[e[0]]
|
||||||
@ -1920,10 +1920,10 @@ int main(int argc, char *argv[])
|
|||||||
zoneI,
|
zoneI,
|
||||||
new cellZone
|
new cellZone
|
||||||
(
|
(
|
||||||
zoneName, //name
|
zoneName, // name
|
||||||
regionCells, //addressing
|
regionCells, // addressing
|
||||||
zoneI, //index
|
zoneI, // index
|
||||||
cellZones //cellZoneMesh
|
cellZones // cellZoneMesh
|
||||||
)
|
)
|
||||||
);
|
);
|
||||||
}
|
}
|
||||||
|
|||||||
@ -446,15 +446,15 @@ int main(int argc, char *argv[])
|
|||||||
ReadFields(mesh, objects, volTensorFields);
|
ReadFields(mesh, objects, volTensorFields);
|
||||||
|
|
||||||
//- Uncomment if you want to interpolate surface fields (usually bad idea)
|
//- Uncomment if you want to interpolate surface fields (usually bad idea)
|
||||||
//Info<< "Reading all current surfaceFields" << endl;
|
// Info<< "Reading all current surfaceFields" << endl;
|
||||||
//PtrList<surfaceScalarField> surfaceScalarFields;
|
// PtrList<surfaceScalarField> surfaceScalarFields;
|
||||||
//ReadFields(mesh, objects, surfaceScalarFields);
|
// ReadFields(mesh, objects, surfaceScalarFields);
|
||||||
//
|
//
|
||||||
//PtrList<surfaceVectorField> surfaceVectorFields;
|
// PtrList<surfaceVectorField> surfaceVectorFields;
|
||||||
//ReadFields(mesh, objects, surfaceVectorFields);
|
// ReadFields(mesh, objects, surfaceVectorFields);
|
||||||
//
|
//
|
||||||
//PtrList<surfaceTensorField> surfaceTensorFields;
|
// PtrList<surfaceTensorField> surfaceTensorFields;
|
||||||
//ReadFields(mesh, objects, surfaceTensorFields);
|
// ReadFields(mesh, objects, surfaceTensorFields);
|
||||||
|
|
||||||
if (!overwrite)
|
if (!overwrite)
|
||||||
{
|
{
|
||||||
|
|||||||
@ -73,10 +73,10 @@ FoamFile
|
|||||||
// {
|
// {
|
||||||
// set f0; // Name of faceSet
|
// set f0; // Name of faceSet
|
||||||
//
|
//
|
||||||
// //option neighbour; // cell with neighbour in faceSet
|
// // option neighbour; // cell with neighbour in faceSet
|
||||||
// //option owner; // ,, owner
|
// // option owner; // ,, owner
|
||||||
// option any; // cell with any face in faceSet
|
// option any; // cell with any face in faceSet
|
||||||
// //option all; // cell with all faces in faceSet
|
// // option all; // cell with all faces in faceSet
|
||||||
// }
|
// }
|
||||||
//
|
//
|
||||||
// // Select based on pointSet
|
// // Select based on pointSet
|
||||||
@ -85,7 +85,7 @@ FoamFile
|
|||||||
// {
|
// {
|
||||||
// set p0;
|
// set p0;
|
||||||
// option any; // cell with any point in pointSet
|
// option any; // cell with any point in pointSet
|
||||||
// //option edge; // cell with an edge with both points in pointSet
|
// // option edge; // cell with an edge with both points in pointSet
|
||||||
// }
|
// }
|
||||||
//
|
//
|
||||||
// // Select based on cellShape
|
// // Select based on cellShape
|
||||||
@ -100,7 +100,7 @@ FoamFile
|
|||||||
// sourceInfo
|
// sourceInfo
|
||||||
// {
|
// {
|
||||||
// box (0 0 0) (1 1 1);
|
// box (0 0 0) (1 1 1);
|
||||||
// //boxes ((0 0 0) (1 1 1) (10 10 10)(11 11 11));
|
// // boxes ((0 0 0) (1 1 1) (10 10 10)(11 11 11));
|
||||||
// }
|
// }
|
||||||
//
|
//
|
||||||
// // Cells with cell centre within box
|
// // Cells with cell centre within box
|
||||||
@ -203,7 +203,7 @@ FoamFile
|
|||||||
// {
|
// {
|
||||||
// set c0;
|
// set c0;
|
||||||
// option all; // All faces of cells
|
// option all; // All faces of cells
|
||||||
// //option both; // Only faces whose owner&neighbour are in cellSet
|
// // option both; // Only faces whose owner&neighbour are in cellSet
|
||||||
// }
|
// }
|
||||||
//
|
//
|
||||||
// // Select based on pointSet
|
// // Select based on pointSet
|
||||||
@ -212,8 +212,8 @@ FoamFile
|
|||||||
// {
|
// {
|
||||||
// set p0;
|
// set p0;
|
||||||
// option any; // Faces using any point in pointSet
|
// option any; // Faces using any point in pointSet
|
||||||
// //option all // Faces with all points in pointSet
|
// // option all // Faces with all points in pointSet
|
||||||
// //option edge // Faces with two consecutive points in pointSet
|
// // option edge // Faces with two consecutive points in pointSet
|
||||||
// }
|
// }
|
||||||
//
|
//
|
||||||
// // Select by explicitly providing face labels
|
// // Select by explicitly providing face labels
|
||||||
@ -249,7 +249,7 @@ FoamFile
|
|||||||
// sourceInfo
|
// sourceInfo
|
||||||
// {
|
// {
|
||||||
// box (0 0 0) (1 1 1);
|
// box (0 0 0) (1 1 1);
|
||||||
// //boxes ((0 0 0) (1 1 1) (10 10 10)(11 11 11));
|
// // boxes ((0 0 0) (1 1 1) (10 10 10)(11 11 11));
|
||||||
// }
|
// }
|
||||||
//
|
//
|
||||||
// // Faces with normal to within certain angle aligned with vector.
|
// // Faces with normal to within certain angle aligned with vector.
|
||||||
@ -322,7 +322,7 @@ FoamFile
|
|||||||
// sourceInfo
|
// sourceInfo
|
||||||
// {
|
// {
|
||||||
// box (0 0 0) (1 1 1);
|
// box (0 0 0) (1 1 1);
|
||||||
// //boxes ((0 0 0) (1 1 1) (10 10 10)(11 11 11));
|
// // boxes ((0 0 0) (1 1 1) (10 10 10)(11 11 11));
|
||||||
// }
|
// }
|
||||||
//
|
//
|
||||||
// // Select based on surface
|
// // Select based on surface
|
||||||
@ -390,7 +390,7 @@ FoamFile
|
|||||||
// surface searchableSphere;
|
// surface searchableSphere;
|
||||||
// centre (0.05 0.05 0.005);
|
// centre (0.05 0.05 0.005);
|
||||||
// radius 0.025;
|
// radius 0.025;
|
||||||
// //name sphere.stl; // Optional name if surface triSurfaceMesh
|
// // name sphere.stl; // Optional name if surface triSurfaceMesh
|
||||||
// }
|
// }
|
||||||
// }
|
// }
|
||||||
//
|
//
|
||||||
|
|||||||
@ -110,8 +110,8 @@ multiLevelCoeffs
|
|||||||
level0
|
level0
|
||||||
{
|
{
|
||||||
numberOfSubdomains 64;
|
numberOfSubdomains 64;
|
||||||
//method simple;
|
// method simple;
|
||||||
//simpleCoeffs
|
// simpleCoeffs
|
||||||
//{
|
//{
|
||||||
// n (2 1 1);
|
// n (2 1 1);
|
||||||
// delta 0.001;
|
// delta 0.001;
|
||||||
@ -155,15 +155,15 @@ metisCoeffs
|
|||||||
|
|
||||||
scotchCoeffs
|
scotchCoeffs
|
||||||
{
|
{
|
||||||
//processorWeights
|
// processorWeights
|
||||||
//(
|
//(
|
||||||
// 1
|
// 1
|
||||||
// 1
|
// 1
|
||||||
// 1
|
// 1
|
||||||
// 1
|
// 1
|
||||||
//);
|
//);
|
||||||
//writeGraph true;
|
// writeGraph true;
|
||||||
//strategy "b";
|
// strategy "b";
|
||||||
}
|
}
|
||||||
|
|
||||||
manualCoeffs
|
manualCoeffs
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -328,7 +328,7 @@ void Foam::domainDecomposition::decomposeMesh(const fileName& dict)
|
|||||||
procProcessorPatchSubPatchIDs_[proci].setSize(nInterfaces);
|
procProcessorPatchSubPatchIDs_[proci].setSize(nInterfaces);
|
||||||
procProcessorPatchSubPatchStarts_[proci].setSize(nInterfaces);
|
procProcessorPatchSubPatchStarts_[proci].setSize(nInterfaces);
|
||||||
|
|
||||||
//Info<< "Processor " << proci << endl;
|
// Info<< "Processor " << proci << endl;
|
||||||
|
|
||||||
// Get sorted neighbour processors
|
// Get sorted neighbour processors
|
||||||
const Map<label>& curNbrToInterPatch = procNbrToInterPatch[proci];
|
const Map<label>& curNbrToInterPatch = procNbrToInterPatch[proci];
|
||||||
@ -365,15 +365,15 @@ void Foam::domainDecomposition::decomposeMesh(const fileName& dict)
|
|||||||
subPatchStarts[proci][interPatch]
|
subPatchStarts[proci][interPatch]
|
||||||
);
|
);
|
||||||
|
|
||||||
//Info<< " nbr:" << nbrProc << endl;
|
// Info<< " nbr:" << nbrProc << endl;
|
||||||
//Info<< " interpatch:" << interPatch << endl;
|
// Info<< " interpatch:" << interPatch << endl;
|
||||||
//Info<< " size:" << procProcessorPatchSize_[proci][i] << endl;
|
// Info<< " size:" << procProcessorPatchSize_[proci][i] << endl;
|
||||||
//Info<< " start:" << procProcessorPatchStartIndex_[proci][i]
|
// Info<< " start:" << procProcessorPatchStartIndex_[proci][i]
|
||||||
// << endl;
|
// << endl;
|
||||||
//Info<< " subPatches:"
|
// Info<< " subPatches:"
|
||||||
// << procProcessorPatchSubPatchIDs_[proci][i]
|
// << procProcessorPatchSubPatchIDs_[proci][i]
|
||||||
// << endl;
|
// << endl;
|
||||||
//Info<< " subStarts:"
|
// Info<< " subStarts:"
|
||||||
// << procProcessorPatchSubPatchStarts_[proci][i] << endl;
|
// << procProcessorPatchSubPatchStarts_[proci][i] << endl;
|
||||||
|
|
||||||
// And add all the face labels for interPatch
|
// And add all the face labels for interPatch
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -188,7 +188,7 @@ void Foam::lagrangianFieldDecomposer::decomposeFields
|
|||||||
const PtrList<GeoField>& fields
|
const PtrList<GeoField>& fields
|
||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
//if (particleIndices_.size())
|
// if (particleIndices_.size())
|
||||||
{
|
{
|
||||||
bool valid = particleIndices_.size() > 0;
|
bool valid = particleIndices_.size() > 0;
|
||||||
forAll(fields, fieldi)
|
forAll(fields, fieldi)
|
||||||
@ -206,7 +206,7 @@ void Foam::lagrangianFieldDecomposer::decomposeFieldFields
|
|||||||
const PtrList<GeoField>& fields
|
const PtrList<GeoField>& fields
|
||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
//if (particleIndices_.size())
|
// if (particleIndices_.size())
|
||||||
{
|
{
|
||||||
bool valid = particleIndices_.size() > 0;
|
bool valid = particleIndices_.size() > 0;
|
||||||
forAll(fields, fieldi)
|
forAll(fields, fieldi)
|
||||||
|
|||||||
@ -743,7 +743,7 @@ int main(int argc, char *argv[])
|
|||||||
IOobjectList objects
|
IOobjectList objects
|
||||||
(
|
(
|
||||||
procMesh,
|
procMesh,
|
||||||
databases[0].timeName(), //procMesh.facesInstance()
|
databases[0].timeName(), // procMesh.facesInstance()
|
||||||
polyMesh::meshSubDir/"sets"
|
polyMesh::meshSubDir/"sets"
|
||||||
);
|
);
|
||||||
|
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -209,14 +209,14 @@ Foam::autoPtr<Foam::fvMesh> Foam::loadOrCreateMesh
|
|||||||
)
|
)
|
||||||
);
|
);
|
||||||
dummyMesh.addZones(pz, fz, cz);
|
dummyMesh.addZones(pz, fz, cz);
|
||||||
//Pout<< "Writing dummy mesh to " << dummyMesh.polyMesh::objectPath()
|
// Pout<< "Writing dummy mesh to " << dummyMesh.polyMesh::objectPath()
|
||||||
// << endl;
|
// << endl;
|
||||||
dummyMesh.write();
|
dummyMesh.write();
|
||||||
|
|
||||||
Pstream::parRun() = oldParRun;
|
Pstream::parRun() = oldParRun;
|
||||||
}
|
}
|
||||||
|
|
||||||
//Pout<< "Reading mesh from " << io.objectPath() << endl;
|
// Pout<< "Reading mesh from " << io.objectPath() << endl;
|
||||||
autoPtr<fvMesh> meshPtr(new fvMesh(io));
|
autoPtr<fvMesh> meshPtr(new fvMesh(io));
|
||||||
fvMesh& mesh = meshPtr();
|
fvMesh& mesh = meshPtr();
|
||||||
|
|
||||||
@ -334,7 +334,7 @@ Foam::autoPtr<Foam::fvMesh> Foam::loadOrCreateMesh
|
|||||||
{
|
{
|
||||||
// We created a dummy mesh file above. Delete it.
|
// We created a dummy mesh file above. Delete it.
|
||||||
const fileName meshFiles = io.time().path()/io.instance()/meshSubDir;
|
const fileName meshFiles = io.time().path()/io.instance()/meshSubDir;
|
||||||
//Pout<< "Removing dummy mesh " << meshFiles << endl;
|
// Pout<< "Removing dummy mesh " << meshFiles << endl;
|
||||||
mesh.removeFiles();
|
mesh.removeFiles();
|
||||||
rmDir(meshFiles);
|
rmDir(meshFiles);
|
||||||
}
|
}
|
||||||
|
|||||||
@ -346,7 +346,7 @@ void readFields
|
|||||||
);
|
);
|
||||||
|
|
||||||
//// Write it for next time round (since mesh gets written as well)
|
//// Write it for next time round (since mesh gets written as well)
|
||||||
//fields[i].write();
|
// fields[i].write();
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
else
|
else
|
||||||
@ -725,7 +725,7 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
// Debugging: Create additional volField that will be mapped.
|
// Debugging: Create additional volField that will be mapped.
|
||||||
// Used to test correctness of mapping
|
// Used to test correctness of mapping
|
||||||
//volVectorField mapCc("mapCc", 1*mesh.C());
|
// volVectorField mapCc("mapCc", 1*mesh.C());
|
||||||
|
|
||||||
// Global matching tolerance
|
// Global matching tolerance
|
||||||
const scalar tolDim = getMergeDistance
|
const scalar tolDim = getMergeDistance
|
||||||
@ -738,14 +738,14 @@ int main(int argc, char *argv[])
|
|||||||
// Mesh distribution engine
|
// Mesh distribution engine
|
||||||
fvMeshDistribute distributor(mesh, tolDim);
|
fvMeshDistribute distributor(mesh, tolDim);
|
||||||
|
|
||||||
//Pout<< "Wanted distribution:"
|
// Pout<< "Wanted distribution:"
|
||||||
// << distributor.countCells(finalDecomp) << nl << endl;
|
// << distributor.countCells(finalDecomp) << nl << endl;
|
||||||
|
|
||||||
// Do actual sending/receiving of mesh
|
// Do actual sending/receiving of mesh
|
||||||
autoPtr<mapDistributePolyMesh> map = distributor.distribute(finalDecomp);
|
autoPtr<mapDistributePolyMesh> map = distributor.distribute(finalDecomp);
|
||||||
|
|
||||||
//// Distribute any non-registered data accordingly
|
//// Distribute any non-registered data accordingly
|
||||||
//map().distributeFaceData(faceCc);
|
// map().distributeFaceData(faceCc);
|
||||||
|
|
||||||
|
|
||||||
// Print some statistics
|
// Print some statistics
|
||||||
@ -766,7 +766,7 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
|
|
||||||
// Debugging: test mapped cellcentre field.
|
// Debugging: test mapped cellcentre field.
|
||||||
//compareFields(tolDim, mesh.C(), mapCc);
|
// compareFields(tolDim, mesh.C(), mapCc);
|
||||||
|
|
||||||
// Print nice message
|
// Print nice message
|
||||||
// ~~~~~~~~~~~~~~~~~~
|
// ~~~~~~~~~~~~~~~~~~
|
||||||
|
|||||||
@ -123,7 +123,7 @@ void print(Ostream& os, const wordList& flds)
|
|||||||
labelList getSelectedPatches
|
labelList getSelectedPatches
|
||||||
(
|
(
|
||||||
const polyBoundaryMesh& patches,
|
const polyBoundaryMesh& patches,
|
||||||
const List<wordRe>& excludePatches //HashSet<word>& excludePatches
|
const List<wordRe>& excludePatches // HashSet<word>& excludePatches
|
||||||
)
|
)
|
||||||
{
|
{
|
||||||
DynamicList<label> patchIDs(patches.size());
|
DynamicList<label> patchIDs(patches.size());
|
||||||
@ -316,7 +316,7 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
Info<< "Time: " << runTime.timeName() << endl;
|
Info<< "Time: " << runTime.timeName() << endl;
|
||||||
|
|
||||||
const word timeDesc = name(timeI); //name(runTime.timeIndex());
|
const word timeDesc = name(timeI); // name(runTime.timeIndex());
|
||||||
|
|
||||||
// Check for new polyMesh/ and update mesh, fvMeshSubset and cell
|
// Check for new polyMesh/ and update mesh, fvMeshSubset and cell
|
||||||
// decomposition.
|
// decomposition.
|
||||||
@ -378,22 +378,22 @@ int main(int argc, char *argv[])
|
|||||||
|
|
||||||
PtrList<pointScalarField> psf;
|
PtrList<pointScalarField> psf;
|
||||||
PtrList<pointVectorField> pvf;
|
PtrList<pointVectorField> pvf;
|
||||||
//PtrList<pointSphericalTensorField> pSpheretf;
|
// PtrList<pointSphericalTensorField> pSpheretf;
|
||||||
//PtrList<pointSymmTensorField> pSymmtf;
|
// PtrList<pointSymmTensorField> pSymmtf;
|
||||||
//PtrList<pointTensorField> ptf;
|
// PtrList<pointTensorField> ptf;
|
||||||
|
|
||||||
|
|
||||||
if (!noPointValues)
|
if (!noPointValues)
|
||||||
{
|
{
|
||||||
//// Add interpolated volFields
|
//// Add interpolated volFields
|
||||||
//const volPointInterpolation& pInterp = volPointInterpolation::New
|
// const volPointInterpolation& pInterp = volPointInterpolation::New
|
||||||
//(
|
//(
|
||||||
// mesh
|
// mesh
|
||||||
//);
|
//);
|
||||||
//
|
//
|
||||||
//label nPsf = psf.size();
|
// label nPsf = psf.size();
|
||||||
//psf.setSize(nPsf+vsf.size());
|
// psf.setSize(nPsf+vsf.size());
|
||||||
//forAll(vsf, i)
|
// forAll(vsf, i)
|
||||||
//{
|
//{
|
||||||
// Info<< "Interpolating " << vsf[i].name() << endl;
|
// Info<< "Interpolating " << vsf[i].name() << endl;
|
||||||
// tmp<pointScalarField> tvsf(pInterp.interpolate(vsf[i]));
|
// tmp<pointScalarField> tvsf(pInterp.interpolate(vsf[i]));
|
||||||
@ -402,9 +402,9 @@ int main(int argc, char *argv[])
|
|||||||
// nPsf++;
|
// nPsf++;
|
||||||
//}
|
//}
|
||||||
//
|
//
|
||||||
//label nPvf = pvf.size();
|
// label nPvf = pvf.size();
|
||||||
//pvf.setSize(vvf.size());
|
// pvf.setSize(vvf.size());
|
||||||
//forAll(vvf, i)
|
// forAll(vvf, i)
|
||||||
//{
|
//{
|
||||||
// Info<< "Interpolating " << vvf[i].name() << endl;
|
// Info<< "Interpolating " << vvf[i].name() << endl;
|
||||||
// tmp<pointVectorField> tvvf(pInterp.interpolate(vvf[i]));
|
// tmp<pointVectorField> tvvf(pInterp.interpolate(vvf[i]));
|
||||||
@ -433,7 +433,7 @@ int main(int argc, char *argv[])
|
|||||||
);
|
);
|
||||||
print(" pointVectorFields :", Info, pvf);
|
print(" pointVectorFields :", Info, pvf);
|
||||||
|
|
||||||
//readFields
|
// readFields
|
||||||
//(
|
//(
|
||||||
// vMesh,
|
// vMesh,
|
||||||
// pointMesh::New(vMesh.baseMesh()),
|
// pointMesh::New(vMesh.baseMesh()),
|
||||||
@ -441,9 +441,9 @@ int main(int argc, char *argv[])
|
|||||||
// selectedFields,
|
// selectedFields,
|
||||||
// pSpheretf
|
// pSpheretf
|
||||||
//);
|
//);
|
||||||
//print(" pointSphericalTensorFields :", Info, pSpheretf);
|
// print(" pointSphericalTensorFields :", Info, pSpheretf);
|
||||||
//
|
//
|
||||||
//readFields
|
// readFields
|
||||||
//(
|
//(
|
||||||
// vMesh,
|
// vMesh,
|
||||||
// pointMesh::New(vMesh.baseMesh()),
|
// pointMesh::New(vMesh.baseMesh()),
|
||||||
@ -451,9 +451,9 @@ int main(int argc, char *argv[])
|
|||||||
// selectedFields,
|
// selectedFields,
|
||||||
// pSymmtf
|
// pSymmtf
|
||||||
//);
|
//);
|
||||||
//print(" pointSymmTensorFields :", Info, pSymmtf);
|
// print(" pointSymmTensorFields :", Info, pSymmtf);
|
||||||
//
|
//
|
||||||
//readFields
|
// readFields
|
||||||
//(
|
//(
|
||||||
// vMesh,
|
// vMesh,
|
||||||
// pointMesh::New(vMesh.baseMesh()),
|
// pointMesh::New(vMesh.baseMesh()),
|
||||||
@ -461,7 +461,7 @@ int main(int argc, char *argv[])
|
|||||||
// selectedFields,
|
// selectedFields,
|
||||||
// ptf
|
// ptf
|
||||||
//);
|
//);
|
||||||
//print(" pointTensorFields :", Info, ptf);
|
// print(" pointTensorFields :", Info, ptf);
|
||||||
}
|
}
|
||||||
Info<< endl;
|
Info<< endl;
|
||||||
|
|
||||||
@ -938,7 +938,7 @@ int main(int argc, char *argv[])
|
|||||||
{
|
{
|
||||||
label patchID = patchIDs[i];
|
label patchID = patchIDs[i];
|
||||||
const polyPatch& pp = patches[patchID];
|
const polyPatch& pp = patches[patchID];
|
||||||
//INTEGER4 strandID = 1 + i;
|
// INTEGER4 strandID = 1 + i;
|
||||||
|
|
||||||
if (pp.size() > 0)
|
if (pp.size() > 0)
|
||||||
{
|
{
|
||||||
@ -954,7 +954,7 @@ int main(int argc, char *argv[])
|
|||||||
writer.writePolygonalZone
|
writer.writePolygonalZone
|
||||||
(
|
(
|
||||||
pp.name(),
|
pp.name(),
|
||||||
strandID++, //strandID,
|
strandID++, // strandID,
|
||||||
ipp,
|
ipp,
|
||||||
allVarLocation
|
allVarLocation
|
||||||
);
|
);
|
||||||
@ -1120,7 +1120,7 @@ int main(int argc, char *argv[])
|
|||||||
writer.writePolygonalZone
|
writer.writePolygonalZone
|
||||||
(
|
(
|
||||||
pp.name(),
|
pp.name(),
|
||||||
strandID++, //1+patchIDs.size()+zoneI, //strandID,
|
strandID++, //1+patchIDs.size()+zoneI, // strandID,
|
||||||
ipp,
|
ipp,
|
||||||
allVarLocation
|
allVarLocation
|
||||||
);
|
);
|
||||||
@ -1252,32 +1252,32 @@ int main(int argc, char *argv[])
|
|||||||
Info<< " vectors :";
|
Info<< " vectors :";
|
||||||
print(Info, vectorNames);
|
print(Info, vectorNames);
|
||||||
|
|
||||||
//wordList sphereNames
|
// wordList sphereNames
|
||||||
//(
|
//(
|
||||||
// sprayObjs.names
|
// sprayObjs.names
|
||||||
// (
|
// (
|
||||||
// sphericalTensorIOField::typeName
|
// sphericalTensorIOField::typeName
|
||||||
// )
|
// )
|
||||||
//);
|
//);
|
||||||
//Info<< " spherical tensors :";
|
// Info<< " spherical tensors :";
|
||||||
//print(Info, sphereNames);
|
// print(Info, sphereNames);
|
||||||
//
|
//
|
||||||
//wordList symmNames
|
// wordList symmNames
|
||||||
//(
|
//(
|
||||||
// sprayObjs.names
|
// sprayObjs.names
|
||||||
// (
|
// (
|
||||||
// symmTensorIOField::typeName
|
// symmTensorIOField::typeName
|
||||||
// )
|
// )
|
||||||
//);
|
//);
|
||||||
//Info<< " symm tensors :";
|
// Info<< " symm tensors :";
|
||||||
//print(Info, symmNames);
|
// print(Info, symmNames);
|
||||||
//
|
//
|
||||||
//wordList tensorNames
|
// wordList tensorNames
|
||||||
//(
|
//(
|
||||||
// sprayObjs.names(tensorIOField::typeName)
|
// sprayObjs.names(tensorIOField::typeName)
|
||||||
//);
|
//);
|
||||||
//Info<< " tensors :";
|
// Info<< " tensors :";
|
||||||
//print(Info, tensorNames);
|
// print(Info, tensorNames);
|
||||||
|
|
||||||
|
|
||||||
// Load cloud positions
|
// Load cloud positions
|
||||||
@ -1336,7 +1336,7 @@ int main(int argc, char *argv[])
|
|||||||
writer.writeOrderedZone
|
writer.writeOrderedZone
|
||||||
(
|
(
|
||||||
cloudDirs[cloudI],
|
cloudDirs[cloudI],
|
||||||
strandID++, //strandID,
|
strandID++, // strandID,
|
||||||
parcels.size(),
|
parcels.size(),
|
||||||
allVarLocation
|
allVarLocation
|
||||||
);
|
);
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -53,8 +53,8 @@ Pout<< endl
|
|||||||
<< " of type:" << tecplotFileType
|
<< " of type:" << tecplotFileType
|
||||||
<< endl;
|
<< endl;
|
||||||
|
|
||||||
INTEGER4 IsDouble = 0; //float
|
INTEGER4 IsDouble = 0; // float
|
||||||
INTEGER4 Debug = 0; //nodebug
|
INTEGER4 Debug = 0; // nodebug
|
||||||
if
|
if
|
||||||
(
|
(
|
||||||
!TECINI112
|
!TECINI112
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -50,9 +50,9 @@ void Foam::tecplotWriter::writeField(const Field<Type>& fld) const
|
|||||||
}
|
}
|
||||||
|
|
||||||
INTEGER4 size = INTEGER4(floats.size());
|
INTEGER4 size = INTEGER4(floats.size());
|
||||||
INTEGER4 IsDouble = 0; //float
|
INTEGER4 IsDouble = 0; // float
|
||||||
|
|
||||||
//Pout<< "Writing component:" << cmpt << " of size:" << size
|
// Pout<< "Writing component:" << cmpt << " of size:" << size
|
||||||
// << " floats." << endl;
|
// << " floats." << endl;
|
||||||
|
|
||||||
if (!TECDAT112(&size, floats.begin(), &IsDouble))
|
if (!TECDAT112(&size, floats.begin(), &IsDouble))
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -117,7 +117,7 @@ void ReadAndMapFields
|
|||||||
);
|
);
|
||||||
fld[pointi] = readField.boundaryField()[patchi][localFacei];
|
fld[pointi] = readField.boundaryField()[patchi][localFacei];
|
||||||
}
|
}
|
||||||
//else
|
// else
|
||||||
//{
|
//{
|
||||||
// FatalErrorInFunction
|
// FatalErrorInFunction
|
||||||
// << "Face " << facei << " from index " << index
|
// << "Face " << facei << " from index " << index
|
||||||
@ -125,7 +125,7 @@ void ReadAndMapFields
|
|||||||
//}
|
//}
|
||||||
|
|
||||||
}
|
}
|
||||||
//else
|
// else
|
||||||
//{
|
//{
|
||||||
// WarningInFunction
|
// WarningInFunction
|
||||||
// << "Point " << pointi << " at "
|
// << "Point " << pointi << " at "
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
|
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
|
||||||
\\/ M anipulation |
|
\\/ M anipulation |
|
||||||
-------------------------------------------------------------------------------
|
-------------------------------------------------------------------------------
|
||||||
License
|
License
|
||||||
@ -242,9 +242,9 @@ private:
|
|||||||
//- Cached data for output port0 (experimental!)
|
//- Cached data for output port0 (experimental!)
|
||||||
vtkMultiBlockDataSet* output0_;
|
vtkMultiBlockDataSet* output0_;
|
||||||
|
|
||||||
//BTX
|
// BTX
|
||||||
Foam::vtkPVFoam* foamData_;
|
Foam::vtkPVFoam* foamData_;
|
||||||
//ETX
|
// ETX
|
||||||
};
|
};
|
||||||
|
|
||||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||||
|
|||||||
Some files were not shown because too many files have changed in this diff Show More
Reference in New Issue
Block a user