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< Form, 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< Form, Cmpt, nCmpt > &) |
void | operator+= (const VectorSpace< Form, Cmpt, nCmpt > &) |
void | operator-= (const VectorSpace< Form, 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 |
|
inline |
Definition at line 65 of file VectorI.H.
Referenced by actuationDiskSource::addActuationDiskAxialInertialResistance(), biLinearFitPolynomial::addCoeffs(), linearFitPolynomial::addCoeffs(), cubicUpwindFitPolynomial::addCoeffs(), quadraticLinearUpwindFitPolynomial::addCoeffs(), quadraticUpwindFitPolynomial::addCoeffs(), quadraticFitPolynomial::addCoeffs(), quadraticLinearFitPolynomial::addCoeffs(), geometrySurface::addGeometryToScene(), radialActuationDiskSource::addRadialActuationDiskAxialInertialResistance(), tabulatedAccelerationSource::addSup(), triad::align(), refineBoundaryLayers::analyseLayers(), tetrahedron::barycentric(), boxScaling::boundingPlanes(), treeBoundBox::calcExtremities(), CentredFitSnGradData< Polynomial >::calcFit(), FitData< CentredFitSnGradData< Polynomial >, extendedCentredCellToFaceStencil, Polynomial >::calcFit(), wedgePolyPatch::calcGeometry(), cyclicPolyPatch::calcTransforms(), rotorDiskSource::calculate(), boxScaling::clone(), DSMCCloud< DSMCParcel< ParcelType > >::collisions(), boundBox::contains(), boundBox::containsInside(), polyMeshGen2DEngine::correctPoints(), cyclicPolyPatch::coupledEdges(), cyclicPolyPatch::coupledPoints(), meshUntangler::cutRegion::createInitialConfiguration(), meshOctree::createInitialOctreeBox(), block::createPoints(), blockMesh::createPoints(), cartesianMeshExtractor::createPolyMesh(), meshOctreeCubeCoordinates::cubeBox(), boxScaling::dict(), treeBoundBox::distanceCmp(), Foam::eigenVectors(), pitchForkRing::energy(), quaternion::eulerAngles(), surfaceOptimizer::evaluateFunc(), surfaceOptimizer::evaluateGradients(), surfaceOptimizer::evaluateStabilisationFactor(), treeBoundBox::faceBits(), edgeCollapser::faceCollapseAxisAndAspectRatio(), Foam::faceNij(), Foam::facePoint(), Foam::facePointN(), meshOctree::findEdgesInBox(), searchableBox::findNearest(), dynamicTreeDataPoint::findNearest(), meshOctree::findNearestCorner(), meshOctree::findNearestEdgePoint(), meshOctree::findNearestSurfacePoint(), meshOctree::findNearestSurfacePointInRegion(), meshOctree::findTrianglesInBox(), pitchForkRing::force(), geomCellLooper::getBase(), boundaryMesh::getNearest(), cylindricalCS::globalToLocal(), immersedBoundaryFvPatchField< Type >::imposeNeumannCondition(), scene::initialise(), moleculeCloud::initialiseMolecules(), writeFuns::insert(), cellShapeControlMesh::insert(), cellShapeControlMesh::insertFar(), treeBoundBox::intersects(), meshOctreeCubeCoordinates::intersectsLine(), lineRefinement::intersectsObject(), Foam::inv(), cellMDLimitedGrad< Type >::limitFace(), cylindricalCS::localToGlobal(), main(), blockDescriptor::makeBlockEdges(), immersedBoundaryFvPatch::makeInvDirichletMatrices(), immersedBoundaryFvPatch::makeInvNeumannMatrices(), cellClassification::markFaces(), momentOfInertia::massPropertiesSolid(), molecule::move(), boundBox::nearest(), meshSurfaceOptimizer::newPositionSurfaceOptimizer(), meshSurfaceOptimizer::nodeDisplacementSurfaceOptimizer(), twoDPointCorrector::normalDir(), onLine(), Foam::operator&(), treeDataPoint::findNearestOp::operator()(), treeDataEdge::findNearestOp::operator()(), Foam::operator*(), Foam::operator/(), boxScaling::operator=(), Foam::operator^(), volumeOptimizer::optimiseDivideAndConquer(), surfaceOptimizer::optimiseDivideAndConquer(), surfaceOptimizer::optimiseSteepestDescent(), indexedOctree< Foam::treeDataFace >::overlaps(), searchablePlate::overlaps(), dynamicIndexedOctree::overlaps(), boundBox::overlaps(), conformalVoronoiMesh::perturbPoint(), plane::planeIntersect(), polyTopoChange::pointRemoved(), treeBoundBox::posBits(), triad::primaryDirection(), indexedOctree< Foam::treeDataFace >::pushPointIntoFace(), dynamicIndexedOctree::pushPointIntoFace(), randomPointInPlane(), AC3DsurfaceFormat< Face >::read(), triSurface::readAC(), canopySource::readRaster(), treeBoundBox::searchOrder(), scene::setCamera(), meshOctreeAutomaticRefinement::setMaxRefLevel(), KinematicLookupTableInjection< CloudType >::setPositionAndCell(), ReactingLookupTableInjection< CloudType >::setPositionAndCell(), ThermoLookupTableInjection< CloudType >::setPositionAndCell(), ReactingMultiphaseLookupTableInjection< CloudType >::setPositionAndCell(), meshOctreeCreator::setRootCubeSizeAndRefParameters(), Foam::sqr(), treeBoundBox::subBbox(), treeBoundBox::subOctant(), Tensor< scalar >::Tensor(), oscillatingRotatingMotion::transformation(), coordinateRotation::transformPrincipal(), pointConstraint::unconstrainedDirections(), wallLayerCells::wallLayerCells(), vtkSetWriter< Type >::write(), X3DsurfaceFormat< Face >::write(), WRLsurfaceFormat< Face >::write(), SMESHsurfaceFormat< Face >::write(), OBJsurfaceFormat< Face >::write(), GTSsurfaceFormat< Face >::write(), AC3DsurfaceFormat< Face >::write(), OBJstream::write(), boxScaling::write(), triSurface::writeAC(), meshToMeshMethod::writeConnectivity(), boxScaling::writeDict(), triSurface::writeDXGeometry(), vtkSurfaceWriter::writeGeometry(), dxSurfaceWriter::writeGeometry(), VTKsurfaceFormatCore::writeHeader(), VTKedgeFormat::writeHeader(), intersectedSurface::writeLocalOBJ(), rawSurfaceWriter::writeLocation(), writeObj(), directions::writeOBJ(), edgeSurface::writeOBJ(), Foam::meshTools::writeOBJ(), intersectedSurface::writeOBJ(), surfaceIntersection::writeOBJ(), coupledPolyPatch::writeOBJ(), triSurfaceTools::writeOBJ(), indexedOctree< Foam::treeDataFace >::writeOBJ(), dynamicIndexedOctree::writeOBJ(), cellCuts::writeOBJ(), TRIsurfaceFormat< Face >::writeShell(), STLsurfaceFormat< Face >::writeShell(), triSurface::writeSTLASCII(), blockMesh::writeTopology(), triSurface::writeTRI(), boundaryLayerOptimisation::writeVTK(), moleculeCloud::writeXYZ(), Foam::Xinterpolate(), and Foam::XstepForwardsToNextPoint().
|
inline |
Definition at line 71 of file VectorI.H.
Referenced by actuationDiskSource::addActuationDiskAxialInertialResistance(), biLinearFitPolynomial::addCoeffs(), linearFitPolynomial::addCoeffs(), quadraticFitPolynomial::addCoeffs(), quadraticLinearUpwindFitPolynomial::addCoeffs(), quadraticUpwindFitPolynomial::addCoeffs(), cubicUpwindFitPolynomial::addCoeffs(), quadraticLinearFitPolynomial::addCoeffs(), geometrySurface::addGeometryToScene(), radialActuationDiskSource::addRadialActuationDiskAxialInertialResistance(), tabulatedAccelerationSource::addSup(), triad::align(), refineBoundaryLayers::analyseLayers(), tetrahedron::barycentric(), boxScaling::boundingPlanes(), treeBoundBox::calcExtremities(), CentredFitSnGradData< Polynomial >::calcFit(), FitData< CentredFitSnGradData< Polynomial >, extendedCentredCellToFaceStencil, Polynomial >::calcFit(), wedgePolyPatch::calcGeometry(), cyclicPolyPatch::calcTransforms(), rotorDiskSource::calculate(), boxScaling::clone(), DSMCCloud< DSMCParcel< ParcelType > >::collisions(), boundBox::contains(), boundBox::containsInside(), polyMeshGen2DEngine::correctPoints(), cyclicPolyPatch::coupledEdges(), cyclicPolyPatch::coupledPoints(), meshUntangler::cutRegion::createInitialConfiguration(), meshOctree::createInitialOctreeBox(), block::createPoints(), blockMesh::createPoints(), cartesianMeshExtractor::createPolyMesh(), meshOctreeCubeCoordinates::cubeBox(), boxScaling::dict(), treeBoundBox::distanceCmp(), Foam::eigenVectors(), pitchForkRing::energy(), quaternion::eulerAngles(), surfaceOptimizer::evaluateFunc(), surfaceOptimizer::evaluateGradients(), surfaceOptimizer::evaluateStabilisationFactor(), treeBoundBox::faceBits(), edgeCollapser::faceCollapseAxisAndAspectRatio(), Foam::faceNij(), Foam::facePoint(), Foam::facePointN(), searchableBox::findNearest(), dynamicTreeDataPoint::findNearest(), meshOctree::findNearestCorner(), meshOctree::findNearestEdgePoint(), meshOctree::findNearestSurfacePoint(), meshOctree::findNearestSurfacePointInRegion(), pitchForkRing::force(), boundaryMesh::getNearest(), cylindricalCS::globalToLocal(), immersedBoundaryFvPatchField< Type >::imposeNeumannCondition(), scene::initialise(), moleculeCloud::initialiseMolecules(), writeFuns::insert(), cellShapeControlMesh::insert(), cellShapeControlMesh::insertFar(), treeBoundBox::intersects(), meshOctreeCubeCoordinates::intersectsLine(), lineRefinement::intersectsObject(), Foam::inv(), cellMDLimitedGrad< Type >::limitFace(), cylindricalCS::localToGlobal(), main(), blockDescriptor::makeBlockEdges(), immersedBoundaryFvPatch::makeInvDirichletMatrices(), immersedBoundaryFvPatch::makeInvNeumannMatrices(), cellClassification::markFaces(), momentOfInertia::massPropertiesSolid(), boundBox::nearest(), meshSurfaceOptimizer::newPositionSurfaceOptimizer(), meshSurfaceOptimizer::nodeDisplacementSurfaceOptimizer(), twoDPointCorrector::normalDir(), onLine(), Foam::operator&(), treeDataPoint::findNearestOp::operator()(), treeDataEdge::findNearestOp::operator()(), Foam::operator*(), Foam::operator/(), boxScaling::operator=(), Foam::operator^(), volumeOptimizer::optimiseDivideAndConquer(), surfaceOptimizer::optimiseDivideAndConquer(), surfaceOptimizer::optimiseSteepestDescent(), indexedOctree< Foam::treeDataFace >::overlaps(), searchablePlate::overlaps(), dynamicIndexedOctree::overlaps(), boundBox::overlaps(), conformalVoronoiMesh::perturbPoint(), plane::planeIntersect(), polyTopoChange::pointRemoved(), treeBoundBox::posBits(), triad::primaryDirection(), indexedOctree< Foam::treeDataFace >::pushPointIntoFace(), dynamicIndexedOctree::pushPointIntoFace(), randomPointInPlane(), AC3DsurfaceFormat< Face >::read(), triSurface::readAC(), canopySource::readRaster(), treeBoundBox::searchOrder(), scene::setCamera(), meshOctreeCreator::setRootCubeSizeAndRefParameters(), Foam::sqr(), treeBoundBox::subBbox(), treeBoundBox::subOctant(), Tensor< scalar >::Tensor(), oscillatingRotatingMotion::transformation(), coordinateRotation::transformPrincipal(), pointConstraint::unconstrainedDirections(), wallLayerCells::wallLayerCells(), vtkSetWriter< Type >::write(), X3DsurfaceFormat< Face >::write(), WRLsurfaceFormat< Face >::write(), SMESHsurfaceFormat< Face >::write(), OBJsurfaceFormat< Face >::write(), GTSsurfaceFormat< Face >::write(), AC3DsurfaceFormat< Face >::write(), OBJstream::write(), boxScaling::write(), triSurface::writeAC(), meshToMeshMethod::writeConnectivity(), boxScaling::writeDict(), triSurface::writeDXGeometry(), vtkSurfaceWriter::writeGeometry(), dxSurfaceWriter::writeGeometry(), VTKsurfaceFormatCore::writeHeader(), VTKedgeFormat::writeHeader(), intersectedSurface::writeLocalOBJ(), rawSurfaceWriter::writeLocation(), writeObj(), directions::writeOBJ(), edgeSurface::writeOBJ(), Foam::meshTools::writeOBJ(), intersectedSurface::writeOBJ(), surfaceIntersection::writeOBJ(), coupledPolyPatch::writeOBJ(), triSurfaceTools::writeOBJ(), indexedOctree< Foam::treeDataFace >::writeOBJ(), dynamicIndexedOctree::writeOBJ(), cellCuts::writeOBJ(), TRIsurfaceFormat< Face >::writeShell(), STLsurfaceFormat< Face >::writeShell(), triSurface::writeSTLASCII(), blockMesh::writeTopology(), triSurface::writeTRI(), boundaryLayerOptimisation::writeVTK(), moleculeCloud::writeXYZ(), and Foam::Xinterpolate().
|
inline |
Definition at line 77 of file VectorI.H.
Referenced by actuationDiskSource::addActuationDiskAxialInertialResistance(), biLinearFitPolynomial::addCoeffs(), linearFitPolynomial::addCoeffs(), cubicUpwindFitPolynomial::addCoeffs(), quadraticLinearUpwindFitPolynomial::addCoeffs(), quadraticUpwindFitPolynomial::addCoeffs(), quadraticFitPolynomial::addCoeffs(), quadraticLinearFitPolynomial::addCoeffs(), geometrySurface::addGeometryToScene(), radialActuationDiskSource::addRadialActuationDiskAxialInertialResistance(), tabulatedAccelerationSource::addSup(), meshSurfaceMapper2D::adjustZCoordinates(), triad::align(), refineBoundaryLayers::analyseLayers(), tetrahedron::barycentric(), boxScaling::boundingPlanes(), treeBoundBox::calcExtremities(), CentredFitSnGradData< Polynomial >::calcFit(), FitData< CentredFitSnGradData< Polynomial >, extendedCentredCellToFaceStencil, Polynomial >::calcFit(), wedgePolyPatch::calcGeometry(), cyclicPolyPatch::calcTransforms(), rotorDiskSource::calculate(), boxScaling::clone(), DSMCCloud< DSMCParcel< ParcelType > >::collisions(), boundBox::contains(), boundBox::containsInside(), polyMeshGen2DEngine::correctPoints(), cyclicPolyPatch::coupledEdges(), cyclicPolyPatch::coupledPoints(), meshUntangler::cutRegion::createInitialConfiguration(), meshOctree::createInitialOctreeBox(), block::createPoints(), blockMesh::createPoints(), cartesianMeshExtractor::createPolyMesh(), triSurface2DCheck::createSubsets(), meshOctreeCubeCoordinates::cubeBox(), boxScaling::dict(), treeBoundBox::distanceCmp(), Foam::eigenVectors(), pitchForkRing::energy(), quaternion::eulerAngles(), triSurfaceExtrude2DEdges::extrudeSurface(), treeBoundBox::faceBits(), Foam::faceNij(), Foam::facePoint(), Foam::facePointN(), searchableBox::findNearest(), dynamicTreeDataPoint::findNearest(), meshOctree::findNearestCorner(), meshOctree::findNearestEdgePoint(), meshOctree::findNearestSurfacePoint(), meshOctree::findNearestSurfacePointInRegion(), polyMeshGen2DEngine::findZMaxPoints(), polyMeshGen2DEngine::findZMinPoints(), pitchForkRing::force(), boundaryMesh::getNearest(), cylindricalCS::globalToLocal(), immersedBoundaryFvPatchField< Type >::imposeNeumannCondition(), scene::initialise(), moleculeCloud::initialiseMolecules(), writeFuns::insert(), cellShapeControlMesh::insert(), cellShapeControlMesh::insertFar(), treeBoundBox::intersects(), meshOctreeCubeCoordinates::intersectsLine(), lineRefinement::intersectsObject(), Foam::inv(), triSurface2DCheck::is2DSurface(), cellMDLimitedGrad< Type >::limitFace(), cylindricalCS::localToGlobal(), main(), blockDescriptor::makeBlockEdges(), immersedBoundaryFvPatch::makeInvDirichletMatrices(), immersedBoundaryFvPatch::makeInvNeumannMatrices(), meshSurfaceMapper2D::mapCorners(), meshSurfaceMapper2D::mapToSmallestDistance(), meshSurfaceMapper2D::mapVerticesOntoSurface(), meshSurfaceMapper2D::mapVerticesOntoSurfacePatches(), cellClassification::markFaces(), momentOfInertia::massPropertiesSolid(), boundBox::nearest(), twoDPointCorrector::normalDir(), onLine(), Foam::operator&(), treeDataPoint::findNearestOp::operator()(), treeDataEdge::findNearestOp::operator()(), Foam::operator*(), Foam::operator/(), boxScaling::operator=(), Foam::operator^(), volumeOptimizer::optimiseDivideAndConquer(), surfaceOptimizer::optimiseSteepestDescent(), indexedOctree< Foam::treeDataFace >::overlaps(), searchablePlate::overlaps(), dynamicIndexedOctree::overlaps(), boundBox::overlaps(), conformalVoronoiMesh::perturbPoint(), plane::planeIntersect(), polyTopoChange::pointRemoved(), treeBoundBox::posBits(), meshSurfaceMapper2D::preMapVertices(), triad::primaryDirection(), indexedOctree< Foam::treeDataFace >::pushPointIntoFace(), dynamicIndexedOctree::pushPointIntoFace(), randomPointInPlane(), AC3DsurfaceFormat< Face >::read(), triSurface::readAC(), treeBoundBox::searchOrder(), scene::setCamera(), meshOctreeCreator::setRootCubeSizeAndRefParameters(), Foam::sqr(), treeBoundBox::subBbox(), treeBoundBox::subOctant(), Tensor< scalar >::Tensor(), oscillatingRotatingMotion::transformation(), coordinateRotation::transformPrincipal(), wallLayerCells::wallLayerCells(), vtkSetWriter< Type >::write(), X3DsurfaceFormat< Face >::write(), WRLsurfaceFormat< Face >::write(), SMESHsurfaceFormat< Face >::write(), OBJsurfaceFormat< Face >::write(), GTSsurfaceFormat< Face >::write(), AC3DsurfaceFormat< Face >::write(), OBJstream::write(), boxScaling::write(), triSurface::writeAC(), meshToMeshMethod::writeConnectivity(), boxScaling::writeDict(), triSurface::writeDXGeometry(), vtkSurfaceWriter::writeGeometry(), dxSurfaceWriter::writeGeometry(), VTKsurfaceFormatCore::writeHeader(), VTKedgeFormat::writeHeader(), intersectedSurface::writeLocalOBJ(), rawSurfaceWriter::writeLocation(), writeObj(), directions::writeOBJ(), edgeSurface::writeOBJ(), Foam::meshTools::writeOBJ(), intersectedSurface::writeOBJ(), surfaceIntersection::writeOBJ(), coupledPolyPatch::writeOBJ(), triSurfaceTools::writeOBJ(), indexedOctree< Foam::treeDataFace >::writeOBJ(), dynamicIndexedOctree::writeOBJ(), cellCuts::writeOBJ(), TRIsurfaceFormat< Face >::writeShell(), STLsurfaceFormat< Face >::writeShell(), triSurface::writeSTLASCII(), blockMesh::writeTopology(), triSurface::writeTRI(), boundaryLayerOptimisation::writeVTK(), and moleculeCloud::writeXYZ().
|
inline |
|
inline |
|
inline |
|
inline |
Return *this (used for point which is a typedef to Vector<scalar>.
Definition at line 106 of file VectorI.H.
Referenced by cellShape::centre(), surfaceFeatures::classifyFeatureAngles(), cyclicPolyPatch::coupledEdges(), KinematicCloud< CloudType >::patchData(), and extendedEdgeMesh::sortPointsAndEdges().
|
static |
|
static |
|
static |
Definition at line 82 of file Vector.H.
Referenced by meshOctreeCubeCoordinates::intersectsTriangle(), treeDataPoint::findNearestOp::operator()(), treeDataEdge::findNearestOp::operator()(), and searchableDisk::searchableDisk().
|
static |
Definition at line 83 of file Vector.H.
Referenced by treeDataPoint::findNearestOp::operator()(), treeDataEdge::findNearestOp::operator()(), searchableDisk::searchableDisk(), and searchableSurfaceCollection::searchableSurfaceCollection().
Copyright © 2011-2018 OpenFOAM | OPENFOAM® is a registered trademark of OpenCFD Ltd.