HorizontalBaseScrew Class Reference

A HorizontalBaseScrew is a copy of AxisymmetricIntersectionOfWalls, with an additional, angle-dependent component. More...

#include <HorizontalBaseScrew.h>

+ Inheritance diagram for HorizontalBaseScrew:

Public Member Functions

 HorizontalBaseScrew ()
 Default constructor. More...
 
 HorizontalBaseScrew (const HorizontalBaseScrew &p)
 Copy constructor. More...
 
 HorizontalBaseScrew (Vec3D position, Vec3D orientation, std::vector< normalAndPosition > walls, const ParticleSpecies *species, Mdouble sinA2Max, Mdouble timeMin)
 Constructor setting values. More...
 
 ~HorizontalBaseScrew ()
 Destructor. More...
 
HorizontalBaseScrewoperator= (const HorizontalBaseScrew &other)
 Copy assignment operator. More...
 
HorizontalBaseScrewcopy () const final
 Wall copy method. It calls the copy constructor of this Wall, useful for polymorphism. More...
 
bool getDistanceAndNormal (const BaseParticle &P, Mdouble &distance, Vec3D &normal_return) const final
 Computes the distance from the wall for a given BaseParticle and returns true if there is a collision. If there is a collision, also return the normal vector. More...
 
void read (std::istream &is) final
 reads wall More...
 
void write (std::ostream &os) const final
 outputs wall More...
 
std::string getName () const final
 Returns the name of the object. More...
 
void setAxis (Vec3D a)
 
void convertLimits (Vec3D &min, Vec3D &max) const
 
void writeVTK (VTKContainer &vtk) const override
 
- Public Member Functions inherited from IntersectionOfWalls
 IntersectionOfWalls ()
 Default constructor. More...
 
 IntersectionOfWalls (const IntersectionOfWalls &other)
 Copy constructor. More...
 
 IntersectionOfWalls (const std::vector< normalAndPosition > &walls, const ParticleSpecies *species)
 Constructor setting values. More...
 
 ~IntersectionOfWalls () override
 Destructor. More...
 
IntersectionOfWallsoperator= (const IntersectionOfWalls &other)
 
IntersectionOfWallscopy () const override
 Wall copy method. It calls the copy constructor of this Wall, useful for polymorphism. More...
 
void clear ()
 Removes all parts of the walls. More...
 
void setSpecies (const ParticleSpecies *species)
 sets species of subwalls as well More...
 
void setHandler (WallHandler *wallHandler) override
 A function which sets the WallHandler for this BaseWall. More...
 
unsigned int getNumberOfObjects ()
 Returns the number of objects. More...
 
void addObject (Vec3D normal, Vec3D point)
 Adds a wall to the set of infinite walls, given a normal vector pointing into the wall (i.e. out of the simulation domain), going through the point, so that normal*x=normal*point. More...
 
void addObject (Quaternion orientation, Vec3D position)
 
void add3PointObject (Vec3D PointA, Vec3D PointB, Vec3D PointC)
 
void setPointsAndLines (unsigned int n)
 
void addTetraSTL (Vec3D PointA, Vec3D PointB, Vec3D PointC, Vec3D WallNormal, Mdouble Thickness, int wallidentifier)
 constructs a tetrahedron for an STL file input More...
 
void addTetra (const Vec3D &PointA, const Vec3D &PointB, const Vec3D &PointC, Mdouble &Thickness)
 constructs a tetrahedron from 3 input coordinates More...
 
void addPlate (const Vec3D &PointA, const Vec3D &PointB, const Vec3D &PointC, const Vec3D &WallNormal, const Mdouble &Thickness, int wallidentifier)
 
MERCURYDPM_DEPRECATED void addObject (Vec3D normal, Mdouble position)
 Adds a wall to the set of finite walls, given an normal vector pointing into the wall (i.e. out of the flow domain), to give a plane defined by normal*x=position. More...
 
void createOpenPrism (std::vector< Vec3D > points, Vec3D prismAxis)
 Creates an open prism which is a polygon between the points, except the first and last point, and extends infinitely in the PrismAxis direction. Note that if you view from inside of your geometry, the shape formed by points has to be convex, otherwise it will not create the wall correctly. More...
 
void createPrism (std::vector< Vec3D > points, Vec3D prismAxis)
 Creates an open prism which is a polygon between the points and extends infinitely in the PrismAxis direction. Note that if you view from inside of your geometry, the shape formed by points has to be convex, otherwise it will not create the wall correctly. More...
 
