|
#include <Vector.h>
Public Member Functions | |
Vec3D () | |
constructor More... | |
Vec3D (const SmallVector< 3 > &vector) | |
Vec3D (const Mdouble x, const Mdouble y, const Mdouble z) | |
Alternative constructor, taking the three elements as arguments. More... | |
Vec3D (std::array< double, 3 > a) | |
void | setZero () |
Sets all elements to zero. More... | |
void | setNaN () |
Sets all elements to NaN. More... | |
bool | isZero () const |
Checks if ALL elements are zero. More... | |
bool | isNaN () const |
Checks if ALL elements are zero. More... | |
Vec3D | operator+ (const Vec3D &a) const |
Adds another vector. More... | |
Vec3D | operator- (const Vec3D a) const |
Binary vector subtraction. More... | |
bool | operator== (const Vec3D &a) const |
Vec3D | multiplyElementwise (const Vec3D &a) const |
Vec3D | divideElementwise (const Vec3D &a) const |
Vec3D | signedSquare () const |
Vec3D | operator* (const Mdouble a) const |
Multiplies by a scalar. More... | |
Vec3D | operator/ (Mdouble a) const |
Divides by a scalar. More... | |
Vec3D & | operator+= (const Vec3D &a) |
Adds another vector. More... | |
bool | operator>= (const Vec3D &a) const |
Checks if all coordinates satisfy this>=a. More... | |
bool | operator< (const Vec3D &a) const |
Vec3D & | operator-= (const Vec3D &a) |
Subtracts another vector. More... | |
Vec3D & | operator*= (Mdouble a) |
Multiplies by a scalar. More... | |
Vec3D & | operator/= (const Mdouble a) |
Divides by a scalar. More... | |
void | normalise () |
Makes this Vec3D unit length. More... | |
void | setLength (Mdouble length) |
Make this Vec3D a certain length. More... | |
Mdouble | getLength () const |
Calculates the length of this Vec3D: \( \sqrt{a\cdot a} \). More... | |
Mdouble | getLengthSquared () const |
Calculates the squared length of this Vec3D: \( a\cdot a \). More... | |
Mdouble | getComponent (int index) const |
Returns the requested component of this Vec3D. More... | |
void | setComponent (int index, double val) |
Sets the requested component of this Vec3D to the requested value. More... | |
Mdouble & | x () |
RW reference to X. More... | |
Mdouble | x () const |
RO reference to X. More... | |
Mdouble & | y () |
RW reference to Y. More... | |
Mdouble | y () const |
RO reference to Y. More... | |
Mdouble & | z () |
RW reference to Z. More... | |
Mdouble | z () const |
RO reference to Z. More... | |
void | setX (Mdouble x) |
void | setY (Mdouble y) |
void | setZ (Mdouble z) |
Mdouble | getX () const |
Mdouble | getY () const |
Mdouble | getZ () const |
void | set (Mdouble x, Mdouble y, Mdouble z) |
Mdouble | getRadialCoordinateSquared () const |
Returns the square of the radial cylindrical coordinate, r^2=x^2+y^2. More... | |
Mdouble | getRadialCoordinate () const |
Returns the square of the radial cylindrical coordinate, r=sqrt(x^2+y^2). More... | |
Vec3D | getCylindricalCoordinates () const |
Returns the representation of this Vec3D in cylindrical coordinates. More... | |
Vec3D | getFromCylindricalCoordinates () const |
Returns the representation of this Vec3D in cylindrical coordinates. More... | |
Vec3D | getCylindricalTensorField (const Vec3D &position) const |
Returns this vector field at point p to cylindrical coordinates. More... | |
bool | isEqualTo (const Vec3D &other, double tol) const |
Checks if the length this Vec3D is equal the length of other with a certain tolerance. More... | |
Static Public Member Functions | |
static Mdouble | dot (const Vec3D &a, const Vec3D &b) |
Calculates the dot product of two Vec3D: \( a \cdot b\). More... | |
static Vec3D | max (const Vec3D &a, const Vec3D &b) |
Calculates the pointwise maximum of two Vec3D. More... | |
static Vec3D | min (const Vec3D &a, const Vec3D &b) |
Calculates the pointwise minimum of two Vec3D. More... | |
static double | max (const Vec3D &a) |
Calculates the maximum coordinate of vector a. More... | |
static double | min (const Vec3D &a) |
Calculates the minimum coordinate of vector a. More... | |
static Vec3D | square (const Vec3D &a) |
Calculates the pointwise square of a Vec3D. More... | |
static Vec3D | sqrt (const Vec3D &a) |
Calculates the pointwise square root of a Vec3D. More... | |
static Vec3D | cross (const Vec3D &a, const Vec3D &b) |
Calculates the cross product of two Vec3D: \( a \times b\). More... | |
static Mdouble | getDistance (const Vec3D &a, const Vec3D &b) |
Calculates the distance between two Vec3D: \( \sqrt{\left(a-b\right) \cdot \left(a-b\right)} \). More... | |
static Mdouble | getDistanceSquared (const Vec3D &a, const Vec3D &b) |
Calculates the squared distance between two Vec3D: \( \left(a-b\right) \cdot \left(a-b\right) \). More... | |
static Mdouble | getLength (const Vec3D &a) |
Calculates the length of a Vec3D: \( \sqrt{a\cdot a} \). More... | |
static Mdouble | getLengthSquared (const Vec3D &a) |
Calculates the squared length of a Vec3D: \( a\cdot a \). More... | |
static Vec3D | getUnitVector (const Vec3D &a) |
Returns a unit Vec3D based on a. More... | |
Public Attributes | |
Mdouble | X |
the vector components More... | |
Mdouble | Y |
Mdouble | Z |
Friends | |
std::ostream & | operator<< (std::ostream &os, const Vec3D &a) |
Adds elements to an output stream. More... | |
std::istream & | operator>> (std::istream &is, Vec3D &a) |
Adds elements to an input stream. More... | |
Vec3D | operator- (const Vec3D &a) |
Reverts the direction of a vector. More... | |
Vec3D | operator* (Mdouble a, const Vec3D &b) |
Multiplies all elements by a scalar. More... | |
|
inline |
constructor
References setZero().
Referenced by cross(), divideElementwise(), getCylindricalCoordinates(), getCylindricalTensorField(), getFromCylindricalCoordinates(), getUnitVector(), max(), min(), multiplyElementwise(), operator*(), operator+(), operator-(), operator/(), signedSquare(), sqrt(), and square().
Vec3D::Vec3D | ( | const SmallVector< 3 > & | vector | ) |
Alternative constructor, that constructs a Vec3D from a SmallVector size 3
[in] | vector | Small vector that should be copied |
Alternative constructor, taking the three elements as arguments.
Alternative constructor, lets you define all three elements.
[in] | x | the x-component |
[in] | y | the y-component |
[in] | z | the z-component |
|
inline |
Calculates the cross product of two Vec3D: \( a \times b\).
Calculates the cross product of two vectors NB: this is a STATIC function!
[in] | a | the first vector |
[in] | b | the second vector |
References Vec3D(), X, Y, and Z.
Referenced by MarbleRun::actionsAfterTimeStep(), IntersectionOfWalls::add3PointObject(), ChuteWithHopper::addHopper(), IntersectionOfWalls::addTetra(), IntersectionOfWalls::addTetraSTL(), MeshTriangle::checkInteractions(), DPMBase::computeAllForces(), Mercury3Dclump::computeAllForces(), DPMBase::computeForcesDueToWalls(), Mercury3Dclump::computeForcesDueToWalls(), FrictionInteraction::computeFrictionForce(), MindlinRollingTorsionInteraction::computeFrictionForce(), DPMBase::computeInternalForce(), Mercury3Dclump::computeInternalForce(), ChuteWithPeriodicInflow::computeInternalForces(), IntersectionOfWalls::createOpenPrism(), IntersectionOfWalls::createPrism(), BaseParticle::getAngularMomentum(), MeshTriangle::getBaricentricWeight(), HorizontalBaseScrew::getDistanceAndNormal(), BasicIntersectionOfWalls::getDistanceAndNormal(), BaseWall::getInteractionWith(), TriangleMeshWall::getInteractionWith(), ParticleParticleCollision::getRelativeVelocity(), WallParticleCollision::getRelativeVelocity(), Membrane::Edge::getSineHalfTheta(), BaseInteractable::getVelocityAtContact(), TriangleMeshWall::getVolumeTetrahedron(), InfiniteWall::InfiniteWall(), TriangleWall::isInsideTriangle(), main(), WearableTriangulatedWall::processDebris(), ClumpParticle::rotatePrincipalDirections(), AngledPeriodicBoundary::set(), TriangulatedWall::setNormalsAndNeighbours(), IntersectionOfWalls::setPointsAndLines(), AxisymmetricHopper::setupInitialConditions(), WearableTriangleMeshWall::storeDebris(), WearableTriangulatedWall::storeDebris(), UniformRandomPDs(), ClumpParticle::updatePebblesVelPos(), MeshTriangle::updateVertexAndNormal(), TriangleWall::updateVertexAndNormal(), and WallVTKWriter::writeVTKSurfaceArea().
Calculates the dot product of two Vec3D: \( a \cdot b\).
Calculates the dot product of two vectors. NB: this is a STATIC function!
[in] | a | the first vector |
[in] | b | the second vector |
Referenced by IntersectionOfWalls::addTetraSTL(), Membrane::Edge::applyBendForce(), Membrane::Edge::applyStretchForce(), Membrane::Edge::calculateUPre(), ConstantMassFlowMaserBoundary::checkBoundaryAfterParticleMoved(), CGHandler::computeContactPoints(), FrictionInteraction::computeFrictionForce(), MindlinInteraction::computeFrictionForce(), MindlinRollingTorsionInteraction::computeFrictionForce(), ChuteWithPeriodicInflow::computeInternalForces(), HertzianViscoelasticInteraction::computeNormalForce(), LinearPlasticViscoelasticInteraction::computeNormalForce(), LinearViscoelasticInteraction::computeNormalForce(), SinterInteraction::computeNormalForce(), SinterLinInteraction::computeNormalForce(), SPHInteraction::computeNormalForce(), HertzianSinterInteraction::computeSinterForce(), SlidingFrictionInteraction::computeSlidingSpring(), SlidingFrictionInteraction::computeSlidingSpringSuperQuadric(), HorizontalBaseScrew::convertLimits(), AngledPeriodicBoundary::distance(), BaseInteraction::gatherContactStatistics(), MeshTriangle::getBaricentricWeight(), CGCoordinates::R::getCNormal(), ConstantMassFlowMaserBoundary::getDistance(), SubcriticalMaserBoundary::getDistance(), TriangulatedWall::Face::getDistance(), DeletionBoundary::getDistance(), FluxBoundary::getDistance(), PeriodicBoundary::getDistance(), TimeDependentPeriodicBoundary::getDistance(), NurbsSurface::getDistance(), ArcWall::getDistanceAndNormal(), AxisymmetricIntersectionOfWalls::getDistanceAndNormal(), HorizontalBaseScrew::getDistanceAndNormal(), BasicIntersectionOfWalls::getDistanceAndNormal(), Combtooth::getDistanceAndNormal(), TriangleWall::getDistanceAndNormal(), TriangulatedWall::Face::getDistanceAndNormal(), IntersectionOfWalls::getDistanceAndNormal(), SubcriticalMaserBoundaryTEST::getDistanceFromRight(), InfiniteWall::getDistanceNormalOverlapSuperquadric(), MeshTriangle::getDistanceNormalOverlapType(), DPMBase::getGravitationalEnergy(), CGCoordinates::R::getINormal(), CGCoordinates::XYZ::getINormal(), InteractionHandler::getInteraction(), BaseWall::getInteractionWith(), BaseWall::getLinePlaneIntersect(), AngledPeriodicBoundary::getOpeningAngle(), CGCoordinates::R::getPNormal(), BaseParticle::getRotationalEnergy(), ClumpParticle::getRotationalEnergy(), Membrane::Edge::getSineHalfTheta(), MindlinInteraction::getTangentialOverlap(), Membrane::getVolume(), TriangleMeshWall::getVolumeTetrahedron(), InfiniteWallWithHole::getWallDistance(), FrictionInteraction::integrate(), MindlinRollingTorsionInteraction::integrate(), PeriodicBoundary::isClosestToLeftBoundary(), TimeDependentPeriodicBoundary::isClosestToLeftBoundary(), ConstantMassFlowMaserBoundary::isClosestToRightBoundary(), SubcriticalMaserBoundary::isClosestToRightBoundary(), BaseWall::isInsideWallVTK(), main(), InfiniteWallWithHole::move_time(), SuperQuadricParticle::overlapFromContactPoint(), BaseWall::projectOntoWallVTK(), ClumpParticle::rotatePrincipalDirections(), ClumpParticle::rotateTensorOfInertia(), DeletionBoundary::set(), FluxBoundary::set(), ArcWall::set(), ConstantMassFlowMaserBoundary::set(), PeriodicBoundary::set(), SubcriticalMaserBoundary::set(), InfiniteWallWithHole::set(), TimeDependentPeriodicBoundary::set(), AngledPeriodicBoundary::set(), ChutePeriodic::set_chute_parameters(), Vreman::set_symmetric_contraction(), ContractionWithPeriodicInflow::set_symmetric_contraction(), ChuteWithPeriodicInflowAndContraction::set_symmetric_contraction(), ChuteWithContraction::set_symmetric_contraction(), ConstantMassFlowMaserBoundary::setPlanewiseShift(), PeriodicBoundary::setPlanewiseShift(), SubcriticalMaserBoundary::setPlanewiseShift(), IntersectionOfWalls::setPointsAndLines(), AngledPeriodicBoundary::shiftPosition(), AngledPeriodicBoundary::shiftPositions(), WearableTriangulatedWall::storeDebris(), ClumpParticle::updateExtraQuantities(), MindlinInteraction::updateK_t(), DPMBase::writeEneTimeStep(), LawinenBox::writeEneTimeStep(), BaseCoupling< M, O >::writeEneTimeStep(), SilbertHstop::writeToEne(), and BaseInteraction::writeToFStat().
Mdouble Vec3D::getComponent | ( | int | index | ) | const |
Returns the requested component of this Vec3D.
returns the vector element belonging to the given index.
[in] | index | the index of interest (should be 0, 1 or 2) |
References ERROR, logger, X, Y, and Z.
Referenced by MeshTriangle::checkInteractions(), Dipole::computeMultipoleExpansion(), Domain::containsParticle(), Panel::createPanels(), Domain::findNearbyBoundaries(), Panel::Panel(), Domain::setBounds(), and Domain::setRange().
Vec3D Vec3D::getCylindricalCoordinates | ( | ) | const |
Returns this vector field at point p to cylindrical coordinates.
Transforms the (Cartesian) vector to cylindrical coordinates. See https://en.wikipedia.org/wiki/Vector_fields_in_cylindrical_and_spherical_coordinates
References Vec3D(), X, Y, and Z.
Referenced by main(), CGFields::StandardFields::setCylindricalFields(), and CGFields::GradVelocityField::setCylindricalFields().
Calculates the distance between two Vec3D: \( \sqrt{\left(a-b\right) \cdot \left(a-b\right)} \).
Calculates the square of the distance (i.e. the length of the difference) between two vectors. NB: this is a STATIC function!
[in] | a | the first vector |
[in] | b | the second vector |
Calculates the distance (i.e. the length of the difference) between two vectors NB: this is a STATIC function!
[in] | a | the first vector |
[in] | b | the second vector |
References getDistanceSquared().
Referenced by main(), and Panel::setPanelInteractions().
Calculates the squared distance between two Vec3D: \( \left(a-b\right) \cdot \left(a-b\right) \).
Referenced by Mercury3Dclump::checkClumpForInteraction(), Mercury3Dclump::checkClumpForInteractionPeriodic(), DPMBase::checkParticleForInteractionLocal(), ChuteWithPeriodicInflow::computeInternalForces(), getDistance(), Mercury3D::hGridFindContactsWithTargetCell(), and BaseParticle::isInContactWith().
Vec3D Vec3D::getFromCylindricalCoordinates | ( | ) | const |
Returns the representation of this Vec3D in cylindrical coordinates.
Transforms the (cylindrical) vector to cartesian coordinates
References mathsFunc::cos(), mathsFunc::sin(), Vec3D(), X, Y, and Z.
Mdouble Vec3D::getLength | ( | ) | const |
Calculates the length of this Vec3D: \( \sqrt{a\cdot a} \).
Calculates the length of this vector
References getLengthSquared().
Referenced by CGHandler::computeContactPoints(), AngledPeriodicBoundarySecondUnitTest::computeExternalForces(), ChuteWithPeriodicInflow::computeInternalForces(), SphericalWall::getDistance(), SphericalWall::getDistanceAndNormal(), TriangulatedWall::Face::getDistanceAndNormal(), AngledPeriodicBoundary::set(), AxisymmetricHopper::setupInitialConditions(), and testCGHandler().
Calculates the length of a Vec3D: \( \sqrt{a\cdot a} \).
Calculates the length of a given vector NB: this is a STATIC function!
[in] | a | vector to be measured. |
References getLength().
Referenced by DrivenParticleClass::actionsAfterTimeStep(), NautaMixer::addScrew(), Membrane::Edge::applyBendForce(), BaseCluster::applyCentralForce(), Membrane::Edge::applyStretchForce(), BondedInteraction::bondInPlace(), Membrane::buildMesh(), Combtooth::Combtooth(), Mercury3Dclump::computeAllForces(), CGHandler::computeContactPoints(), MindlinInteraction::computeFrictionForce(), MindlinRollingTorsionInteraction::computeFrictionForce(), ChuteWithPeriodicInflow::computeInternalForces(), ScrewsymmetricIntersectionOfWalls::computeNormalRadialDeltaN(), SlidingFrictionInteraction::computeSlidingSpringSuperQuadric(), BaseInteraction::gatherContactStatistics(), AxisymmetricIntersectionOfWalls::getDistanceAndNormal(), HorizontalBaseScrew::getDistanceAndNormal(), Coil::getDistanceAndNormal(), Combtooth::getDistanceAndNormal(), CylindricalWall::getDistanceAndNormal(), InfiniteWallWithHole::getDistanceAndNormal(), ParabolaChute::getDistanceAndNormal(), SineWall::getDistanceAndNormal(), TriangleWall::getDistanceAndNormal(), VChute::getDistanceAndNormal(), LevelSetWall::getDistanceAndNormalLabCoordinates(), MeshTriangle::getDistanceNormalOverlapType(), getLength(), CGCoordinates::RZ::getLength(), TimeDependentPeriodicBoundary::getPlanewiseShift(), ClumpParticle::getRotationalEnergy(), MindlinInteraction::getTangentialOverlap(), SlidingFrictionInteraction::getTangentialOverlap(), main(), BaseCluster::makeDataAnalysis(), FileReader::read(), ClumpParticle::rotatePrincipalDirections(), Combtooth::set(), Chute::setChuteAngle(), WearableTriangleMeshWall::storeDebris(), ClumpParticle::updateExtraQuantities(), MindlinInteraction::updateK_t(), MeshTriangle::updateVertexAndNormal(), SingleParticle< SpeciesType >::writeEneTimeStep(), BaseInteraction::writeToFStat(), and WallVTKWriter::writeVTKSurfaceArea().
Mdouble Vec3D::getLengthSquared | ( | ) | const |
Calculates the squared length of this Vec3D: \( a\cdot a \).
Calculates the square of the length of itself
Referenced by DPM::computeLocalCGHGrid(), DPM::computeLocalVolumeFraction(), DPM::computeLocalVolumeFractionHGrid(), HorizontalBaseScrew::convertLimits(), Domain::findNewMPIInteractions(), NurbsSurface::getDistance(), HorizontalBaseScrew::getDistanceAndNormal(), TriangulatedWall::Face::getDistanceAndNormal(), CGCoordinates::XYZ::getDistanceSquared(), SuperQuadricParticle::getInitialGuessForContact(), BaseParticle::getInteractionWith(), SuperQuadricParticle::getInteractionWith(), getLength(), CGCoordinates::XYZ::getTangentialSquared(), isEqualTo(), and normalise().
Calculates the squared length of a Vec3D: \( a\cdot a \).
Calculates the square of the length of a given vector. NB: this is a STATIC function!
[in] | a | the vector. |
Referenced by VolumeCoupling::actionsAfterTimeStep(), LawinenBox::actionsBeforeTimeStep(), IntersectionOfWalls::add3PointObject(), ChuteWithHopper::addHopper(), IntersectionOfWalls::addPlate(), IntersectionOfWalls::addTetra(), IntersectionOfWalls::addTetraSTL(), PeriodicBoundary::checkBoundaryAfterParticlesMove(), FrictionInteraction::computeFrictionForce(), MindlinRollingTorsionInteraction::computeFrictionForce(), SlidingFrictionInteraction::computeFrictionForce(), ChuteWithPeriodicInflow::computeInternalForces(), NurbsSurface::getDistance(), IntersectionOfWalls::getDistanceAndNormal(), SimpleDrumSuperquadrics::getDistanceNormalOverlapSuperquadric(), FrictionInteraction::getElasticEnergy(), MindlinInteraction::getElasticEnergy(), MindlinRollingTorsionInteraction::getElasticEnergy(), SlidingFrictionInteraction::getElasticEnergy(), BaseParticle::getKineticEnergy(), ClumpParticle::getRotationalEnergy(), getUnitVector(), InfiniteWall::InfiniteWall(), BaseParticle::integrateBeforeForceComputation(), ClumpParticle::integrateBeforeForceComputation(), LawinenBox::printTime(), setDistance(), DPMBase::setMeanVelocityAndKineticEnergy(), Domain::updateParticlePosition(), and PeriodicBoundaryHandler::updateParticles().
Mdouble Vec3D::getRadialCoordinate | ( | ) | const |
Mdouble Vec3D::getRadialCoordinateSquared | ( | ) | const |
Returns a unit Vec3D based on a.
Calculates the unit vector of a given vector (unless it is a vector with zero length; in that case it returns a 3D vector with each element equal to zero). NB: this is a STATIC function!
[in] | a | the vector of interest |
References getLengthSquared(), and Vec3D().
Referenced by IntersectionOfWalls::createOpenPrism(), IntersectionOfWalls::createPrism(), MindlinInteraction::getTangentialOverlap(), WearableTriangulatedWall::processDebris(), TriangulatedWall::setNormalsAndNeighbours(), CGHandlerSelfTest::setupInitialConditions(), and MindlinInteraction::updateK_t().
|
inline |
References X.
Referenced by MercuryProblem::actionsAfterTimeStep(), VolumeCoupling::checkParticlesInFiniteElems(), VolumeCoupling::computeCouplingOnFEM(), SCoupling< M, O >::computeSCouplingForcesFromTriangles(), VolumeCoupling::computeWeightOnParticles(), VolumeCoupling::getProjectionAndProjected(), and BaseCoupling< M, O >::writeEneTimeStep().
|
inline |
References Y.
Referenced by MercuryProblem::actionsAfterTimeStep(), VolumeCoupling::checkParticlesInFiniteElems(), VolumeCoupling::computeCouplingOnFEM(), SCoupling< M, O >::computeSCouplingForcesFromTriangles(), VolumeCoupling::computeWeightOnParticles(), and VolumeCoupling::getProjectionAndProjected().
|
inline |
References Z.
Referenced by MercuryProblem::actionsAfterTimeStep(), VolumeCoupling::checkParticlesInFiniteElems(), VolumeCoupling::computeCouplingOnFEM(), SCoupling< M, O >::computeSCouplingForcesFromTriangles(), VolumeCoupling::computeWeightOnParticles(), VolumeCoupling::getProjectionAndProjected(), RollingOverTriangleWalls::setupInitialConditions(), and MercuryProblem::setupInitialConditions().
Checks if the length this Vec3D is equal the length of other with a certain tolerance.
Checks if the length of the vector is equal to the one given in the first argument (other), with a tolerance given in the second argument (tol).
[in] | other | the 3D vector to check against |
[in] | tol | the tolerance |
References getLengthSquared().
Referenced by TriangleMeshWall::addToMesh(), STLTriangle::isEqualTo(), and main().
bool Vec3D::isNaN | ( | ) | const |
|
inline |
Checks if ALL elements are zero.
Referenced by MeshTriangle::rotate(), TriangleWall::rotate(), and ArcWallUnitTest::setupInitialConditions().
Calculates the pointwise maximum of two Vec3D.
Calculates the pointwise maximum of two vectors. NB: this is a STATIC function!
[in] | a | the first vector |
[in] | b | the second vector |
References Vec3D(), X, Y, and Z.
Referenced by statistics_while_running< T >::auto_set_domain(), FileReader::read(), TriangleMeshWall::updateBoundingBox(), TriangleMeshWall::updateBoundingBoxGlobal(), MeshTriangle::updateVertexAndNormal(), and TriangleWall::updateVertexAndNormal().
Calculates the pointwise minimum of two Vec3D.
Calculates the pointwise minimum of two vectors. NB: this is a STATIC function!
[in] | a | the first vector |
[in] | b | the second vector |
References Vec3D(), X, Y, and Z.
Referenced by BaseWall::addParticlesAtWall(), statistics_while_running< T >::auto_set_domain(), FileReader::read(), TriangleMeshWall::updateBoundingBox(), TriangleMeshWall::updateBoundingBoxGlobal(), MeshTriangle::updateVertexAndNormal(), and TriangleWall::updateVertexAndNormal().
void Vec3D::normalise | ( | ) |
Makes this Vec3D unit length.
Normalises the vector, i.e. divides all elements by the vectors length (resulting in a vector in the same direction, but with unit length).
References ERROR, getLengthSquared(), and logger.
Referenced by IntersectionOfWalls::addObject(), IntersectionOfWalls::addTetraSTL(), SlidingFrictionInteraction::computeSlidingSpringSuperQuadric(), ArcWall::getDistanceAndNormal(), HorizontalScrew::getDistanceAndNormal(), ScrewsymmetricIntersectionOfWalls::getDistanceAndNormal(), SimpleDrumSuperquadrics::getDistanceAndNormal(), Screw::getDistanceAndNormalLabCoordinates(), SimpleDrumSuperquadrics::getDistanceNormalOverlapSuperquadric(), ClumpParticle::rotatePrincipalDirections(), ArcWall::set(), setLength(), Quaternion::setOrientationViaNormal(), HorizontalMixer::setOuterWalls(), HorizontalMixerWalls::setOuterWalls(), UniformRandomPDs(), MeshTriangle::updateVertexAndNormal(), and TriangleWall::updateVertexAndNormal().
void Vec3D::setComponent | ( | int | index, |
double | val | ||
) |
Sets the requested component of this Vec3D to the requested value.
Sets the element of the vector belonging to the first argument (index) to the value given in the second argument (val).
[in] | index | index of element of interest, |
[in] | val | value to be set |
References ERROR, logger, X, Y, and Z.
Referenced by ScaleCoupling< M, O >::computeCouplingForce(), Panel::createPanels(), Panel::Panel(), and Domain::setBounds().
void Vec3D::setLength | ( | Mdouble | length | ) |
Make this Vec3D a certain length.
Sets the length of the vector to a given scalar (while maintaining the direction).
[in] | length | the length to be set |
References normalise().
void Vec3D::setNaN | ( | ) |
Sets all elements to NaN.
Sets each element to zero.
References constants::NaN, X, Y, and Z.
Referenced by BaseInteraction::BaseInteraction().
|
inline |
Referenced by SCoupling< M, O >::createDPMWallsFromFiniteElems().
|
inline |
Referenced by SCoupling< M, O >::createDPMWallsFromFiniteElems().
|
inline |
Referenced by SCoupling< M, O >::createDPMWallsFromFiniteElems().
void Vec3D::setZero | ( | ) |
Sets all elements to zero.
Sets each element to zero.
Referenced by BaseInteractable::BaseInteractable(), BaseInteraction::BaseInteraction(), BaseParticle::BaseParticle(), Coil::Coil(), ChuteWithPeriodicInflow::computeInternalForces(), FrictionInteraction::FrictionInteraction(), HorizontalScrew::HorizontalScrew(), BaseCluster::makeDataAnalysis(), MindlinInteraction::MindlinInteraction(), MindlinRollingTorsionInteraction::MindlinRollingTorsionInteraction(), BaseInteractable::resetForceTorque(), Screw::Screw(), CGFields::GradVelocityField::setZero(), CGFields::StandardFields::setZero(), SlidingFrictionInteraction::SlidingFrictionInteraction(), StatisticsPoint< T >::StatisticsPoint(), testCGHandler(), Vec3D(), CFile::writeP4C(), and CFile::writeP4W().
|
inline |
Calculates the pointwise square root of a Vec3D.
Calculates the pointwise square root of a given vector. NB: this is a STATIC function!
[in] | a | the vector to be pointwise square rooted |
Calculates the pointwise square of a Vec3D.
Calculates the pointwise square of the vector. NB: this is a STATIC function!
[in] | a | the vector to be squared. |
References Vec3D(), X, Y, and Z.
Referenced by CGFields::GradVelocityField::getSquared(), and CGFields::StandardFields::getSquared().
|
inline |
RW reference to X.
References X.
Referenced by MeshTriangle::getVelocityAtContact(), DPMBase::getXMax(), DPMBase::getXMin(), DPMBase::read(), DPMBase::readNextDataFile(), DPMBase::readOld(), WallHandler::readTriangleWall(), set(), DPMBase::setMax(), DPMBase::setMin(), setX(), DPMBase::setXMax(), DPMBase::setXMin(), and Vec3D().
|
inline |
RW reference to Y.
References Y.
Referenced by MeshTriangle::getVelocityAtContact(), DPMBase::getYMax(), DPMBase::getYMin(), DPMBase::read(), DPMBase::readNextDataFile(), DPMBase::readOld(), WallHandler::readTriangleWall(), set(), DPMBase::setMax(), DPMBase::setMin(), setY(), DPMBase::setYMax(), DPMBase::setYMin(), and Vec3D().
|
inline |
RW reference to Z.
References Z.
Referenced by MeshTriangle::getVelocityAtContact(), DPMBase::getZMax(), DPMBase::getZMin(), DPMBase::read(), DPMBase::readNextDataFile(), DPMBase::readOld(), WallHandler::readTriangleWall(), set(), DPMBase::setMax(), DPMBase::setMin(), setZ(), DPMBase::setZMax(), DPMBase::setZMin(), and Vec3D().
Multiplies all elements by a scalar.
Multiplies each element of a given vector (b) by a given scalar (a). NB: this is a global function and a friend of the Vec3D class. Gets called when a scalar multiplication of the form (Mdouble) * (Vec3D) is performed.
[in] | a | the scalar |
[in] | b | the vector |
|
friend |
Adds elements to an output stream.
Adds all elements of the vector to an output stream. NB: this is a global function and a friend of the Vec3D class!
[in] | os | the output stream, |
[in] | a | The vector of interest |
|
friend |
Adds elements to an input stream.
Reads all elements of a given vector from an input stream. NB: this is a global function and a friend of the Vec3D class!
[in,out] | is | the input stream |
[in,out] | a | the vector to be read in |
Mdouble Vec3D::X |
the vector components
Referenced by ScaleCoupledBeam::actionsAfterSolve(), HertzianBSHPInteractionTwoParticleElasticCollision::actionsAfterSolve(), SphericalSuperQuadricCollision::actionsAfterSolve(), SpeciesTest::actionsAfterSolve(), T_protectiveWall::actionsAfterTimeStep(), ContactDetectionNormalSpheresTest::actionsAfterTimeStep(), ContactDetectionRotatedSpheresTest::actionsAfterTimeStep(), protectiveWall::actionsAfterTimeStep(), DrivenParticleClass::actionsAfterTimeStep(), LawinenBox::actionsBeforeTimeStep(), SmoothChute::actionsBeforeTimeStep(), AngleOfRepose::actionsBeforeTimeStep(), Chutebelt::actionsBeforeTimeStep(), StressStrainControlBoundary::activateStrainRateControl(), ChutePeriodic::add_particles(), NautaMixer::addBaseWall(), NautaMixer::addConeWall(), ChuteWithHopper::addHopper(), NautaMixer::addParticles(), NautaMixer::addParticlesAtWall(), BaseWall::addParticlesAtWall(), ClumpParticle::angularAccelerateClumpIterative(), Quaternion::angularDisplacementTimeDerivative(), Quaternion::angularVelocityBodyFixedFrameToAngularDisplacement(), statistics_while_running< T >::auto_set_domain(), DeletionBoundary::checkBoundaryAfterParticleMoved(), HeaterBoundary::checkBoundaryAfterParticleMoved(), VolumeCoupling::checkParticlesInFiniteElems(), ChuteWithContraction::ChuteWithContraction(), ChuteWithPeriodicInflow::cleanChute(), ChuteWithContraction::cleanChute(), Chute::cleanChute(), ScrewsymmetricIntersectionOfWalls::computeDeltaZ(), ScaleCoupling< M, O >::computeExternalForces(), SuperQuadricParticle::computeHessianLabFixed(), Mercury2D::computeInternalForces(), Mercury3D::computeInternalForces(), ChuteWithPeriodicInflow::computeInternalForces(), BaseCluster::computeInternalStructure(), DPM::computeLocalCGHGrid(), DPM::computeLocalVolumeFractionHGrid(), SuperQuadricParticle::computeMass(), ScrewsymmetricIntersectionOfWalls::computeNormalRadialDeltaN(), SuperQuadricParticle::computeResidualContactDetection(), SuperQuadricParticle::computeShape(), SuperQuadricParticle::computeShapeGradientLabFixed(), Mercury3D::computeWallForces(), AxisymmetricIntersectionOfWalls::convertLimits(), HorizontalBaseScrew::convertLimits(), ScrewsymmetricIntersectionOfWalls::convertLimits(), Funnel::create_funnel(), LawinenBox::create_inflow_particle(), Funnel::create_inflow_particle(), FlowRule::create_inflow_particle(), SilbertPeriodic::create_inflow_particle(), Chute::createBottom(), CircularPeriodicBoundary::createPeriodicParticle(), InfiniteWall::createVTK(), Matrix3D::cross(), cross(), divideElementwise(), dot(), Matrix3D::dyadic(), ChuteWithWedge::extendBottom(), SubcriticalMaserBoundaryTEST::extendBottom(), MembraneDemo::fixMembraneEdges(), BidisperseCubeInsertionBoundary::generateParticle(), BaseWall::getAxis(), MeshTriangle::getBaricentricWeight(), CGCoordinates::RZ::getCNormal(), CGCoordinates::X::getCNormal(), CGCoordinates::XY::getCNormal(), CGCoordinates::XZ::getCNormal(), getComponent(), SuperQuadricParticle::getContactPointPlanB(), getCylindricalCoordinates(), Matrix3D::getCylindricalTensorField(), getCylindricalTensorField(), BaseParticle::getDisplacement2(), HeaterBoundary::getDistance(), CubeDeletionBoundary::getDistance(), Quaternion::getDistance(), AxisymmetricIntersectionOfWalls::getDistanceAndNormal(), HorizontalBaseScrew::getDistanceAndNormal(), HorizontalScrew::getDistanceAndNormal(), ScrewsymmetricIntersectionOfWalls::getDistanceAndNormal(), BasicIntersectionOfWalls::getDistanceAndNormal(), Coil::getDistanceAndNormal(), CylindricalWall::getDistanceAndNormal(), InfiniteWallWithHole::getDistanceAndNormal(), SineWall::getDistanceAndNormal(), VChute::getDistanceAndNormal(), LevelSetWall::getDistanceAndNormalLabCoordinates(), Screw::getDistanceAndNormalLabCoordinates(), getDistanceSquared(), CGCoordinates::RZ::getDistanceSquared(), CGCoordinates::X::getDistanceSquared(), CGCoordinates::XY::getDistanceSquared(), CGCoordinates::XZ::getDistanceSquared(), CGCoordinates::BaseCoordinates::getDomainVolume(), CGCoordinates::R::getDomainVolume(), SCoupling< M, O >::getElementBoundingBox(), getFromCylindricalCoordinates(), InfiniteWall::getFurthestPointSuperQuadric(), InfiniteWallWithHole::getHoleDistance(), LeesEdwardsBoundary::getHorizontalDistance(), ShearBoxBoundary::getHorizontalDistance(), WallSpecies::getInfo(), SuperQuadricParticle::getInitialGuessForContact(), CGCoordinates::RZ::getINormal(), CGCoordinates::X::getINormal(), CGCoordinates::XY::getINormal(), CGCoordinates::XZ::getINormal(), SuperQuadricParticle::getInteractionWithSuperQuad(), SuperQuadricParticle::getJacobianOfContactDetectionObjective(), ClumpParticle::getKineticEnergy(), CGCoordinates::R::getLength(), CGCoordinates::X::getLength(), CGCoordinates::XY::getLength(), CGCoordinates::XYZ::getLength(), CGCoordinates::XZ::getLength(), getLengthSquared(), ParticleHandler::getMassTimesPosition(), getMPISum(), DomainHandler::getParticleDomainGlobalIndex(), CGCoordinates::RZ::getPNormal(), CGCoordinates::X::getPNormal(), CGCoordinates::XY::getPNormal(), CGCoordinates::XZ::getPNormal(), getRadialCoordinate(), getRadialCoordinateSquared(), ParticleParticleCollision::getRelativeVelocityComponents(), WallParticleCollision::getRelativeVelocityComponents(), CGCoordinates::RZ::getTangentialSquared(), CGCoordinates::XY::getTangentialSquared(), CGCoordinates::XZ::getTangentialSquared(), HeaterBoundary::getVolume(), SuperQuadricParticle::getVolume(), CGCoordinates::O::getVolumeOfAveragedDimensions(), CGCoordinates::Y::getVolumeOfAveragedDimensions(), CGCoordinates::YZ::getVolumeOfAveragedDimensions(), CGCoordinates::Z::getVolumeOfAveragedDimensions(), WearableNurbsWall::getVolumeUnderSurface(), WearableNurbsWall::getVolumeUnderSurfaceX(), getX(), DPMBase::getXCenter(), Mercury2D::hGridFindParticleContacts(), Mercury3D::hGridFindParticleContacts(), Mercury2D::hGridGetInteractingParticleList(), Mercury3D::hGridGetInteractingParticleList(), Mercury2D::hGridHasParticleContacts(), Mercury3D::hGridHasParticleContacts(), Mercury2D::hGridUpdateParticle(), Mercury3D::hGridUpdateParticle(), MarbleRun::includeInDomain(), InitialConditions< SpeciesType >::InitialConditions(), HorizontalMixer::introduceParticlesAtWall(), ContactDetectionIntersectionOfWallsTest::introduceParticlesAtWall(), HorizontalMixer::introduceParticlesInDomain(), mathsFunc::isEqual(), SuperQuadricParticle::isInContactWith(), MeshTriangle::isInsideTriangle(), isNaN(), isZero(), LawinenBox::LawinenBox(), Matrix3D::ldivide(), load(), main(), max(), min(), multiplyElementwise(), operator*(), Matrix3D::operator*(), operator*=(), operator+(), operator+=(), operator-(), operator-=(), operator/(), operator/=(), operator<(), operator==(), operator>=(), LiquidMigrationMPI2Test::outputXBallsData(), LiquidMigrationSelfTest::outputXBallsData(), ChuteWithPeriodicInflow::outputXBallsDataParticlee(), SuperQuadricParticle::overlapFromContactPoint(), BaseCluster::particleInsertionSuccessful(), FixedClusterInsertionBoundary::placeParticle(), ChuteInsertionBoundary::placeParticle(), CubeInsertionBoundary::placeParticle(), PolydisperseInsertionBoundary::placeParticle(), RandomClusterInsertionBoundary::placeParticle(), ChuteWithPeriodicInflow::printTime(), RotatingDrumWet::printTime(), ForceLawsMPI2Test::printTime(), BaseCluster::printTime(), DPMBase::readNextDataFile(), WallHandler::readTriangleWall(), TriangulatedWall::readVTK(), save(), MatrixSymmetric3D::selfDyadic(), serialize(), set(), AngledPeriodicBoundary::set(), SuperQuadricParticle::setBoundingRadius(), setComponent(), DPMBase::setDomain(), Quaternion::setEuler(), CGFields::OrientationField::setFields(), BaseCG::setHX(), SuperQuadricParticle::setInertia(), setNaN(), Quaternion::setOrientationViaNormal(), ClumpParticle::setPrincipalDirections_e1(), ClumpParticle::setPrincipalDirections_e2(), ClumpParticle::setPrincipalDirections_e3(), Domain::setRange(), HeaterBoundary::setStrength2D(), HeaterBoundary::setStrength3D(), ClosedCSCWalls::setupInitialConditions(), CSCInit::setupInitialConditions(), CSCWalls::setupInitialConditions(), MercuryLogo::setupInitialConditions(), SmoothChute::setupInitialConditions(), HourGlass::setupInitialConditions(), MinimalExampleDrum::setupInitialConditions(), TimeDependentPeriodicBoundary3DSelfTest::setupInitialConditions(), AngleOfRepose::setupInitialConditions(), GetDistanceAndNormalForIntersectionOfWalls::setupInitialConditions(), GetDistanceAndNormalForScrew::setupInitialConditions(), GetDistanceAndNormalForTriangleWall::setupInitialConditions(), LeesEdwardsSelfTest::setupInitialConditions(), ParticleCreation::setupInitialConditions(), my_problem_HGRID::setupInitialConditions(), GetDistanceAndNormalForTriangleWalls::setupInitialConditions(), TriangulatedScrewSelfTest::setupInitialConditions(), TriangulatedWallSelfTest::setupInitialConditions(), DrumRot::setupInitialConditions(), RotatingDrum::setupInitialConditions(), EllipticalSuperQuadricCollision::setupInitialConditions(), Tutorial11::setupInitialConditions(), ArcWallUnitTest::setupInitialConditions(), MD_demo::setupInitialConditions(), ChuteBottom::setupInitialConditions(), BaseCG::setX(), setX(), setZero(), signedSquare(), CGCoordinates::spaceEvenly(), sqrt(), square(), FlowFrontChute::stretch(), MatrixSymmetric3D::symmetrisedDyadic(), ContactDetectionNormalSpheresTest::test(), Packing::test(), HertzContactRestitutionUnitTest::test(), UniformRandomPDs(), TriangleMeshWall::updateBoundingBoxGlobal(), ScaleCoupling< M, O >::updateCoupledElements(), StressStrainControlBoundary::updateDomainSize(), PeriodicBoundaryHandler::updateMaserParticle(), Vec3D(), SuperQuadricParticle::writeDebugMessageStep2(), SuperQuadricParticle::writeDebugMessageStep3(), DPMBase::writeEneTimeStep(), LawinenBox::writeEneTimeStep(), Drum::writeEneTimeStep(), Slide::writeEneTimeStep(), BaseCoupling< M, O >::writeEneTimeStep(), CFile::writeP4C(), GranuDrum::writeResults(), BaseCluster::writeToCdatFile(), HorizontalScrew::writeVTK(), Screw::writeVTK(), and x().
Mdouble Vec3D::Y |
Referenced by ContactDetectionNormalSpheresTest::actionsAfterTimeStep(), ContactDetectionRotatedSpheresTest::actionsAfterTimeStep(), DrivenParticleClass::actionsAfterTimeStep(), SmoothChute::actionsBeforeTimeStep(), AngleOfRepose::actionsBeforeTimeStep(), Slide::actionsBeforeTimeStep(), StressStrainControlBoundary::activateStrainRateControl(), ChuteWithHopper::addHopper(), NautaMixer::addParticles(), NautaMixer::addParticlesAtWall(), BaseWall::addParticlesAtWall(), ClumpParticle::angularAccelerateClumpIterative(), Quaternion::angularDisplacementTimeDerivative(), Quaternion::angularVelocityBodyFixedFrameToAngularDisplacement(), statistics_while_running< T >::auto_set_domain(), DeletionBoundary::checkBoundaryAfterParticleMoved(), HeaterBoundary::checkBoundaryAfterParticleMoved(), VolumeCoupling::checkParticlesInFiniteElems(), ScrewsymmetricIntersectionOfWalls::computeDeltaZ(), ScaleCoupling< M, O >::computeExternalForces(), SuperQuadricParticle::computeHessianLabFixed(), Mercury2D::computeInternalForces(), Mercury3D::computeInternalForces(), BaseCluster::computeInternalStructure(), DPM::computeLocalCGHGrid(), DPM::computeLocalVolumeFractionHGrid(), SuperQuadricParticle::computeMass(), ScrewsymmetricIntersectionOfWalls::computeNormalRadialDeltaN(), SuperQuadricParticle::computeResidualContactDetection(), SuperQuadricParticle::computeShape(), SuperQuadricParticle::computeShapeGradientLabFixed(), Mercury3D::computeWallForces(), AxisymmetricIntersectionOfWalls::convertLimits(), HorizontalBaseScrew::convertLimits(), ScrewsymmetricIntersectionOfWalls::convertLimits(), Funnel::create_funnel(), LawinenBox::create_inflow_particle(), SegregationWithHopper::create_inflow_particle(), Funnel::create_inflow_particle(), FlowRule::create_inflow_particle(), SilbertPeriodic::create_inflow_particle(), Chute::createBottom(), CircularPeriodicBoundary::createPeriodicParticle(), InfiniteWall::createVTK(), Matrix3D::cross(), cross(), divideElementwise(), dot(), Matrix3D::dyadic(), SubcriticalMaserBoundaryTEST::extendBottom(), MembraneDemo::fixMembraneEdges(), MembraneSelfTest::fixMembraneEdges(), BidisperseCubeInsertionBoundary::generateParticle(), BaseWall::getAxis(), MeshTriangle::getBaricentricWeight(), CGCoordinates::XY::getCNormal(), CGCoordinates::Y::getCNormal(), CGCoordinates::YZ::getCNormal(), getComponent(), SuperQuadricParticle::getContactPointPlanB(), getCylindricalCoordinates(), Matrix3D::getCylindricalTensorField(), getCylindricalTensorField(), BaseParticle::getDisplacement2(), HeaterBoundary::getDistance(), CubeDeletionBoundary::getDistance(), Quaternion::getDistance(), HorizontalScrew::getDistanceAndNormal(), ScrewsymmetricIntersectionOfWalls::getDistanceAndNormal(), BasicIntersectionOfWalls::getDistanceAndNormal(), Coil::getDistanceAndNormal(), CylindricalWall::getDistanceAndNormal(), InfiniteWallWithHole::getDistanceAndNormal(), ParabolaChute::getDistanceAndNormal(), SimpleDrumSuperquadrics::getDistanceAndNormal(), SineWall::getDistanceAndNormal(), VChute::getDistanceAndNormal(), LevelSetWall::getDistanceAndNormalLabCoordinates(), Screw::getDistanceAndNormalLabCoordinates(), SimpleDrumSuperquadrics::getDistanceNormalOverlapSuperquadric(), getDistanceSquared(), CGCoordinates::RZ::getDistanceSquared(), CGCoordinates::XY::getDistanceSquared(), CGCoordinates::Y::getDistanceSquared(), CGCoordinates::YZ::getDistanceSquared(), CGCoordinates::BaseCoordinates::getDomainVolume(), SCoupling< M, O >::getElementBoundingBox(), getFromCylindricalCoordinates(), InfiniteWall::getFurthestPointSuperQuadric(), InfiniteWallWithHole::getHoleDistance(), SuperQuadricParticle::getInitialGuessForContact(), CGCoordinates::XY::getINormal(), CGCoordinates::Y::getINormal(), CGCoordinates::YZ::getINormal(), SuperQuadricParticle::getInteractionWithSuperQuad(), SuperQuadricParticle::getJacobianOfContactDetectionObjective(), ClumpParticle::getKineticEnergy(), CGCoordinates::R::getLength(), CGCoordinates::XY::getLength(), CGCoordinates::XYZ::getLength(), CGCoordinates::Y::getLength(), CGCoordinates::YZ::getLength(), getLengthSquared(), ParticleHandler::getMassTimesPosition(), getMPISum(), DomainHandler::getParticleDomainGlobalIndex(), CGCoordinates::XY::getPNormal(), CGCoordinates::Y::getPNormal(), CGCoordinates::YZ::getPNormal(), getRadialCoordinate(), getRadialCoordinateSquared(), ParticleParticleCollision::getRelativeVelocityComponents(), WallParticleCollision::getRelativeVelocityComponents(), CGCoordinates::XY::getTangentialSquared(), CGCoordinates::YZ::getTangentialSquared(), LeesEdwardsBoundary::getVerticalDistance(), ShearBoxBoundary::getVerticalDistance(), HeaterBoundary::getVolume(), SuperQuadricParticle::getVolume(), CGCoordinates::O::getVolumeOfAveragedDimensions(), CGCoordinates::X::getVolumeOfAveragedDimensions(), CGCoordinates::XZ::getVolumeOfAveragedDimensions(), CGCoordinates::Z::getVolumeOfAveragedDimensions(), WearableNurbsWall::getVolumeUnderSurface(), WearableNurbsWall::getVolumeUnderSurfaceX(), getY(), DPMBase::getYCenter(), Mercury2D::hGridFindParticleContacts(), Mercury3D::hGridFindParticleContacts(), Mercury2D::hGridGetInteractingParticleList(), Mercury3D::hGridGetInteractingParticleList(), Mercury2D::hGridHasParticleContacts(), Mercury3D::hGridHasParticleContacts(), Mercury2D::hGridUpdateParticle(), Mercury3D::hGridUpdateParticle(), MarbleRun::includeInDomain(), InitialConditions< SpeciesType >::InitialConditions(), HorizontalMixer::introduceParticlesAtWall(), ContactDetectionIntersectionOfWallsTest::introduceParticlesAtWall(), HorizontalMixer::introduceParticlesInDomain(), mathsFunc::isEqual(), SuperQuadricParticle::isInContactWith(), MeshTriangle::isInsideTriangle(), isNaN(), isZero(), LawinenBox::LawinenBox(), Matrix3D::ldivide(), load(), main(), max(), min(), multiplyElementwise(), operator*(), Matrix3D::operator*(), operator*=(), operator+(), operator+=(), operator-(), operator-=(), operator/(), operator/=(), operator<(), operator==(), operator>=(), LiquidMigrationMPI2Test::outputXBallsData(), LiquidMigrationSelfTest::outputXBallsData(), ChuteWithPeriodicInflow::outputXBallsDataParticlee(), SuperQuadricParticle::overlapFromContactPoint(), BaseCluster::particleInsertionSuccessful(), FixedClusterInsertionBoundary::placeParticle(), ChuteInsertionBoundary::placeParticle(), CubeInsertionBoundary::placeParticle(), PolydisperseInsertionBoundary::placeParticle(), RandomClusterInsertionBoundary::placeParticle(), BaseCluster::printTime(), DPMBase::readNextDataFile(), WallHandler::readTriangleWall(), TriangulatedWall::readVTK(), save(), MatrixSymmetric3D::selfDyadic(), serialize(), set(), AngledPeriodicBoundary::set(), SuperQuadricParticle::setBoundingRadius(), setComponent(), DPMBase::setDomain(), Quaternion::setEuler(), CGFields::OrientationField::setFields(), BaseCG::setHY(), SuperQuadricParticle::setInertia(), setNaN(), Quaternion::setOrientationViaNormal(), ClumpParticle::setPrincipalDirections_e1(), ClumpParticle::setPrincipalDirections_e2(), ClumpParticle::setPrincipalDirections_e3(), Domain::setRange(), HeaterBoundary::setStrength2D(), HeaterBoundary::setStrength3D(), ClosedCSCWalls::setupInitialConditions(), CSCInit::setupInitialConditions(), CSCWalls::setupInitialConditions(), MercuryLogo::setupInitialConditions(), SmoothChute::setupInitialConditions(), HourGlass::setupInitialConditions(), MinimalExampleDrum::setupInitialConditions(), TimeDependentPeriodicBoundary3DSelfTest::setupInitialConditions(), AngleOfRepose::setupInitialConditions(), LeesEdwardsSelfTest::setupInitialConditions(), ParticleCreation::setupInitialConditions(), my_problem_HGRID::setupInitialConditions(), TriangulatedScrewSelfTest::setupInitialConditions(), TriangulatedWallSelfTest::setupInitialConditions(), RotatingDrum::setupInitialConditions(), EllipticalSuperQuadricCollision::setupInitialConditions(), Tutorial11::setupInitialConditions(), ArcWallUnitTest::setupInitialConditions(), MD_demo::setupInitialConditions(), ChuteBottom::setupInitialConditions(), BaseCG::setY(), setY(), setZero(), signedSquare(), CGCoordinates::spaceEvenly(), sqrt(), square(), MatrixSymmetric3D::symmetrisedDyadic(), Packing::test(), UniformRandomPDs(), TriangleMeshWall::updateBoundingBoxGlobal(), ScaleCoupling< M, O >::updateCoupledElements(), StressStrainControlBoundary::updateDomainSize(), Vec3D(), SuperQuadricParticle::writeDebugMessageStep2(), SuperQuadricParticle::writeDebugMessageStep3(), DPMBase::writeEneTimeStep(), Slide::writeEneTimeStep(), BaseCoupling< M, O >::writeEneTimeStep(), CFile::writeP4C(), BaseCluster::writeToCdatFile(), HorizontalScrew::writeVTK(), Screw::writeVTK(), and y().
Mdouble Vec3D::Z |
Referenced by GranuHeap::actionsAfterTimeStep(), ClosedCSCRestart::actionsAfterTimeStep(), ClosedCSCRun::actionsAfterTimeStep(), ClosedCSCWalls::actionsAfterTimeStep(), MarbleRun::actionsAfterTimeStep(), BouncingSuperQuadric::actionsAfterTimeStep(), ContactDetectionNormalSpheresTest::actionsAfterTimeStep(), ContactDetectionRotatedSpheresTest::actionsAfterTimeStep(), DrivenParticleClass::actionsAfterTimeStep(), LawinenBox::actionsBeforeTimeStep(), SmoothChute::actionsBeforeTimeStep(), Slide::actionsBeforeTimeStep(), StressStrainControlBoundary::activateStrainRateControl(), ChutePeriodic::add_particles(), NautaMixer::addBaseWall(), NautaMixer::addConeWall(), ChuteWithHopper::addHopper(), NautaMixer::addParticles(), NautaMixer::addParticlesAtWall(), BaseWall::addParticlesAtWall(), ClumpParticle::angularAccelerateClumpIterative(), Quaternion::angularDisplacementTimeDerivative(), Quaternion::angularVelocityBodyFixedFrameToAngularDisplacement(), statistics_while_running< T >::auto_set_domain(), statistics_while_running< T >::auto_set_z(), DeletionBoundary::checkBoundaryAfterParticleMoved(), HeaterBoundary::checkBoundaryAfterParticleMoved(), VolumeCoupling::checkParticlesInFiniteElems(), Funnel::cleanChute(), ScrewsymmetricIntersectionOfWalls::computeDeltaZ(), ScaleCoupling< M, O >::computeExternalForces(), SuperQuadricParticle::computeHessianLabFixed(), Mercury3D::computeInternalForces(), BaseCluster::computeInternalStructure(), DPM::computeLocalCGHGrid(), DPM::computeLocalVolumeFractionHGrid(), SuperQuadricParticle::computeMass(), ScrewsymmetricIntersectionOfWalls::computeNormalRadialDeltaN(), SuperQuadricParticle::computeResidualContactDetection(), SuperQuadricParticle::computeShape(), SuperQuadricParticle::computeShapeGradientLabFixed(), Mercury3D::computeWallForces(), ClosedCSCWalls::continueSolve(), AxisymmetricIntersectionOfWalls::convertLimits(), HorizontalBaseScrew::convertLimits(), ScrewsymmetricIntersectionOfWalls::convertLimits(), Funnel::create_funnel(), LawinenBox::create_inflow_particle(), Funnel::create_inflow_particle(), FlowRule::create_inflow_particle(), SilbertPeriodic::create_inflow_particle(), InfiniteWall::createVTK(), Matrix3D::cross(), cross(), divideElementwise(), dot(), Matrix3D::dyadic(), SubcriticalMaserBoundaryTEST::extendBottom(), BidisperseCubeInsertionBoundary::generateParticle(), BaseWall::getAxis(), MeshTriangle::getBaricentricWeight(), CGCoordinates::RZ::getCNormal(), CGCoordinates::XZ::getCNormal(), CGCoordinates::YZ::getCNormal(), CGCoordinates::Z::getCNormal(), getComponent(), SuperQuadricParticle::getContactPointPlanB(), getCylindricalCoordinates(), getCylindricalTensorField(), BaseParticle::getDisplacement2(), HeaterBoundary::getDistance(), CubeDeletionBoundary::getDistance(), Quaternion::getDistance(), AxisymmetricIntersectionOfWalls::getDistanceAndNormal(), HorizontalBaseScrew::getDistanceAndNormal(), HorizontalScrew::getDistanceAndNormal(), ScrewsymmetricIntersectionOfWalls::getDistanceAndNormal(), BasicIntersectionOfWalls::getDistanceAndNormal(), Coil::getDistanceAndNormal(), CylindricalWall::getDistanceAndNormal(), InfiniteWallWithHole::getDistanceAndNormal(), ParabolaChute::getDistanceAndNormal(), SineWall::getDistanceAndNormal(), VChute::getDistanceAndNormal(), LevelSetWall::getDistanceAndNormalLabCoordinates(), Screw::getDistanceAndNormalLabCoordinates(), getDistanceSquared(), CGCoordinates::RZ::getDistanceSquared(), CGCoordinates::XZ::getDistanceSquared(), CGCoordinates::YZ::getDistanceSquared(), CGCoordinates::Z::getDistanceSquared(), CGCoordinates::BaseCoordinates::getDomainVolume(), CGCoordinates::R::getDomainVolume(), SCoupling< M, O >::getElementBoundingBox(), SphericalIndenter::getForceOnIndenter(), getFromCylindricalCoordinates(), InfiniteWall::getFurthestPointSuperQuadric(), SphericalIndenter::getIndenterHeight(), SphericalIndenter::getIndenterVelocity(), WallSpecies::getInfo(), SuperQuadricParticle::getInitialGuessForContact(), CGCoordinates::RZ::getINormal(), CGCoordinates::XZ::getINormal(), CGCoordinates::YZ::getINormal(), CGCoordinates::Z::getINormal(), SuperQuadricParticle::getInteractionWithSuperQuad(), SuperQuadricParticle::getJacobianOfContactDetectionObjective(), ClumpParticle::getKineticEnergy(), CGCoordinates::XYZ::getLength(), CGCoordinates::XZ::getLength(), CGCoordinates::YZ::getLength(), CGCoordinates::Z::getLength(), getLengthSquared(), ParticleHandler::getMassTimesPosition(), getMPISum(), DomainHandler::getParticleDomainGlobalIndex(), CGCoordinates::RZ::getPNormal(), CGCoordinates::XZ::getPNormal(), CGCoordinates::YZ::getPNormal(), CGCoordinates::Z::getPNormal(), CGCoordinates::RZ::getTangentialSquared(), CGCoordinates::XZ::getTangentialSquared(), CGCoordinates::YZ::getTangentialSquared(), HeaterBoundary::getVolume(), SuperQuadricParticle::getVolume(), CGCoordinates::O::getVolumeOfAveragedDimensions(), CGCoordinates::R::getVolumeOfAveragedDimensions(), CGCoordinates::X::getVolumeOfAveragedDimensions(), CGCoordinates::XY::getVolumeOfAveragedDimensions(), CGCoordinates::Y::getVolumeOfAveragedDimensions(), WearableNurbsWall::getVolumeUnderSurface(), WearableNurbsWall::getVolumeUnderSurfaceX(), getZ(), DPMBase::getZCenter(), GranuHeap::GranuHeap(), Mercury3D::hGridFindParticleContacts(), Mercury3D::hGridGetInteractingParticleList(), Mercury3D::hGridHasParticleContacts(), Mercury3D::hGridUpdateParticle(), MarbleRun::includeInDomain(), InitialConditions< SpeciesType >::InitialConditions(), HorizontalMixer::introduceParticlesAtWall(), ContactDetectionIntersectionOfWallsTest::introduceParticlesAtWall(), HorizontalMixer::introduceParticlesInDomain(), mathsFunc::isEqual(), SuperQuadricParticle::isInContactWith(), MeshTriangle::isInsideTriangle(), isNaN(), isZero(), Matrix3D::ldivide(), load(), main(), max(), min(), multiplyElementwise(), operator*(), Matrix3D::operator*(), operator*=(), operator+(), operator+=(), operator-(), operator-=(), operator/(), operator/=(), operator<(), operator==(), operator>=(), LiquidMigrationMPI2Test::outputXBallsData(), LiquidMigrationSelfTest::outputXBallsData(), ChuteWithPeriodicInflow::outputXBallsDataParticlee(), SuperQuadricParticle::overlapFromContactPoint(), BaseCluster::particleInsertionSuccessful(), FixedClusterInsertionBoundary::placeParticle(), ChuteInsertionBoundary::placeParticle(), CubeInsertionBoundary::placeParticle(), PolydisperseInsertionBoundary::placeParticle(), RandomClusterInsertionBoundary::placeParticle(), ClosedCSCRestart::printTime(), ClosedCSCRun::printTime(), ClosedCSCWalls::printTime(), RotatingDrumWet::printTime(), CubeDeletionBoundarySelfTest::printTime(), DeletionBoundarySelfTest::printTime(), BaseCluster::printTime(), DPMBase::readNextDataFile(), WallHandler::readTriangleWall(), TriangulatedWall::readVTK(), save(), ClosedCSCWalls::saveWalls(), MatrixSymmetric3D::selfDyadic(), serialize(), set(), AngledPeriodicBoundary::set(), SuperQuadricParticle::setBoundingRadius(), setComponent(), DPMBase::setDomain(), Quaternion::setEuler(), CGFields::OrientationField::setFields(), BaseCG::setHZ(), SuperQuadricParticle::setInertia(), setNaN(), Quaternion::setOrientationViaNormal(), ClumpParticle::setPrincipalDirections_e1(), ClumpParticle::setPrincipalDirections_e2(), ClumpParticle::setPrincipalDirections_e3(), Domain::setRange(), HeaterBoundary::setStrength2D(), HeaterBoundary::setStrength3D(), ClosedCSCWalls::setupInitialConditions(), CSCInit::setupInitialConditions(), CSCWalls::setupInitialConditions(), MercuryLogo::setupInitialConditions(), SmoothChute::setupInitialConditions(), HourGlass::setupInitialConditions(), MinimalExampleDrum::setupInitialConditions(), TimeDependentPeriodicBoundary3DSelfTest::setupInitialConditions(), GetDistanceAndNormalForIntersectionOfWalls::setupInitialConditions(), GetDistanceAndNormalForScrew::setupInitialConditions(), GetDistanceAndNormalForTriangleWall::setupInitialConditions(), NewtonsCradleSelfTest::setupInitialConditions(), ParticleCreation::setupInitialConditions(), GetDistanceAndNormalForTriangleWalls::setupInitialConditions(), TriangulatedScrewSelfTest::setupInitialConditions(), TriangulatedWallSelfTest::setupInitialConditions(), DrumRot::setupInitialConditions(), RotatingDrum::setupInitialConditions(), InitialConditions< SpeciesType >::setupInitialConditions(), EllipticalSuperQuadricCollision::setupInitialConditions(), Tutorial11::setupInitialConditions(), MD_demo::setupInitialConditions(), ChuteBottom::setupInitialConditions(), BaseCG::setZ(), setZ(), setZero(), ShearBoxBoundary::shiftHorizontalPosition(), signedSquare(), CGCoordinates::spaceEvenly(), sqrt(), square(), MatrixSymmetric3D::symmetrisedDyadic(), Packing::test(), UniformRandomPDs(), TriangleMeshWall::updateBoundingBoxGlobal(), ScaleCoupling< M, O >::updateCoupledElements(), StressStrainControlBoundary::updateDomainSize(), Vec3D(), SuperQuadricParticle::writeDebugMessageStep2(), SuperQuadricParticle::writeDebugMessageStep3(), DPMBase::writeEneTimeStep(), LawinenBox::writeEneTimeStep(), Drum::writeEneTimeStep(), Penetration::writeEneTimeStep(), SingleParticle< SpeciesType >::writeEneTimeStep(), BaseCoupling< M, O >::writeEneTimeStep(), CFile::writeP4C(), GranuDrum::writeResults(), BaseCluster::writeToCdatFile(), HorizontalBaseScrew::writeVTK(), HorizontalScrew::writeVTK(), Screw::writeVTK(), WearableNurbsWall::writeWallDetailsVTK(), and z().