Templated 3D Vector derived from VectorSpace adding construction from 3 components, element access using x(), y() and z() member functions and the inner-product (dot-product) and cross product operators. More...
Public Types | |
enum | { rank = 1 } |
enum | components { X, Y, Z } |
Component labeling enumeration. More... | |
typedef Vector< label > | labelType |
Equivalent type of labels used for valid component indexing. More... | |
![]() | |
enum | |
typedef Cmpt | cmptType |
Component type. More... | |
Public Member Functions | |
Vector () | |
Construct null. More... | |
template<class Cmpt2 > | |
Vector (const VectorSpace< Vector< Cmpt2 >, Cmpt2, 3 > &) | |
Construct given VectorSpace of the same rank. More... | |
Vector (const Cmpt &vx, const Cmpt &vy, const Cmpt &vz) | |
Construct given three components. More... | |
Vector (Istream &) | |
Construct from Istream. More... | |
const Cmpt & | x () const |
const Cmpt & | y () const |
const Cmpt & | z () const |
Cmpt & | x () |
Cmpt & | y () |
Cmpt & | z () |
const Vector< Cmpt > & | centre (const Foam::List< Vector< Cmpt > > &) const |
Return *this (used for point which is a typedef to Vector<scalar>. More... | |
![]() | |
VectorSpace () | |
Construct null. More... | |
VectorSpace (Istream &) | |
Construct from Istream. More... | |
VectorSpace (const VectorSpace< Vector< Cmpt >, Cmpt, nCmpt > &) | |
Construct as copy. More... | |
VectorSpace (const VectorSpace< Form2, Cmpt2, nCmpt > &) | |
Construct as copy of another VectorSpace type of the same rank. More... | |
label | size () const |
Return the number of elements in the VectorSpace = nCmpt. More... | |
const Cmpt & | component (const direction) const |
Cmpt & | component (const direction) |
void | component (Cmpt &, const direction) const |
void | replace (const direction, const Cmpt &) |
const Cmpt & | operator[] (const direction) const |
Cmpt & | operator[] (const direction) |
void | operator= (const VectorSpace< Vector< Cmpt >, Cmpt, nCmpt > &) |
void | operator+= (const VectorSpace< Vector< Cmpt >, Cmpt, nCmpt > &) |
void | operator-= (const VectorSpace< Vector< Cmpt >, Cmpt, nCmpt > &) |
void | operator*= (const scalar) |
void | operator/= (const scalar) |
Static Public Attributes | |
static const char *const | typeName = "complexVector" |
static const char * | componentNames [] = {"x", "y", "z"} |
static const Vector | zero |
static const Vector | one |
static const Vector | max |
static const Vector | min |
static const Vector | rootMax |
static const Vector | rootMin |
Additional Inherited Members | |
![]() | |
Cmpt | v_ [nCmpt] |
The components of this vector space. More... | |
Templated 3D Vector derived from VectorSpace adding construction from 3 components, element access using x(), y() and z() member functions and the inner-product (dot-product) and cross product operators.
A centre() member function which returns the Vector for which it is called is defined so that point which is a typedef to Vector<scalar> behaves as other shapes in the shape hierachy.
enum components |
|
inline |
Construct given VectorSpace of the same rank.
|
inline |
Construct given three components.
Definition at line 47 of file VectorI.H.
References VectorSpace< Vector< Cmpt >, Cmpt, 3 >::v_, Vector< Cmpt >::X, Vector< Cmpt >::Y, and Vector< Cmpt >::Z.
|
inline |
Definition at line 65 of file VectorI.H.
References VectorSpace< Vector< Cmpt >, Cmpt, 3 >::v_, and Vector< Cmpt >::X.
Referenced by biLinearFitPolynomial::addCoeffs(), cubicUpwindFitPolynomial::addCoeffs(), linearFitPolynomial::addCoeffs(), quadraticFitPolynomial::addCoeffs(), quadraticLinearUpwindFitPolynomial::addCoeffs(), quadraticUpwindFitPolynomial::addCoeffs(), quadraticLinearFitPolynomial::addCoeffs(), triad::align(), tetrahedron< Point, PointRef >::barycentric(), Foam::meshTools::calcBoxPointNormals(), treeBoundBox::calcExtremities(), CentredFitSnGradData< Polynomial >::calcFit(), FitData< FitDataType, ExtendedStencil, Polynomial >::calcFit(), cyclicPolyPatch::calcTransforms(), rotorDiskSource::calculate(), edgeCollapser::checkMeshQuality(), molecule::constantProperties::constantProperties(), boundBox::contains(), boundBox::containsInside(), MaxwellianThermal< CloudType >::correct(), MixedDiffuseSpecular< CloudType >::correct(), cyclicPolyPatch::coupledEdges(), cyclicPolyPatch::coupledPoints(), treeBoundBox::distanceCmp(), Foam::eigenVector(), Foam::eigenVectors(), pitchForkRing::energy(), quaternion::eulerAngles(), treeBoundBox::faceBits(), Foam::faceNij(), Foam::facePoint(), Foam::facePointN(), indexedOctree< Type >::findLine(), dynamicTreeDataPoint::findNearest(), dynamicIndexedOctree< Type >::findNearest(), indexedOctree< Type >::findNearest(), pitchForkRing::force(), polyMesh::geometricD(), boundaryMesh::getNearest(), cylindricalCS::globalToLocal(), cellShapeControlMesh::insert(), cellShapeControlMesh::insertFar(), triangleFuncs::intersectBb(), treeBoundBox::intersects(), Foam::inv(), cellMDLimitedGrad< Type >::limitFace(), cylindricalCS::localToGlobal(), momentOfInertia::massPropertiesSolid(), conformalVoronoiMesh::maxSurfaceProtrusion(), molecule::move(), NamedEnum< Enum, nEnum >::names(), blockDescriptor::nCells(), boundBox::nearest(), twoDPointCorrector::normalDir(), blockDescriptor::nPoints(), Foam::operator&(), treeDataPoint::findNearestOp::operator()(), treeDataEdge::findNearestOp::operator()(), Foam::operator*(), Foam::operator/(), Foam::operator^(), searchablePlate::overlaps(), boundBox::overlaps(), dynamicIndexedOctree< Type >::overlaps(), indexedOctree< Type >::overlaps(), plane::planeCoeffs(), plane::planeIntersect(), polyTopoChange::pointRemoved(), boundBox::points(), treeBoundBox::posBits(), triad::primaryDirection(), quaternion::R(), AC3DsurfaceFormat< Face >::read(), Foam::readUpto(), coordSet::scalarCoord(), treeBoundBox::searchOrder(), KinematicLookupTableInjection< CloudType >::setPositionAndCell(), ReactingLookupTableInjection< CloudType >::setPositionAndCell(), ThermoLookupTableInjection< CloudType >::setPositionAndCell(), ReactingMultiphaseLookupTableInjection< CloudType >::setPositionAndCell(), polyMesh::solutionD(), Foam::sqr(), treeBoundBox::subBbox(), treeBoundBox::subOctant(), surfaceDisplacementPointPatchVectorField::surfaceDisplacementPointPatchVectorField(), Tensor< Cmpt >::Tensor(), Foam::toPoint(), oscillatingRotatingMotion::transformation(), coordinateRotation::transformPrincipal(), pointConstraint::unconstrainedDirections(), vtkInsertNextOpenFOAMPoint(), wallLayerCells::wallLayerCells(), vtkSetWriter< Type >::write(), X3DsurfaceFormat< Face >::write(), WRLsurfaceFormat< Face >::write(), SMESHsurfaceFormat< Face >::write(), GTSsurfaceFormat< Face >::write(), OBJsurfaceFormat< Face >::write(), OBJedgeFormat::write(), AC3DsurfaceFormat< Face >::write(), OBJstream::write(), meshToMeshMethod::writeConnectivity(), VTKsurfaceFormatCore::writeHeader(), VTKedgeFormat::writeHeader(), Foam::meshTools::writeOBJ(), coupledPolyPatch::writeOBJ(), triSurfaceTools::writeOBJ(), cellCuts::writeOBJ(), blockMesh::writeTopology(), moleculeCloud::writeXYZ(), Foam::Xinterpolate(), and Foam::XstepForwardsToNextPoint().
|
inline |
Definition at line 71 of file VectorI.H.
References VectorSpace< Vector< Cmpt >, Cmpt, 3 >::v_, and Vector< Cmpt >::Y.
Referenced by biLinearFitPolynomial::addCoeffs(), cubicUpwindFitPolynomial::addCoeffs(), linearFitPolynomial::addCoeffs(), quadraticFitPolynomial::addCoeffs(), quadraticLinearUpwindFitPolynomial::addCoeffs(), quadraticUpwindFitPolynomial::addCoeffs(), quadraticLinearFitPolynomial::addCoeffs(), triad::align(), tetrahedron< Point, PointRef >::barycentric(), Foam::meshTools::calcBoxPointNormals(), treeBoundBox::calcExtremities(), CentredFitSnGradData< Polynomial >::calcFit(), FitData< FitDataType, ExtendedStencil, Polynomial >::calcFit(), cyclicPolyPatch::calcTransforms(), rotorDiskSource::calculate(), edgeCollapser::checkMeshQuality(), molecule::constantProperties::constantProperties(), boundBox::contains(), boundBox::containsInside(), MaxwellianThermal< CloudType >::correct(), MixedDiffuseSpecular< CloudType >::correct(), cyclicPolyPatch::coupledEdges(), cyclicPolyPatch::coupledPoints(), treeBoundBox::distanceCmp(), Foam::eigenVector(), Foam::eigenVectors(), pitchForkRing::energy(), quaternion::eulerAngles(), treeBoundBox::faceBits(), Foam::faceNij(), Foam::facePoint(), Foam::facePointN(), indexedOctree< Type >::findLine(), dynamicTreeDataPoint::findNearest(), dynamicIndexedOctree< Type >::findNearest(), indexedOctree< Type >::findNearest(), pitchForkRing::force(), boundaryMesh::getNearest(), cylindricalCS::globalToLocal(), cellShapeControlMesh::insert(), cellShapeControlMesh::insertFar(), triangleFuncs::intersectBb(), treeBoundBox::intersects(), Foam::inv(), cellMDLimitedGrad< Type >::limitFace(), cylindricalCS::localToGlobal(), momentOfInertia::massPropertiesSolid(), conformalVoronoiMesh::maxSurfaceProtrusion(), molecule::move(), NamedEnum< Enum, nEnum >::names(), blockDescriptor::nCells(), boundBox::nearest(), twoDPointCorrector::normalDir(), blockDescriptor::nPoints(), Foam::operator&(), treeDataPoint::findNearestOp::operator()(), treeDataEdge::findNearestOp::operator()(), Foam::operator*(), Foam::operator/(), Foam::operator^(), searchablePlate::overlaps(), boundBox::overlaps(), dynamicIndexedOctree< Type >::overlaps(), indexedOctree< Type >::overlaps(), plane::planeCoeffs(), plane::planeIntersect(), polyTopoChange::pointRemoved(), boundBox::points(), treeBoundBox::posBits(), triad::primaryDirection(), quaternion::R(), AC3DsurfaceFormat< Face >::read(), Foam::readUpto(), coordSet::scalarCoord(), treeBoundBox::searchOrder(), Foam::sqr(), treeBoundBox::subBbox(), treeBoundBox::subOctant(), surfaceDisplacementPointPatchVectorField::surfaceDisplacementPointPatchVectorField(), Tensor< Cmpt >::Tensor(), Foam::toPoint(), oscillatingRotatingMotion::transformation(), coordinateRotation::transformPrincipal(), pointConstraint::unconstrainedDirections(), vtkInsertNextOpenFOAMPoint(), wallLayerCells::wallLayerCells(), vtkSetWriter< Type >::write(), X3DsurfaceFormat< Face >::write(), WRLsurfaceFormat< Face >::write(), SMESHsurfaceFormat< Face >::write(), OBJsurfaceFormat< Face >::write(), GTSsurfaceFormat< Face >::write(), AC3DsurfaceFormat< Face >::write(), OBJedgeFormat::write(), OBJstream::write(), meshToMeshMethod::writeConnectivity(), VTKsurfaceFormatCore::writeHeader(), VTKedgeFormat::writeHeader(), Foam::meshTools::writeOBJ(), coupledPolyPatch::writeOBJ(), triSurfaceTools::writeOBJ(), cellCuts::writeOBJ(), blockMesh::writeTopology(), moleculeCloud::writeXYZ(), and Foam::Xinterpolate().
|
inline |
Definition at line 77 of file VectorI.H.
References VectorSpace< Vector< Cmpt >, Cmpt, 3 >::v_, and Vector< Cmpt >::Z.
Referenced by biLinearFitPolynomial::addCoeffs(), cubicUpwindFitPolynomial::addCoeffs(), linearFitPolynomial::addCoeffs(), quadraticFitPolynomial::addCoeffs(), quadraticLinearUpwindFitPolynomial::addCoeffs(), quadraticUpwindFitPolynomial::addCoeffs(), quadraticLinearFitPolynomial::addCoeffs(), triad::align(), tetrahedron< Point, PointRef >::barycentric(), Foam::meshTools::calcBoxPointNormals(), treeBoundBox::calcExtremities(), CentredFitSnGradData< Polynomial >::calcFit(), FitData< FitDataType, ExtendedStencil, Polynomial >::calcFit(), cyclicPolyPatch::calcTransforms(), rotorDiskSource::calculate(), molecule::constantProperties::constantProperties(), boundBox::contains(), boundBox::containsInside(), MaxwellianThermal< CloudType >::correct(), MixedDiffuseSpecular< CloudType >::correct(), cyclicPolyPatch::coupledEdges(), cyclicPolyPatch::coupledPoints(), treeBoundBox::distanceCmp(), Foam::eigenVector(), Foam::eigenVectors(), pitchForkRing::energy(), quaternion::eulerAngles(), treeBoundBox::faceBits(), Foam::faceNij(), Foam::facePoint(), Foam::facePointN(), indexedOctree< Type >::findLine(), dynamicTreeDataPoint::findNearest(), dynamicIndexedOctree< Type >::findNearest(), indexedOctree< Type >::findNearest(), pitchForkRing::force(), boundaryMesh::getNearest(), cylindricalCS::globalToLocal(), cellShapeControlMesh::insert(), cellShapeControlMesh::insertFar(), triangleFuncs::intersectBb(), treeBoundBox::intersects(), Foam::inv(), cellMDLimitedGrad< Type >::limitFace(), cylindricalCS::localToGlobal(), momentOfInertia::massPropertiesSolid(), conformalVoronoiMesh::maxSurfaceProtrusion(), layeredEngineMesh::move(), NamedEnum< Enum, nEnum >::names(), blockDescriptor::nCells(), boundBox::nearest(), twoDPointCorrector::normalDir(), blockDescriptor::nPoints(), Foam::operator&(), treeDataPoint::findNearestOp::operator()(), treeDataEdge::findNearestOp::operator()(), Foam::operator*(), Foam::operator/(), Foam::operator^(), searchablePlate::overlaps(), boundBox::overlaps(), dynamicIndexedOctree< Type >::overlaps(), indexedOctree< Type >::overlaps(), plane::planeCoeffs(), plane::planeIntersect(), polyTopoChange::pointRemoved(), boundBox::points(), treeBoundBox::posBits(), triad::primaryDirection(), quaternion::R(), AC3DsurfaceFormat< Face >::read(), Foam::readUpto(), coordSet::scalarCoord(), treeBoundBox::searchOrder(), Foam::sqr(), treeBoundBox::subBbox(), treeBoundBox::subOctant(), surfaceDisplacementPointPatchVectorField::surfaceDisplacementPointPatchVectorField(), Tensor< Cmpt >::Tensor(), Foam::toPoint(), oscillatingRotatingMotion::transformation(), coordinateRotation::transformPrincipal(), vtkInsertNextOpenFOAMPoint(), wallLayerCells::wallLayerCells(), vtkSetWriter< Type >::write(), X3DsurfaceFormat< Face >::write(), WRLsurfaceFormat< Face >::write(), SMESHsurfaceFormat< Face >::write(), GTSsurfaceFormat< Face >::write(), OBJsurfaceFormat< Face >::write(), AC3DsurfaceFormat< Face >::write(), OBJedgeFormat::write(), OBJstream::write(), meshToMeshMethod::writeConnectivity(), VTKsurfaceFormatCore::writeHeader(), VTKedgeFormat::writeHeader(), Foam::meshTools::writeOBJ(), coupledPolyPatch::writeOBJ(), triSurfaceTools::writeOBJ(), cellCuts::writeOBJ(), blockMesh::writeTopology(), and moleculeCloud::writeXYZ().
|
inline |
Definition at line 84 of file VectorI.H.
References VectorSpace< Vector< Cmpt >, Cmpt, 3 >::v_, and Vector< Cmpt >::X.
|
inline |
Definition at line 90 of file VectorI.H.
References VectorSpace< Vector< Cmpt >, Cmpt, 3 >::v_, and Vector< Cmpt >::Y.
|
inline |
Definition at line 96 of file VectorI.H.
References Vector< Cmpt >::centre(), VectorSpace< Vector< Cmpt >, Cmpt, 3 >::v_, and Vector< Cmpt >::Z.
|
inline |
Return *this (used for point which is a typedef to Vector<scalar>.
Definition at line 106 of file VectorI.H.
References Foam::type().
Referenced by cyclicPolyPatch::coupledEdges(), treeDataPrimitivePatch< PatchType >::overlaps(), KinematicCloud< CloudType >::patchData(), surfaceFeatures::setFromStatus(), extendedEdgeMesh::sortPointsAndEdges(), and Vector< Cmpt >::z().
Definition at line 79 of file Vector.H.
Referenced by searchablePlate::searchablePlate(), and regionSizeDistribution::write().
|
static |
Definition at line 80 of file Vector.H.
Referenced by autoLayerDriver::addLayers(), interRegionExplicitPorositySource::addSup(), meanVelocityForce::addSup(), rotorDiskSource::addSup(), pointConstraint::applyConstraint(), autoSnapDriver::avgCellCentres(), booleanSurface::booleanSurface(), ReactingParcel< ParcelType >::calc(), ReactingMultiphaseParcel< ParcelType >::calc(), ThermoParcel< ParcelType >::calc(), targetCoeffTrim::calcCoeffs(), LiftForce< CloudType >::calcCoupled(), BrownianMotionForce< CloudType >::calcCoupled(), ParticleForce< CloudType >::calcCoupled(), fixedCoeff::calcForce(), DarcyForchheimer::calcForce(), forces::calcForcesMoment(), autoSnapDriver::calcNearestSurface(), GravityForce< CloudType >::calcNonCoupled(), ParticleForce< CloudType >::calcNonCoupled(), cyclicAMIPolyPatch::calcTransforms(), moleculeCloud::calculateForce(), cell::centre(), face::centre(), polyTopoChange::changeMesh(), polyMeshGeometry::checkFaceTwist(), edgeCollapser::checkMeshQuality(), pointConstraint::combine(), ConeInjection< CloudType >::ConeInjection(), ConeNozzleInjection< CloudType >::ConeNozzleInjection(), molecule::constantProperties::constantProperties(), orientation::constrainRotation(), point::constrainTranslation(), contactAngleForce::correct(), advectionDiffusion::correct(), motionSmootherAlgo::correctBoundaryConditions(), targetCoeffTrim::correctTrim(), rotorDiskSource::createCoordinateSystem(), displacementInterpolationMotionSolver::curPoints(), motionSmootherAlgo::curPoints(), geomCellLooper::cut(), MRFZoneList::DDt(), cyclicAMIFvPatch::delta(), cyclicACMIFvPatch::delta(), autoSnapDriver::doSnap(), cylindrical::e1(), cylindrical::e2(), extendedEdgeMesh::edgeDirection(), triSurfaceMesh::edgeTree(), quaternion::eulerAngles(), Foam::exp(), extrudePatchMesh::extrudePatchMesh(), searchableSurfacesQueries::facesIntersection(), indexedOctree< Type >::findNearest(), refinementFeatures::findNearestEdge(), refinementFeatures::findNearestRegionEdge(), searchableSphere::getNormal(), searchablePlate::getNormal(), searchableCylinder::getNormal(), searchableBox::getNormal(), triSurfaceMesh::getNormal(), triSurfaceMeshPointSet::getRefPoint(), treeDataFace::getVolumeType(), particle< Type >::hitWallFaces(), rotorDiskSource::inflowVelocity(), InjectionModel< CloudType >::inject(), InjectionModel< CloudType >::injectSteadyState(), cylindrical::invTransform(), meshRefinement::isGap(), meshRefinement::isNormalGap(), DSMCCloud< ParcelType >::linearMomentumOfSystem(), cell::mag(), primitiveMesh::makeCellCentresAndVols(), meshRefinement::makeDisplacementField(), primitiveMesh::makeFaceCentresAndAreas(), MRFZone::makeRelative(), edgeMesh::mergePoints(), molecule::move(), regionModel1D::moveMesh(), surfaceInterpolation::movePoints(), NamedEnum< Enum, nEnum >::names(), cellCuts::nonAnchorPoints(), surfaceLocation::normal(), face::normal(), listPlusEqOp< T >::operator()(), InflationInjection< CloudType >::parcelsToInject(), searchableCylinder::points(), indexedCell< Gt, Cb >::potentialCoplanarCell(), boundaryMesh::read(), kinematicSingleLayer::resetPrimaryRegionSourceTerms(), sphericalAngularDamper::restrain(), linearDamper::restrain(), sphericalAngularSpring::restrain(), linearAxialAngularSpring::restrain(), linearSpring::restrain(), tabulatedAxialAngularSpring::restrain(), motionSmootherAlgo::scaleMesh(), motionSmootherAlgo::setDisplacementPatchFields(), rotorDiskSource::setFaceArea(), NoInjection< CloudType >::setProperties(), globalMeshData::sharedPoints(), sixDoFRigidBodyMotionSolver::solve(), triSurfaceTools::surfaceNormal(), ThermoSurfaceFilm< CloudType >::tangentVector(), meshRefinement::testSyncPointList(), cylindrical::transform(), porosityModel::transformModelData(), triSurfaceSearch::tree(), triSurfaceRegionSearch::treeByRegion(), pointConstraint::unconstrainedDirections(), StochasticDispersionRAS< CloudType >::update(), uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField::updateCoeffs(), mappedVelocityFluxFixedValueFvPatchField::updateCoeffs(), outletPhaseMeanVelocityFvPatchVectorField::updateCoeffs(), laminar::Us(), coalCloudList::UTrans(), vorticity::vorticity(), wallShearStress::wallShearStress(), mappedPatchBase::write(), medialAxisMeshMover::~medialAxisMeshMover(), and skewCorrectionVectors::~skewCorrectionVectors().
|
static |
Definition at line 81 of file Vector.H.
Referenced by autoLayerDriver::addLayers(), motionDirectionalDiffusivity::correct(), boundBox::inflate(), and searchableSphere::searchableSphere().
|
static |
Definition at line 82 of file Vector.H.
Referenced by autoSnapDriver::doSnap(), mappedPatchBase::findSamples(), removePoints::getUnrefimentSet(), pointEdgeStructuredWalk::inZone(), NamedEnum< Enum, nEnum >::names(), treeDataPoint::findNearestOp::operator()(), treeDataEdge::findNearestOp::operator()(), orientedSurface::orientedSurface(), distributedTriSurfaceMesh::overlappingSurface(), primitiveMesh::pointInCellBB(), polyTopoChange::pointRemoved(), searchableDisk::searchableDisk(), addPatchCellLayer::setRefinement(), removePoints::setUnrefinement(), and pointEdgeStructuredWalk::valid().
|
static |
Definition at line 83 of file Vector.H.
Referenced by NamedEnum< Enum, nEnum >::names(), treeDataPoint::findNearestOp::operator()(), treeDataEdge::findNearestOp::operator()(), distributedTriSurfaceMesh::overlappingSurface(), searchableDisk::searchableDisk(), and searchableSurfaceCollection::searchableSurfaceCollection().
|
static |
Definition at line 84 of file Vector.H.
Referenced by symmetryPlanePolyPatch::calcGeometry(), and wedgePolyPatch::calcGeometry().