void createOpenPrism (std::vector< Vec3D > points)
 Creates an open prism which is a polygon between the points, except the first and last point, and extends infinitely in the direction perpendicular to the first and second wall. Note that if you view from inside of your geometry, the shape formed by points has to be convex, otherwise it will not create the wall correctly. More...
 
void createPrism (std::vector< Vec3D > points)
 Creates an open prism which is a polygon between the points and extends infinitely in the direction perpendicular to the first and second wall. Note that if you view from inside of your geometry, the shape formed by points has to be convex, otherwise it will not create the wall correctly. More...
 
bool getDistanceAndNormal (const BaseParticle &p, Mdouble &distance, Vec3D &normal_return) const override
 Compute the distance from the wall for a given BaseParticle and return if there is a collision. If there is a collision, also return the normal vector. More...
 
bool getDistanceAndNormal (const Vec3D &position, Mdouble wallInteractionRadius, Mdouble &distance, Vec3D &normal_return) const
 Compute the distance from the wall for a given BaseParticle and return if there is an interaction. If there is an interaction, also return the normal vector. More...
 
void read (std::istream &is) override
 Move the IntersectionOfWalls to a new position, which is a Vec3D from the old position. More...
 
void write (std::ostream &os) const override
 Writes an IntersectionOfWalls to an output stream, for example a restart file. More...
 
std::string getName () const override
 Returns the name of the object, here the string "IntersectionOfWalls". More...
 
void writeVTK (VTKContainer &vtk) const override
 
- Public Member Functions inherited from BaseWall
 BaseWall ()
 Default constructor. More...
 
 BaseWall (const BaseWall &w)
 Copy constructor. More...
 
 ~BaseWall () override
 Default destructor. More...
 
virtual bool getDistanceNormalOverlap (const BaseParticle &P, Mdouble &distance, Vec3D &normal_return, Mdouble &overlap) const
 
virtual bool getDistanceNormalOverlapSuperquadric (const SuperQuadricParticle &p, Mdouble &distance, Vec3D &normal_return, Mdouble &overlap) const
 
virtual Vec3D getFurthestPointSuperQuadric (const Vec3D &normalBodyFixed, const Vec3D &axes, Mdouble eps1, Mdouble eps2) const
 
WallHandlergetHandler () const
 A function which returns the WallHandler that handles this BaseWall. More...
 
void setIndSpecies (unsigned int indSpecies) override
 Define the species of this wall using the index of the species in the SpeciesHandler in this DPMBase. More...
 
void setSpecies (const ParticleSpecies *species)
 Defines the species of the current wall. More...
 
bool isFixed () const override
 
void setForceControl (Vec3D forceGoal, Vec3D gainFactor, Vec3D baseVelocity={0, 0, 0})
 Slowly adjusts the force on a wall towards a specified goal, by adjusting (prescribing) the velocity of the wall. More...
 
virtual bool isLocal (Vec3D &min, Vec3D &max) const
 
bool getLinePlaneIntersect (Vec3D &intersect, const Vec3D &p0, const Vec3D &p1, const Vec3D &n, const Vec3D &p)
 
bool isInsideWallVTK (const Vec3D &point, const Vec3D &normal, const Vec3D &position) const
 
void projectOntoWallVTK (Vec3D &point0, const Vec3D &point1, const Vec3D &normal, const Vec3D &position) const
 
void intersectVTK (std::vector< Vec3D > &points, Vec3D normal, Vec3D position) const
 
virtual BaseInteractiongetInteractionWithSuperQuad (SuperQuadricParticle *p, unsigned timeStamp, InteractionHandler *interactionHandler)
 
void getVTK (std::vector< Vec3D > &points, std::vector< std::vector< double >> &triangleStrips)
 
const Vec3D getAxis () const
 
BaseInteractiongetInteractionWith (BaseParticle *p, unsigned timeStamp, InteractionHandler *interactionHandler) override
 Returns the interaction between this wall and a given particle, nullptr if there is no interaction. More...
 
virtual void actionsOnRestart ()
 No implementation but can be overidden in its derived classes. More...
 
virtual void actionsAfterParticleGhostUpdate ()
 No implementation but can be overidden in its derived classes. More...
 
virtual void handleParticleAddition (unsigned int id, BaseParticle *p)
 Handles the addition of particles to the particleHandler. More...
 
virtual void handleParticleRemoval (unsigned int id)
 Handles the addition of particles to the particleHandler. More...
 
virtual void checkInteractions (InteractionHandler *interactionHandler, unsigned int timeStamp)
 Check if all interactions are valid. More...
 
bool getVTKVisibility () const
 
void setVTKVisibility (bool vtkVisibility)
 
void addRenderedWall (BaseWall *w)
 
BaseWallgetRenderedWall (size_t i) const
 
std::vector< BaseWall * > getRenderedWalls () const
 
void removeRenderedWalls ()
 
void renderWall (VTKContainer &vtk)
 
void addParticlesAtWall (unsigned numElements=50)
 
void setVelocityControl (Vec3D forceGoal, Vec3D gainFactor, Vec3D baseVelocity)
 
virtual void writeWallDetailsVTK (VTKData &data) const
 
virtual void computeWear ()
 
- Public Member Functions inherited from BaseInteractable
 BaseInteractable ()
 Default BaseInteractable constructor. More...
 
 BaseInteractable (const BaseInteractable &p)
 Copy constructor. More...
 
 ~BaseInteractable () override
 Destructor, it simply destructs the BaseInteractable and all the objects it contains. More...
 
unsigned int getIndSpecies () const
 Returns the index of the species associated with the interactable object. More...
 
const ParticleSpeciesgetSpecies () const
 Returns a pointer to the species of this BaseInteractable. More...
 
void setSpecies (const ParticleSpecies *species)
 Sets the species of this BaseInteractable. More...
 
const Vec3DgetForce () const
 Returns the force on this BaseInteractable. More...
 
const Vec3DgetTorque () const
 Returns the torque on this BaseInteractable. More...
 
void setForce (const Vec3D &force)
 Sets the force on this BaseInteractable. More...
 
void setTorque (const Vec3D &torque)
 Sets the torque on this BaseInteractable. More...
 
void addForce (const Vec3D &addForce)
 Adds an amount to the force on this BaseInteractable. More...
 
void addTorque (const Vec3D &addTorque)
 Adds an amount to the torque on this BaseInteractable. More...
 
virtual void resetForceTorque (int numberOfOMPthreads)
 
void sumForceTorqueOMP ()
 
const Vec3DgetPosition () const
 Returns the position of this BaseInteractable. More...
 
const QuaterniongetOrientation () const
 Returns the orientation of this BaseInteractable. More...
 
virtual void setPosition (const Vec3D &position)
 Sets the position of this BaseInteractable. More...
 
void setOrientationViaNormal (Vec3D normal)
 Sets the orientation of this BaseInteractable by defining the vector that results from the rotation of the (1,0,0) vector. More...
 
void setOrientationViaEuler (Vec3D eulerAngle)
 Sets the orientation of this BaseInteractable by defining the euler angles. More...
 
virtual void setOrientation (const Quaternion &orientation)
 Sets the orientation of this BaseInteractable. More...
 
virtual void move (const Vec3D &move)
 Moves this BaseInteractable by adding an amount to the position. More...
 
virtual void rotate (const Vec3D &angularVelocityDt)
 Rotates this BaseInteractable. More...
 
const std::vector< BaseInteraction * > & getInteractions () const
 Returns a list of interactions which belong to this interactable. More...
 
void addInteraction (BaseInteraction *I)
 Adds an interaction to this BaseInteractable. More...
 
bool removeInteraction (BaseInteraction *I)
 Removes an interaction from this BaseInteractable. More...
 
void copyInteractionsForPeriodicParticles (const BaseInteractable &p)
 Copies interactions to this BaseInteractable whenever a periodic copy made. More...
 
void setVelocity (const Vec3D &velocity)
 set the velocity of the BaseInteractable. More...
 
void setAngularVelocity (const Vec3D &angularVelocity)
 set the angular velocity of the BaseInteractble. More...
 
void addVelocity (const Vec3D &velocity)
 adds an increment to the velocity. More...
 
void addAngularVelocity (const Vec3D &angularVelocity)
 add an increment to the angular velocity. More...
 
virtual const Vec3DgetVelocity () const
 Returns the velocity of this interactable. More...
 
virtual const Vec3DgetAngularVelocity () const
 Returns the angular velocity of this interactable. More...
 
void setPrescribedPosition (const std::function< Vec3D(double)> &prescribedPosition)
 Allows the position of an infinite mass interactable to be prescribed. More...
 
void applyPrescribedPosition (double time)
 Computes the position from the user defined prescribed position function. More...
 
void setPrescribedVelocity (const std::function< Vec3D(double)> &prescribedVelocity)
 Allows the velocity of an infinite mass interactable to be prescribed. More...
 
void applyPrescribedVelocity (double time)
 Computes the velocity from the user defined prescribed velocity function. More...
 
void setPrescribedOrientation (const std::function< Quaternion(double)> &prescribedOrientation)
 Allows the orientation of the infinite mass interactbale to be prescribed. More...
 
void applyPrescribedOrientation (double time)
 Computes the orientation from the user defined prescribed orientation function. More...
 
void setPrescribedAngularVelocity (const std::function< Vec3D(double)> &prescribedAngularVelocity)
 Allows the angular velocity of the infinite mass interactable to be prescribed. More...
 
void applyPrescribedAngularVelocity (double time)
 Computes the angular velocity from the user defined prescribed angular velocity. More...
 
virtual const Vec3D getVelocityAtContact (const Vec3D &contact) const
 Returns the velocity at the contact point, use by many force laws. More...
 
void integrateBeforeForceComputation (double time, double timeStep)
 This is part of integrate routine for objects with infinite mass. More...
 
void integrateAfterForceComputation (double time, double timeStep)
 This is part of the integration routine for objects with infinite mass. More...
 
virtual Mdouble getInvMass () const
 
virtual Mdouble getCurvature (const Vec3D &labFixedCoordinates) const
 
virtual bool isFaceContact (const Vec3D &normal) const
 
- Public Member Functions inherited from BaseObject
 BaseObject ()=default
 Default constructor. More...
 
 BaseObject (const BaseObject &p)=default
 Copy constructor, copies all the objects BaseObject contains. More...
 
virtual ~BaseObject ()=default
 virtual destructor More...
 
virtual void moveInHandler (unsigned int index)
 Except that it is virtual, it does the same thing as setIndex() does. More...
 
void setIndex (unsigned int index)
 Allows one to assign an index to an object in the handler/container. More...
 
void setId (unsigned long id)
 Assigns a unique identifier to each object in the handler (container) which remains constant even after the object is deleted from the container/handler. More...
 
unsigned int getIndex () const
 Returns the index of the object in the handler. More...
 
unsigned int getId () const
 Returns the unique identifier of any particular object. More...
 
void setGroupId (unsigned groupId)
 
unsigned getGroupId () const
 

Public Attributes

Mdouble sinA2Max_
 
Mdouble timeMin_
 

Additional Inherited Members

- Static Public Member Functions inherited from BaseWall
static void addToVTK (const std::vector< Vec3D > &points, VTKContainer &vtk)
 Takes the points provided and adds a triangle strip connecting these points to the vtk container. More...
 
- Protected Attributes inherited from IntersectionOfWalls
std::vector< InfiniteWallwallObjects_
 The wall "segments"/directions that together make up the finite wall. More...
 
std::vector< Vec3DC_
 A vector that stores the intersection point of three different InfiniteWall. More...
 

Detailed Description

A HorizontalBaseScrew is a copy of AxisymmetricIntersectionOfWalls, with an additional, angle-dependent component.

All changes w.r.t. AxisymmetricIntersectionOfWalls are encapsulated in //BEGIN CHANGE and //BEGIN CHANGE

Constructor & Destructor Documentation

◆ HorizontalBaseScrew() [1/3]

HorizontalBaseScrew::HorizontalBaseScrew ( )

Default constructor.

11 {
12  //BEGIN CHANGE
13  sinA2Max_ = 0;
14  timeMin_ = 0;
15  //END CHANGE
16  logger(DEBUG, "HorizontalBaseScrew() finished");
17 }
Logger< MERCURYDPM_LOGLEVEL > logger("MercuryKernel")
Definition of different loggers with certain modules. A user can define its own custom logger here.
@ DEBUG
Mdouble sinA2Max_
Definition: HorizontalBaseScrew.h:80
Mdouble timeMin_
Definition: HorizontalBaseScrew.h:81

References DEBUG, logger, sinA2Max_, and timeMin_.

Referenced by copy().

◆ HorizontalBaseScrew() [2/3]

HorizontalBaseScrew::HorizontalBaseScrew ( const HorizontalBaseScrew other)

Copy constructor.

Parameters
[in]otherThe HorizontalBaseScrew that must be copied.
23  : IntersectionOfWalls(other)
24 {
25  //BEGIN CHANGE
26  sinA2Max_ = other.sinA2Max_;
27  timeMin_ = other.timeMin_;
28  //END CHANGE
29  logger(DEBUG, "HorizontalBaseScrew(const HorizontalBaseScrew &p) finished");
30 }
IntersectionOfWalls()
Default constructor.
Definition: IntersectionOfWalls.cc:12

References DEBUG, logger, sinA2Max_, and timeMin_.

◆ HorizontalBaseScrew() [3/3]

HorizontalBaseScrew::HorizontalBaseScrew ( Vec3D  position,
Vec3D  orientation,
std::vector< normalAndPosition walls,
const ParticleSpecies species,
Mdouble  sinA2Max,
Mdouble  timeMin 
)

Constructor setting values.

33  : IntersectionOfWalls(walls, species), sinA2Max_(sinA2Max), timeMin_(timeMin)
34 {
35  setPosition(position);
36  setOrientationViaNormal(orientation);
37 }
void setOrientationViaNormal(Vec3D normal)
Sets the orientation of this BaseInteractable by defining the vector that results from the rotation o...
Definition: BaseInteractable.cc:177
virtual void setPosition(const Vec3D &position)
Sets the position of this BaseInteractable.
Definition: BaseInteractable.h:218

References BaseInteractable::setOrientationViaNormal(), and BaseInteractable::setPosition().

◆ ~HorizontalBaseScrew()

HorizontalBaseScrew::~HorizontalBaseScrew ( )

Destructor.

40 {
41  logger(DEBUG, "~HorizontalBaseScrew() finished.");
42 }

References DEBUG, and logger.

Member Function Documentation

◆ convertLimits()

void HorizontalBaseScrew::convertLimits ( Vec3D min,
Vec3D max 
) const

converts XYZ limits into RZ limits, to properly limit the VTK plotting area.

157  {
158  //define the box in the rz plane
159  double x[2] = {min.X, max.X};
160  double y[2] = {min.Y, max.Y};
161  double z[2] = {min.Z, max.Z};
163  Vec3D o = q.getAxis();
164 
165  //look at the corner points of the domain and see that the wall is displayed in the domain (possibly a bit outside as well)
166  min -= getPosition();
167  q.rotate(min); //set min/max initial values to values of first corner point
168  max = min;
169  Mdouble maxXSquared = 0;
170  //
171  for (unsigned i=0; i<2; i++)
172  for (unsigned j=0; j<2; j++)
173  for (unsigned k=0; k<2; k++) {
174  Vec3D p = Vec3D(x[i],y[j],z[k])-getPosition();
175  Mdouble Z = Vec3D::dot(p,o);
176  Mdouble XSquared = Vec3D::getLengthSquared(p-Z*o);
177  if (XSquared>maxXSquared) maxXSquared=XSquared;
178  if (Z<min.Z) min.Z=Z;
179  if (Z>max.Z) max.Z=Z;
180  }
181  min.X = 0;
182  max.X = sqrt(maxXSquared);
183  min.Y = 0;
184  max.Y = 0.001; //unused
185  //logger(ERROR,"min % max %",min,max);
186 }
AnnoyingScalar sqrt(const AnnoyingScalar &x)
Definition: AnnoyingScalar.h:134
int i
Definition: BiCGSTAB_step_by_step.cpp:9
float * p
Definition: Tutorial_Map_using.cpp:9
const Quaternion & getOrientation() const
Returns the orientation of this BaseInteractable.
Definition: BaseInteractable.h:209
const Vec3D & getPosition() const
Returns the position of this BaseInteractable.
Definition: BaseInteractable.h:197
This class contains the 4 components of a quaternion and the standard operators and functions needed ...
Definition: Kernel/Math/Quaternion.h:42
Definition: Kernel/Math/Vector.h:30
Mdouble getLengthSquared() const
Calculates the squared length of this Vec3D: .
Definition: Vector.cc:164
static Mdouble dot(const Vec3D &a, const Vec3D &b)
Calculates the dot product of two Vec3D: .
Definition: Vector.cc:56
#define min(a, b)
Definition: datatypes.h:22
#define max(a, b)
Definition: datatypes.h:23
#define Z
Definition: icosphere.cpp:21
Scalar * y
Definition: level1_cplx_impl.h:128
char char char int int * k
Definition: level2_impl.h:374
EIGEN_DEVICE_FUNC const Scalar & q
Definition: SpecialFunctionsImpl.h:2019
list x
Definition: plotDoE.py:28
std::ptrdiff_t j
Definition: tut_arithmetic_redux_minmax.cpp:2

References Vec3D::dot(), Vec3D::getLengthSquared(), BaseInteractable::getOrientation(), BaseInteractable::getPosition(), i, j, k, max, min, p, Eigen::numext::q, sqrt(), plotDoE::x, y, and Z.

Referenced by writeVTK().

◆ copy()

HorizontalBaseScrew * HorizontalBaseScrew::copy ( ) const
finalvirtual

Wall copy method. It calls the copy constructor of this Wall, useful for polymorphism.

Returns
pointer to a IntersectionOfWalls object allocated using new.

Implements BaseWall.

63 {
64  return new HorizontalBaseScrew(*this);
65 }
HorizontalBaseScrew()
Default constructor.
Definition: HorizontalBaseScrew.cc:10

References HorizontalBaseScrew().

Referenced by operator=().

◆ getDistanceAndNormal()

bool HorizontalBaseScrew::getDistanceAndNormal ( const BaseParticle p,
Mdouble distance,
Vec3D normalReturn 
) const
finalvirtual

Computes the distance from the wall for a given BaseParticle and returns true if there is a collision. If there is a collision, also return the normal vector.

First, the particle is translated by the vector position_, then the distance normal and tangential to the orientation is computed. This normal and tangential direction is interpreted as the x and z coordinate. With the particle shifted into the XZ plane, the distance and normal is computed, as if the HorizontalBaseScrew would be a simple IntersectionOfWalls. Finally, the object and the normal is rotated back to the original position.

See also HorizontalBaseScrew for details.

Todo:
check, maybe orientation has to be normalised differently for axisymmetric walls (or axis needs to be normalised)

Implements BaseWall.

78 {
79  //transform to axisymmetric coordinates
80  //move the coordinate system to the axis origin, so pOrigin=(xhat,yhat,zhat)
81  Vec3D pOrigin = p.getPosition() -getPosition();
83  Vec3D axis = getOrientation().getAxis();
84  Mdouble a = Vec3D::dot(pOrigin, axis);
85  //Vec3D(r,a) is the projection into the radial-axial plane
86  Vec3D radialDirection = pOrigin - a * axis;
87  Mdouble r = radialDirection.getLength();
88 
89  //BEGIN CHANGE
90  //if in contact
91  if (r!=0)
92  radialDirection /= r;
93  else //in this case the tangential vector is irrelevant
94  logger(WARN, "Warning: Particle % is exactly on the symmetry axis of wall %", p.getIndex(), getIndex());
95 
96  //tangential is the projection into the (xhat,yhat) plane
98  Vec3D orientation = Vec3D(cos(angle),sin(angle),0);
99  Mdouble sinA2 = Vec3D::getLengthSquared(Vec3D::cross(radialDirection,orientation));
100  if (sinA2>sinA2Max_) {
101  a+=sinA2-sinA2Max_;
102  }
103  //END CHANGE
104 
105  //determine wall distance, normal and contact in axissymmetric coordinates
106  //and transform from axisymmetric coordinates
107  Vec3D normal;
108  if (!IntersectionOfWalls::getDistanceAndNormal(Vec3D(r, 0, a), p.getWallInteractionRadius(this), distance, normal))
109  {
110  //if not in contact
111  return false;
112  }
113  else
114  {
115  //if in contact
116  if (r!=0)
117  radialDirection /= r;
118  else //in this case the tangential vector is irrelevant
119  logger(WARN, "Warning: Particle % is exactly on the symmetry axis of wall %", p.getIndex(), getIndex());
120  normalReturn = normal.Z * axis + normal.X * radialDirection;
121  //logger.assert_debug(normalReturn.Y==0,"Error");
122  return true;
123  }
124 }
AnnoyingScalar cos(const AnnoyingScalar &x)
Definition: AnnoyingScalar.h:136
AnnoyingScalar sin(const AnnoyingScalar &x)
Definition: AnnoyingScalar.h:137
@ WARN
DPMBase * getDPMBase()
Gets the problem that is solved using this handler.
Definition: BaseHandler.h:733
virtual const Vec3D & getAngularVelocity() const
Returns the angular velocity of this interactable.
Definition: BaseInteractable.cc:319
unsigned int getIndex() const
Returns the index of the object in the handler.
Definition: BaseObject.h:97
WallHandler * getHandler() const
A function which returns the WallHandler that handles this BaseWall.
Definition: BaseWall.cc:113
Mdouble getTime() const
Returns the current simulation time.
Definition: DPMBase.cc:799
bool getDistanceAndNormal(const BaseParticle &p, Mdouble &distance, Vec3D &normal_return) const override
Compute the distance from the wall for a given BaseParticle and return if there is a collision....
Definition: IntersectionOfWalls.cc:511
Vec3D getAxis() const
Converts the quaternions into a normal vector by rotating the vector x=(1,0,0); see See Wiki for deta...
Definition: Quaternion.cc:481
Mdouble Z
Definition: Kernel/Math/Vector.h:45
static Vec3D cross(const Vec3D &a, const Vec3D &b)
Calculates the cross product of two Vec3D: .
Definition: Vector.cc:143
static Mdouble getLength(const Vec3D &a)
Calculates the length of a Vec3D: .
Definition: Vector.cc:350
const Scalar * a
Definition: level2_cplx_impl.h:32
double angle(const double &t)
Angular position as a function of time t.
Definition: jeffery_orbit.cc:98
r
Definition: UniformPSDSelfTest.py:20
void normal(const Vector< double > &x, Vector< double > &normal)
Definition: free_surface_rotation.cc:65

References a, Jeffery_Solution::angle(), cos(), Vec3D::cross(), Vec3D::dot(), BaseInteractable::getAngularVelocity(), Quaternion::getAxis(), IntersectionOfWalls::getDistanceAndNormal(), BaseHandler< T >::getDPMBase(), BaseWall::getHandler(), BaseObject::getIndex(), Vec3D::getLength(), Vec3D::getLengthSquared(), BaseInteractable::getOrientation(), BaseInteractable::getPosition(), DPMBase::getTime(), logger, WallFunction::normal(), p, UniformPSDSelfTest::r, sin(), sinA2Max_, timeMin_, WARN, and Vec3D::Z.

◆ getName()

std::string HorizontalBaseScrew::getName ( ) const
finalvirtual

Returns the name of the object.

Returns
The string "HorizontalBaseScrew".

Implements BaseObject.

148 {
149  return "HorizontalBaseScrew";
150 }

◆ operator=()

HorizontalBaseScrew & HorizontalBaseScrew::operator= ( const HorizontalBaseScrew other)

Copy assignment operator.

Parameters
[in]otherThe HorizontalBaseScrew that must be copied.
48 {
49  if (this == &other)
50  {
51  return *this;
52  }
53  else
54  {
55  return *(other.copy());
56  }
57 }
HorizontalBaseScrew * copy() const final
Wall copy method. It calls the copy constructor of this Wall, useful for polymorphism.
Definition: HorizontalBaseScrew.cc:62

References copy().

◆ read()

void HorizontalBaseScrew::read ( std::istream &  is)
finalvirtual

reads wall

Parameters
[in]isThe input stream from which the HorizontalBaseScrew is read, usually a restart file.

Reimplemented from BaseWall.

131 {
133 }
void read(std::istream &is) override
Move the IntersectionOfWalls to a new position, which is a Vec3D from the old position.
Definition: IntersectionOfWalls.cc:725

References IntersectionOfWalls::read().

◆ setAxis()

void HorizontalBaseScrew::setAxis ( Vec3D  a)

◆ write()

void HorizontalBaseScrew::write ( std::ostream &  os) const
finalvirtual

outputs wall

Parameters
[in]osThe output stream where the HorizontalBaseScrew must be written to, usually a restart file.

Reimplemented from BaseWall.

140 {
142 }
void write(std::ostream &os) const override
Writes an IntersectionOfWalls to an output stream, for example a restart file.
Definition: IntersectionOfWalls.cc:755

References IntersectionOfWalls::write().

◆ writeVTK()

void HorizontalBaseScrew::writeVTK ( VTKContainer vtk) const
overridevirtual

adds extra information to the points and triangleStrips vectors needed to plot the wall in vtk format

Parameters
pointsCoordinates of the vertices of the triangulated surfaces (in the VTK file this is called POINTS)
triangleStripsIndices of three vertices forming one triangulated surface (in the VTK file this is called CELL)
Bug:
once the quaternions are implemented, we can orient these walls properly

Reimplemented from BaseWall.

189 {
190  for (auto wall=wallObjects_.begin(); wall!=wallObjects_.end(); wall++)
191  {
192  //plot each of the intersecting walls
193  std::vector<Vec3D> myPoints;
194 
195  //first create a slice of non-rotated wall in the xz plane, 0<y<1
199 
200  //create the basic slice for the first wall using the InfiniteWall routine
201  wall->createVTK (myPoints,min,max);
202 
203  //create intersections with the other walls, similar to the IntersectionOfWalls routine
204  for (auto other=wallObjects_.begin(); other!=wallObjects_.end(); other++)
205  {
206  if (other!=wall)
207  {
208  intersectVTK(myPoints, -other->getNormal(), other->getPosition());
209  }
210  }
211 
212  //only keep the y=0 values
213  std::vector<Vec3D> rzVec;
214  for (auto& p: myPoints)
215  {
216  if (p.Y==0)
217  {
218  rzVec.push_back(p);
219  }
220  }
221  if (rzVec.size()==0)
222  return;
223 
224  //create points on the unit circle
225  unsigned nr = 180;
226  //BEGIN CHANGE
227  std::vector<Vec3D> xyVec;
229  for (unsigned ir=0; ir<nr; ir++) {
230  Mdouble angle = 2.0 * constants::pi * ir/nr;
231 
232  Mdouble sinA2 = sin(a1 - angle); sinA2 *= sinA2;
233  Mdouble dSin = sinA2-sinA2Max_;
234 
235  xyVec.push_back(Vec3D(cos(angle),sin(angle),fmax(dSin,0)));
236  }
237  //END CHANGE
238 
239  //now create rings of points on the axisym. shape
241  unsigned nPoints = vtk.points.size();
242  Vec3D p;
243  for (auto rz : rzVec)
244  {
245  for (auto xy : xyVec)
246  {
247  //BEGIN CHANGE
248  p = Vec3D(rz.X * xy.X, rz.X * xy.Y,fmax(rz.Z - xy.Z,0.0));
249  //getOrientation().rotate(p);
250  //END CHANGE
251  p += getPosition();
252  vtk.points.push_back(p);
253  }
254  }
255 
256  //finally create the connectivity matri to plot shell-like triangle strips.
257  unsigned nz = rzVec.size();
258  for (unsigned iz=0; iz<nz-1; iz++) {
259  std::vector<double> cell;
260  cell.reserve(2*nr+2);
261  for (unsigned ir=0; ir<nr; ir++) {
262  cell.push_back(nPoints+ir+iz*nr);
263  cell.push_back(nPoints+ir+(iz+1)*nr);
264  }
265  cell.push_back(nPoints+iz*nr);
266  cell.push_back(nPoints+(iz+1)*nr);
267  vtk.triangleStrips.push_back(cell);
268  }
269  }
270 
271 }
Matrix< float, 2, 1 > xy
Definition: LLT_solve.cpp:6
void intersectVTK(std::vector< Vec3D > &points, Vec3D normal, Vec3D position) const
Definition: BaseWall.cc:220
Vec3D getMax() const
Returns the maximum coordinates of the problem domain.
Definition: DPMBase.h:659
Vec3D getMin() const
Returns the minimum coordinates of the problem domain.
Definition: DPMBase.h:653
void convertLimits(Vec3D &min, Vec3D &max) const
Definition: HorizontalBaseScrew.cc:157
std::vector< InfiniteWall > wallObjects_
The wall "segments"/directions that together make up the finite wall.
Definition: IntersectionOfWalls.h:198
EIGEN_STRONG_INLINE EIGEN_DEVICE_FUNC bfloat16 fmax(const bfloat16 &a, const bfloat16 &b)
Definition: BFloat16.h:670
const unsigned nz
Definition: ConstraintElementsUnitTest.cpp:32
const Mdouble pi
Definition: ExtendedMath.h:23
std::vector< std::vector< double > > triangleStrips
Definition: BaseWall.h:19
std::vector< Vec3D > points
Definition: BaseWall.h:18

References Jeffery_Solution::angle(), convertLimits(), cos(), Eigen::bfloat16_impl::fmax(), BaseInteractable::getAngularVelocity(), BaseHandler< T >::getDPMBase(), BaseWall::getHandler(), DPMBase::getMax(), DPMBase::getMin(), BaseInteractable::getPosition(), DPMBase::getTime(), BaseWall::intersectVTK(), max, min, Mesh_Parameters::nz, p, constants::pi, VTKContainer::points, sin(), sinA2Max_, timeMin_, VTKContainer::triangleStrips, IntersectionOfWalls::wallObjects_, xy, and Vec3D::Z.

Member Data Documentation

◆ sinA2Max_

Mdouble HorizontalBaseScrew::sinA2Max_

◆ timeMin_

Mdouble HorizontalBaseScrew::timeMin_

The documentation for this class was generated from the following files: