MercuryDPM  Beta
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Pages
StatisticsVector< T > Class Template Reference

This class is used to extract statistical data from MD simulations. More...

#include <StatisticsPoint.h>

+ Inheritance diagram for StatisticsVector< T >:

Public Member Functions

void constructor ()
 this is the actual constructor, sets up all basic things More...
 
void constructor (std::string name)
 
 StatisticsVector ()
 Basic constructor only calls constructor() More...
 
 StatisticsVector (std::string name)
 
 StatisticsVector (StatisticsVector &other)
 Copy constructor. More...
 
 StatisticsVector (int argc, char *argv[])
 Advanced constructor that accepts arguments from the command line. More...
 
void readStatArguments (int argc, char *argv[])
 
std::string printStat ()
 Outputs member variable values to a std::string. More...
 
void set_statType ()
 
void writeOutputFiles ()
 Writes the simulation data onto all the files i.e. .data, .ene, .fstat ... More...
 
void print_help ()
 
void setNX (int new_)
 
void set_hx (Mdouble hx)
 
void setNY (int new_)
 
void set_hy (Mdouble hy)
 
void setNZ (int new_)
 
void set_hz (Mdouble hz)
 
void setN (int n)
 
void set_h (Mdouble h)
 
int getNX ()
 
int getNY ()
 
int getNZ ()
 
void setCGTimeMin (Mdouble t)
 
void setTimeMaxStat (Mdouble t)
 
void setCGTimeAveragingInterval (Mdouble t)
 
Mdouble getCGTimeMin ()
 
Mdouble getTimeMaxStat ()
 
Mdouble getCGTimeAveragingInterval ()
 
bool check_current_time_for_statistics ()
 
void setCGShape (const char *new_)
 
void setCGShape (CG new_)
 
CG getCGShape ()
 
void setN (int nx_, int ny_, int nz_)
 
void getN (int &nx_, int &ny_, int &nz_)
 
void setCGWidth (Mdouble w)
 Set CG variables w2 and CG_invvolume. More...
 
void setCGWidth2 (Mdouble new_)
 Set CG variables w2 and CG_invvolume. More...
 
Mdouble getCGWidth ()
 
Mdouble getCGWidthSquared ()
 
Mdouble getCutoff ()
 
Mdouble getCutoff2 ()
 
std::string print_CG ()
 Output coarse graining variables. More...
 
StatisticsPoint< T > average (std::vector< StatisticsPoint< T > > &P)
 Output average of statistical variables. More...
 
virtual void reset_statistics ()
 Set all statistical variables to zero. More...
 
void statistics_from_fstat_and_data ()
 get StatisticsPoint More...
 
void statistics_from_p3 ()
 
void jump_p3c ()
 
void setDoTimeAverage (bool new_)
 
bool getDoTimeAverage ()
 
void setStressTypeForFixedParticles (int new_)
 
int getStressTypeForFixedParticles ()
 
void set_infiniteStressForFixedParticles (bool new_)
 
void setMirrorAtDomainBoundary (Mdouble new_)
 
Mdouble getMirrorAtDomainBoundary ()
 
void setDoVariance (bool new_)
 
bool getDoVariance ()
 
void setDoGradient (bool new_)
 
bool getDoGradient ()
 
void setSuperExact (bool new_)
 
bool getSuperExact ()
 
void setDoIgnoreFixedParticles (bool new_)
 
bool getDoIgnoreFixedParticles ()
 
void verbose ()
 
void setVerbosityLevel (int new_)
 
int getVerbosityLevel () const
 
void setCGWidthalls (bool new_)
 
bool getCGWidthalls ()
 
void setDoPeriodicWalls (bool new_)
 
bool getDoPeriodicWalls ()
 
void setCGWidth_over_rmax (Mdouble new_)
 
Mdouble getCGWidth_over_rmax ()
 
void setPositions ()
 Set position of StatisticsPoint points and set variables to 0. More...
 
bool readNextDataFile (unsigned int format)
 
void gather_force_statistics_from_fstat_and_data ()
 
void gather_force_statistics_from_p3c (int version)
 
void gather_force_statistics_from_p3w (int version, std::vector< int > &index)
 
void evaluate_force_statistics (int wp=0)
 
void evaluate_wall_force_statistics (Vec3D P, int wp=0)
 
void jump_fstat ()
 
void initialiseStatistics ()
 Initializes statistics, i.e. setting w2, setting the grid and writing the header lines in the .stat file. More...
 
void outputStatistics ()
 Calculates statistics for Particles (i.e. not collisions) More...
 
void gatherContactStatistics (unsigned int index1, int index2, Vec3D Contact, Mdouble delta, Mdouble ctheta, Mdouble fdotn, Mdouble fdott, Vec3D P1_P2_normal_, Vec3D P1_P2_tangential)
 Calculates statistics for one collision (can be any kind of collision) More...
 
void processStatistics (bool usethese)
 Processes all gathered statistics and resets them afterwards. (Processing means either calculating time averages or writing out statistics) More...
 
void finishStatistics ()
 Finish all statistics (i.e. write out final data) More...
 
void write_statistics ()
 Writes regular statistics. More...
 
void write_time_average_statistics ()
 Writes out time averaged statistics. More...
 
void evaluate_particle_statistics (std::vector< BaseParticle * >::iterator P, int wp=0)
 Calculates statistics for a single Particle. More...
 
std::vector< StatisticsPoint< T > > getCGPoints ()
 
Mdouble getXMinStat ()
 Functions to acces and change the domain of statistics. More...
 
Mdouble getYMinStat ()
 
Mdouble getZMinStat ()
 
Mdouble getXMaxStat ()
 
Mdouble getYMaxStat ()
 
Mdouble getZMaxStat ()
 
void setXMinStat (Mdouble xminStat_)
 
void setYMinStat (Mdouble yminStat_)
 
void setZMinStat (Mdouble zminStat_)
 
void setXMaxStat (Mdouble xmaxStat_)
 
void setYMaxStat (Mdouble ymaxStat_)
 
void setZMaxStat (Mdouble zmaxStat_)
 
int getNTimeAverage ()
 
Mdouble setInfinitelyLongDistance ()
 
void set_Polynomial (std::vector< Mdouble > new_coefficients, unsigned int new_dim)
 
void set_Polynomial (Mdouble *new_coefficients, unsigned int num_coeff, unsigned int new_dim)
 
void setPolynomialName (const char *new_name)
 
std::string getPolynomialName ()
 
void setDoDoublePoints (bool new_)
 
bool getDoDoublePoints ()
 
void setNTimeAverageReset (int new_)
 
bool getNTimeAverageReset ()
 
void set_rmin (Mdouble new_)
 
void set_rmax (Mdouble new_)
 
void set_hmax (Mdouble new_)
 
Mdouble evaluatePolynomial (Mdouble r)
 
Mdouble evaluatePolynomialGradient (Mdouble r)
 
Mdouble evaluateIntegral (Mdouble n1, Mdouble n2, Mdouble t)
 
unsigned int getStepSize () const
 
void setStepSize (unsigned int stepSize)
 
- Public Member Functions inherited from DPMBase
void constructor ()
 A function which initialises the member variables to default values, so that the problem can be solved off the shelf; sets up a basic two dimensional problem which can be solved off the shelf. It is called in the constructor DPMBase(). More...
 
 DPMBase ()
 Constructor that calls the "void constructor()". More...
 
 DPMBase (const FilesAndRunNumber &other)
 Copy constructor type-1. More...
 
 DPMBase (const DPMBase &other)
 Copy constructor type-2. More...
 
virtual ~DPMBase ()
 virtual destructor More...
 
void solve ()
 The work horse of the code. More...
 
void checkSettings ()
 Checks if the essentials are set properly to go ahead with solving the problem. More...
 
void solve (int argc, char *argv[])
 The solve function is the work horse of the code with the user input. More...
 
virtual void setupInitialConditions ()
 This function allows to set the initial conditions for our problem to be solved, by default particle locations are randomly set. Remember particle properties must also be defined here. More...
 
virtual void writeXBallsScript () const
 This writes a script which can be used to load the xballs problem to display the data just generated. More...
 
virtual double getInfo (const BaseParticle &P) const
 A virtual method that allows the user to overrride and set what is written into the info column in the data file. By default it returns the Species ID number. More...
 
virtual void writeRestartFile ()
 Stores all the particle data for current save time step. Calls the write function. More...
 
int readRestartFile ()
 Reads all the particle data corresponding to the current saved time step. Which is what the restart file basically stores. The problem description with the latest particle data. More...
 
int readRestartFile (std::string fileName)
 Also reads all the particle data corresponding to the current saved time step. More...
 
virtual void write (std::ostream &os, bool writeAllParticles=true) const
 Loads all MD data and plots statistics for all timesteps in the .data file. More...
 
virtual void read (std::istream &is)
 Reads all particle data into a restart file. More...
 
virtual void readOld (std::istream &is)
 Reads all particle data into a restart file; old version. More...
 
bool readDataFile (const std::string fileName, unsigned int format=0)
 This allows particle data to be reloaded from data files. More...
 
bool readParAndIniFiles (const std::string fileName)
 Allows the user to read par.ini files (useful to read MDCLR files) More...
 
bool readNextDataFile (unsigned int format=0)
 Reads the next data file with default format=0. However, one can modify the format based on whether the particle data corresponds to 3D or 2D data. See XBalls/xballs.txt. More...
 
bool findNextExistingDataFile (Mdouble tMin, bool verbose=true)
 Useful when fileType is chosen as Multiple Files or Multiple files with padded. More...
 
bool readArguments (int argc, char *argv[])
 Can interpret main function input arguments that are passed by the driver codes. More...
 
virtual bool readNextArgument (int &i, int argc, char *argv[])
 
virtual bool checkParticleForInteraction (const BaseParticle &P)
 Checks if the particle having any interaction with walls or other particles. More...
 
Mdouble getTime () const
 Access function for the time. More...
 
unsigned int getNtimeSteps () const
 Returns the current counter of time steps. More...
 
void setTime (Mdouble time)
 Access function for the time. More...
 
void setTimeMax (Mdouble newTMax)
 Allows the upper time limit to be changed. More...
 
Mdouble getTimeMax () const
 Allows the user to access the total simulation time during the simulation. Cannot change it though. More...
 
void setDoCGAlways (bool newDoCGFlag)
 
void setRotation (bool newRotFlag)
 Allows to set the flag for enabling or disabling particle rotation in the simulations. More...
 
bool getRotation () const
 Returns a flag indicating if particle rotation is enabled or disabled. More...
 
bool getDoCGAlways () const
 
Mdouble getXMin () const
 If the length of the problem domain in x-direction is XMax - XMin, then getXMin() returns XMin,. More...
 
Mdouble getXMax () const
 If the length of the problem domain in x-direction is XMax - XMin, then getXMax() returns XMax,. More...
 
Mdouble getYMin () const
 If the length of the problem domain in y-direction is YMax - YMin, then getYMin() returns YMin,. More...
 
Mdouble getYMax () const
 If the length of the problem domain in y-direction is YMax - YMin, then getYMax() returns XMax,. More...
 
Mdouble getZMin () const
 If the length of the problem domain in z-direction is ZMax - ZMin, then getZMin() returns ZMin,. More...
 
Mdouble getZMax () const
 If the length of the problem domain in z-direction is ZMax - ZMin, then getZMax() returns ZMax,. More...
 
void setXMin (Mdouble newXMin)
 If the length of the problem domain in x-direction is XMax - XMin, this method sets XMin. More...
 
void setYMin (Mdouble newYMin)
 If the length of the problem domain in y-direction is YMax - YMin, this method sets YMin. More...
 
void setZMin (Mdouble newZMin)
 If the length of the problem domain in z-direction is ZMax - ZMin, this method sets ZMin. More...
 
void setXMax (Mdouble newXMax)
 If the length of the problem domain in x-direction is XMax - XMin, this method sets XMax. More...
 
void setYMax (Mdouble newYMax)
 If the length of the problem domain in y-direction is YMax - YMin, this method sets YMax. More...
 
void setZMax (Mdouble newZMax)
 If the length of the problem domain in z-direction is XMax - XMin, this method sets ZMax. More...
 
void setTimeStep (Mdouble newDt)
 Allows the time step dt to be changed. More...
 
Mdouble getTimeStep () const
 Allows the time step dt to be accessed. More...
 
void setXBallsColourMode (int newCMode)
 Set the xball output mode. More...
 
int getXBallsColourMode () const
 Get the xball colour mode (CMode) More...
 
void setXBallsVectorScale (double newVScale)
 Set the scale of vectors in xballs. More...
 
double getXBallsVectorScale () const
 Returns the scale of vectors used in xballs. More...
 
void setXBallsAdditionalArguments (std::string newXBArgs)
 Set the additional arguments for xballs. More...
 
std::string getXBallsAdditionalArguments () const
 
void setXBallsScale (Mdouble newScale)
 Sets the scale of the view (either normal, zoom in or zoom out) to display in xballs. The default is fit to screen. More...
 
double getXBallsScale () const
 Returns the scale of the view in xballs. More...
 
void setGravity (Vec3D newGravity)
 Allows to modify the gravity vector. More...
 
Vec3D getGravity () const
 Returns the gravity vector. More...
 
void setDimension (unsigned int newDim)
 Sets the system and particle dimension. More...
 
void setSystemDimensions (unsigned int newDim)
 Allows for the dimension of the simulation to be changed. More...
 
unsigned int getSystemDimensions () const
 Returns the dimension of the simulation. Note there is also a particle dimension. More...
 
void setParticleDimensions (unsigned int particleDimensions)
 Allows the dimension of the particle (f.e. for mass) to be changed. e.g. discs or spheres. More...
 
unsigned int getParticleDimensions () const
 Returns the particle dimensions. More...
 
std::string getRestartVersion () const
 This is to take into account for different Mercury versions. Returns the version of the restart file. More...
 
void setRestartVersion (std::string newRV)
 Sets restart_version. More...
 
bool getRestarted () const
 Returns the flag denoting if the simulation was restarted or not. More...
 
void setRestarted (bool newRestartedFlag)
 Allows to set the flag stating if the simulation is to be restarted or not. More...
 
bool getAppend () const
 Returns the flag denoting if the append option is on or off. More...
 
void setAppend (bool newAppendFlag)
 Allows to set the append option. More...
 
Mdouble getElasticEnergy () const
 Returns the global elastic energy within the system. More...
 
Mdouble getKineticEnergy () const
 Returns the global kinetic energy stored in the system. More...
 
bool areInContact (const BaseParticle *pI, const BaseParticle *pJ) const
 Checks if two particle are in contact or is there any positive overlap. More...
 
virtual void hGridInsertParticle (BaseParticle *obj UNUSED)
 no implementation but can be overidden in its derived classes. More...
 
virtual void hGridUpdateParticle (BaseParticle *obj UNUSED)
 no implementation but can be overidden in its derived classes. More...
 
virtual void hGridRemoveParticle (BaseParticle *obj UNUSED)
 no implementation but can be overidden in its derived classes. More...
 
virtual void hGridUpdateMove (BaseParticle *, Mdouble)
 no implementation but can be overidden in its derived classes. More...
 
- Public Member Functions inherited from FilesAndRunNumber
 FilesAndRunNumber ()
 Constructor. More...
 
 FilesAndRunNumber (const FilesAndRunNumber &other)
 Copy constructor. More...
 
virtual ~FilesAndRunNumber ()
 Constructor. More...
 
void constructor ()
 a function called by the FilesAndRunNumber() (constructor) More...
 
void incrementRunNumberInFile ()
 Increment the run Number (counter value) stored in the file_counter (COUNTER_DONOTDEL) by 1 and store the new value in the counter file. More...
 
int readRunNumberFromFile ()
 Read the run number or the counter from the counter file (COUNTER_DONOTDEL) More...
 
void autoNumber ()
 The autoNumber() function is the trigger. It calls three functions. setRunNumber(), readRunNumberFromFile() and incrementRunNumberInFile(). More...
 
std::vector< int > get2DParametersFromRunNumber (int size_x, int size_y)
 This turns a counter into two indices which is an amazing feature for doing two dimensional parameter studies. The indices run from 1:size_x and 1:size_y, while the study number starts at 0 ( initially the counter=1 in COUNTER_DONOTDEL) More...
 
int launchNewRun (const char *name, bool quick=false)
 This launches a code from within this code. Please pass the name of the code to run. More...
 
void setRunNumber (int runNumber)
 This sets the counter/Run number, overriding the defaults. More...
 
int getRunNumber () const
 This returns the current value of the counter (runNumber_) More...
 
void read (std::istream &is)
 Accepts an input stream std::istream. More...
 
void write (std::ostream &os) const
 Accepts an output stream read function, which accepts an input stream std::ostream. More...
 
- Public Member Functions inherited from Files
 Files ()
 A constructor. More...
 
virtual ~Files ()
 A destructor, watch out its a virtual destructor. More...
 
 Files (const Files &other)
 Copy constructor. More...
 
MERCURY_DEPRECATED FilegetDataFile ()
 The non const version. Allows one to edit the File::dataFile. More...
 
MERCURY_DEPRECATED FilegetEneFile ()
 The non const version. Allows to edit the File::eneFile. More...
 
MERCURY_DEPRECATED FilegetFStatFile ()
 The non const version. Allows to edit the File::fStatFile. More...
 
MERCURY_DEPRECATED FilegetRestartFile ()
 The non const version. Allows to edit the File::restartFile. More...
 
MERCURY_DEPRECATED FilegetStatFile ()
 The non const version. Allows to edit the File::statFile. More...
 
MERCURY_DEPRECATED const FilegetDataFile () const
 The const version. Does not allow for any editing of the File::dataFile. More...
 
MERCURY_DEPRECATED const FilegetEneFile () const
 The const version. Does not allow for any editing of the File::eneFile. More...
 
MERCURY_DEPRECATED const FilegetFStatFile () const
 The const version. Does not allow for any editing of the File::fStatFile. More...
 
MERCURY_DEPRECATED const FilegetRestartFile () const
 The const version. Does not allow for any editing of the File::restartFile. More...
 
MERCURY_DEPRECATED const FilegetStatFile () const
 The const version. Does not allow for any editing of the File::statFile. More...
 
const std::string & getName () const
 Returns the name of the file. Does not allow to change it though. More...
 
void setName (const std::string &name)
 Allows to set the name of all the files (ene, data, fstat, restart, stat) More...
 
void setName (const char *name)
 Calls setName(std::string) More...
 
void setSaveCount (unsigned int saveCount)
 Sets File::saveCount_ for all files (ene, data, fstat, restart, stat) More...
 
void setFileType (FileType fileType)
 Sets File::fileType_ for all files (ene, data, fstat, restart, stat) More...
 
void setOpenMode (std::fstream::openmode openMode)
 Sets File::openMode_ for all files (ene, data, fstat, restart, stat) More...
 
void resetFileCounter ()
 Resets the file counter for each file i.e. for ene, data, fstat, restart, stat) More...
 
void read (std::istream &is)
 Extracts data from the input stream (which is basically a file you want to read from) into name_, restartFile .... More...
 
void write (std::ostream &os) const
 Writes data into a file from the member variables name_, restartFile, dataFile etc. More...
 
void openFiles ()
 Opens all the files (ene, data, fstat, restart, stat) for reading and writing purposes. More...
 
void closeFiles ()
 Closes all files (ene, data, fstat, restart, stat) that were opened to read or write. More...
 
void setNextSavedTimeStep (unsigned int nextSavedTimeStep)
 Sets the next time step for all the files (ene, data, fstat, restart, stat) at which the data is to be written or saved. More...
 

Protected Member Functions

bool satisfiesInclusionCriteria (BaseParticle *P)
 
bool loadVelocityProfile (const char *filename)
 
bool loadPositions (const char *filename)
 
Vec3D getVelocityProfile (Vec3D Position)
 
bool read_next_from_p3p_file ()
 
void auto_setdim ()
 
- Protected Member Functions inherited from DPMBase
virtual void computeAllForces ()
 Computes all the forces acting on the particles by using the setTorque and setForce methods. See BaseInteractible.cc. More...
 
virtual void computeInternalForces (BaseParticle *i)
 Computes the forces between particles (internal in the sense that the sum over all these forces is zero i.e. fully modelled forces) More...
 
virtual void computeInternalForces (BaseParticle *P1, BaseParticle *P2)
 Computes the forces between particles (internal in the sense that the sum over all these forces is zero i.e. fully modelled forces) More...
 
virtual void computeExternalForces (BaseParticle *PI)
 Computes the external forces acting on particles (e.g. gravitational) More...
 
virtual void computeForcesDueToWalls (BaseParticle *PI)
 Computes the forces on the particles due to the walls (normals are outward normals) More...
 
virtual void actionsOnRestart ()
 A virtual function where the users can add extra code which is executed only when the code is restarted. More...
 
virtual void actionsBeforeTimeLoop ()
 A virtual function. Allows one to carry out any operations before the start of the time loop. More...
 
virtual void hGridActionsBeforeTimeLoop ()
 A virtual function that allows one to carry out hGrid operations before the start of the time loop. More...
 
virtual void hGridActionsBeforeTimeStep ()
 A virtual function that allows one to set or execute hGrid parameters or operations before every simulation time step. More...
 
virtual bool getHGridUpdateEachTimeStep () const
 
virtual void actionsBeforeTimeStep ()
 A virtual function which allows to define operations to be executed before the new time step. More...
 
virtual void actionsAfterSolve ()
 A virtual function which allows to define operations to be executed after the solve(). More...
 
virtual void actionsAfterTimeStep ()
 A virtual function which allows to define operations to be executed after time step. More...
 
virtual void outputXBallsData (std::ostream &os) const
 This function writes the location of the walls and particles in a format the XBalls program can read. See XBalls/xballs.txt. However, MercuryDPM supports a much better viewer now called Paraview. See the tutorials section in the documentation. More...
 
virtual void outputXBallsDataParticle (const unsigned int i, const unsigned int format, std::ostream &os) const
 This function writes out the particle locations into an output stream in a format the XBalls program can read. More...
 
virtual void writeEneHeader (std::ostream &os) const
 Writes a header with a certain format for ENE file. More...
 
virtual void writeFstatHeader (std::ostream &os) const
 Writes a header with a certain format for FStat file. More...
 
virtual void writeEneTimestep (std::ostream &os) const
 This function enables one to write the global energy available in the system after each time step. The default is to compute the rotational and translational kinetic energy, potential energy and the centre of mass. More...
 
void gatherContactStatistics ()
 
virtual void integrateBeforeForceComputation ()
 This is were the integration is done, at the moment it is velocity Verlet integration and is done before the forces are computed. See http://en.wikipedia.org/wiki/Verlet_integration#Velocity_Verlet. More...
 
virtual void integrateAfterForceComputation ()
 Integration is done after force computations. We apply the Velocity verlet scheme. See http://en.wikipedia.org/wiki/Verlet_integration#Velocity_Verlet. More...
 
virtual void checkInteractionWithBoundaries ()
 There are a range of boundaries one could implement depending on ones' problem. This methods checks for interactions between particles and such range of boundaries. See BaseBoundary.h and all the boundaries in the Boundaries folder. More...
 
virtual void hGridActionsBeforeIntegration ()
 no implementation but can be overidden in its derived classes. More...
 
virtual void hGridActionsAfterIntegration ()
 no implementation but can be overidden in its derived classes. More...
 
virtual void broadPhase (BaseParticle *i)
 By broad one means to screen and determine an approximate number of particles that a given particle can be in contact with. Hence the word "Broad phase" of contact detection. More...
 
void setFixedParticles (unsigned int n)
 
void initialiseTangentialSprings ()
 
virtual void printTime () const
 Displays the current simulation time onto your screen for example. More...
 
virtual bool continueSolve () const
 
void outputInteractionDetails () const
 Displays the interaction details corresponding to the pointer objects in the interaction handler. More...
 
bool isTimeEqualTo (Mdouble time) const
 Checks if the input variable "time" is the current time in the simulation. More...
 
void removeDuplicatePeriodicParticles ()
 Removes periodic duplicate Particles. More...
 
void checkAndDuplicatePeriodicParticles ()
 In case of periodic boundaries, the below methods checks and adds particles when necessary into the particle handler. See DPMBase.cc and PeriodicBoundary.cc for more details. More...
 

Protected Attributes

StatType statType
 Possible values X,Y,Z,XY,XZ,YZ,XYZ,RAZ,RA,RZ,AZ,R,A are used to determine if the statistics are averaged; f.e. StatType X is averaged over y and z. More...
 
int nx
 Grid size nx,ny,nz (by default the points of evaluation are placed in an grid on the domain [xminStat,xmaxStat]x[yminStat,ymaxStat]x[zminStat,zmaxStat]. More...
 
int ny
 see nx More...
 
int nz
 see nx More...
 
Mdouble xminStat
 By default the domain is set to the domain of the MD problem (indicated by setting the stat-domain values to nan), but can be resized. More...
 
Mdouble xmaxStat
 
Mdouble yminStat
 
Mdouble ymaxStat
 
Mdouble zminStat
 
Mdouble zmaxStat
 
int nxMirrored
 extension of grid size from mirrored points More...
 
int nyMirrored
 
int nzMirrored
 
std::vector< StatisticsPoint< T > > Points
 A vector that stores the values of the statistical variables at a given position. More...
 
std::vector< StatisticsPoint< T > > dx
 A vector that stores the gradient in x of all statistical variables at a given position. More...
 
std::vector< StatisticsPoint< T > > dy
 A vector that stores the gradient in y of all statistical variables at a given position. More...
 
std::vector< StatisticsPoint< T > > dz
 A vector that stores the gradient in z of all statistical variables at a given position. More...
 
std::vector< StatisticsPoint< T > > timeAverage
 A vector used to sum up all statistical values in Points for time-averaging. More...
 
std::vector< StatisticsPoint< T > > timeVariance
 a vector used to sum up the variance in time of all statistical values More...
 
std::vector< StatisticsPoint< T > > dxTimeAverage
 a vector used to sum up all statistical gradients in dx for time-averaging More...
 
std::vector< StatisticsPoint< T > > dyTimeAverage
 a vector used to sum up all statistical gradients in dy for time-averaging More...
 
std::vector< StatisticsPoint< T > > dzTimeAverage
 a vector used to sum up all statistical gradients in dz for time-averaging More...
 
bool doTimeAverage
 Determines if output is averaged over time. More...
 
int nTimeAverageReset
 Determines after how many timesteps the time average is reset. More...
 
bool doVariance
 Determines if variance is outputted. More...
 
bool doGradient
 Determines if gradient is outputted. More...
 
int nTimeAverage
 A counter needed to average over time. More...
 
CG CG_type
 coarse graining type (Gaussian, Heaviside, Polynomial) More...
 
NORMALIZED_POLYNOMIAL< T > CGPolynomial
 Stores the Polynomial, if the cg function is an axisymmetric function Polynomial in r. More...
 
Mdouble w2
 coarse graining width squared; for HeavisideSphere and Gaussian More...
 
Mdouble cutoff
 The distance from the origin at which the cg function vanishes; cutoff=w for HeavisideSphere or Polynomial, 3*w for Gaussian. More...
 
Mdouble cutoff2
 
Mdouble w_over_rmax
 if w is not set manually then w will be set by multiplying this value by the largest particle radius at t=0 More...
 
Mdouble tminStat
 Statistical output will only be created if t>tminStat. More...
 
Mdouble tmaxStat
 Statistical output will only be created if t<tmaxStat. More...
 
Mdouble tintStat
 Statistical output will only be created if tmaxStat-tintStat< t< tmaxStat. More...
 
Mdouble indSpecies
 defines the species for which statistics are extracted (-1 for all species) More...
 
Mdouble rmin
 defines the minimum radius of the particles for which statistics are extracted More...
 
Mdouble rmax
 defines the maximum radius of the particles for which statistics are extracted More...
 
Mdouble hmax
 defines the maximum height of the particles for which statistics are extracted More...
 
bool walls
 Turns off walls before evaluation. More...
 
bool periodicWalls
 Turns off periodic walls before evaluation (needed for averaging, because we do not yet check if particle is in domain) More...
 
bool ignoreFixedParticles
 Determines if fixed particles contribute to particle statistics (density, ...) More...
 
int StressTypeForFixedParticles
 Stress type for fixed particles. More...
 
int verbosity
 Determines how much is outputted to the terminal. More...
 
int format
 format of the data input file More...
 
Mdouble mirrorAtDomainBoundary
 0: Statistics near the wall are equal to statistics away from the wall; 1: Statistics are mirrored at the domain boundaries; up to a maximum depth specified by this number More...
 
bool isMDCLR
 
bool superexact
 If true, cutoff radius for Gaussian is set to 5*w (from 3*w) More...
 
bool doDoublePoints
 
Vec3D P1
 Position of first contact point. More...
 
Vec3D P2
 Position of second contact point. More...
 
Vec3D P1_P2_normal
 Direction of contact. More...
 
Mdouble P1_P2_distance
 Length of contact line. More...
 
Matrix3D P1_P2_NormalStress
 Contact stress from normal forces along the line of contact. More...
 
Matrix3D P1_P2_ContactCoupleStress
 
Vec3D P1_P2_Contact
 
Matrix3D P1_P2_TangentialStress
 Contact stress from tangential forces along the line of contact. More...
 
Vec3D P1_P2_NormalTraction
 Traction from normal forces at contact of flow with fixed particles or walls. More...
 
Vec3D P1_P2_TangentialTraction
 Traction from tangential forces at contact of flow with fixed particles or walls. More...
 
MatrixSymmetric3D P1_P2_Fabric
 Fabric. More...
 
Vec3D P1_P2_CollisionalHeatFlux
 not yet working More...
 
Mdouble P1_P2_Dissipation
 not yet working More...
 
Mdouble P1_P2_Potential
 not yet working More...
 
std::vector< Vec3DVelocityProfile
 
Vec3D VelocityProfile_Min
 
Vec3D VelocityProfile_D
 
std::fstream p3p_file
 
std::fstream p3c_file
 
std::fstream p3w_file
 
unsigned int stepSize_
 
std::vector< Vec3Dpositions_
 

Additional Inherited Members

- Public Attributes inherited from DPMBase
SpeciesHandler speciesHandler
 A handler to that stores the species type i.e. elastic, linear visco-elastic... et cetera. More...
 
RNG random
 This is a random generator, often used for setting up the initial conditions etc... More...
 
ParticleHandler particleHandler
 An object of the class ParticleHandler, contains the pointers to all the particles created. More...
 
WallHandler wallHandler
 An object of the class WallHandler. Contains pointers to all the walls created. More...
 
BoundaryHandler boundaryHandler
 An object of the class BoundaryHandler which concerns insertion and deletion of particles into or from regions. More...
 
InteractionHandler interactionHandler
 An object of the class InteractionHandler. More...
 
- Public Attributes inherited from Files
File dataFile
 An instance of class File to handle in- and output into a .data file. More...
 
File fStatFile
 An instance of class File to handle in- and output into a .fstat file. More...
 
File eneFile
 An instance of class File to handle in- and output into a .ene file. More...
 
File restartFile
 An instance of class File to handle in- and output into a .restart file. More...
 
File statFile
 An instance of class File to handle in- and output into a .stat file. More...
 

Detailed Description

template<StatType T>
class StatisticsVector< T >

This class is used to extract statistical data from MD simulations.

When calling statistics_from_fstat_and_data(), statistical data (such as density, pressure, ...) will be extracted at various points in the domain, aligned in a nx*ny*nz grid.

Set functions can be used to define the dimensions of the grid (default: nx=ny=nz=1) and the type and width of the coarse graining function (default: Gaussian, width w=r_max).

Definition at line 36 of file StatisticsPoint.h.

Constructor & Destructor Documentation

template<StatType T>
StatisticsVector< T >::StatisticsVector ( )
inline

Basic constructor only calls constructor()

Definition at line 75 of file StatisticsVector.h.

References StatisticsVector< T >::constructor().

76  {
77  constructor();
78  }
void constructor()
this is the actual constructor, sets up all basic things
template<StatType T>
StatisticsVector< T >::StatisticsVector ( std::string  name)
inline

Definition at line 83 of file StatisticsVector.h.

References StatisticsVector< T >::constructor().

84  {
85  constructor(name);
86  }
void constructor()
this is the actual constructor, sets up all basic things
template<StatType T>
StatisticsVector< T >::StatisticsVector ( StatisticsVector< T > &  other)

Copy constructor.

template<StatType T>
StatisticsVector< T >::StatisticsVector ( int  argc,
char *  argv[] 
)

Advanced constructor that accepts arguments from the command line.

Member Function Documentation

template<StatType T>
void StatisticsVector< T >::auto_setdim ( )
protected
template<StatType T>
StatisticsPoint<T> StatisticsVector< T >::average ( std::vector< StatisticsPoint< T > > &  P)

Output average of statistical variables.

template<StatType T>
bool StatisticsVector< T >::check_current_time_for_statistics ( )
inline

Definition at line 269 of file StatisticsVector.h.

References StatisticsVector< T >::getCGTimeMin(), DPMBase::getTime(), StatisticsVector< T >::getTimeMaxStat(), and DPMBase::getTimeStep().

270  {
271  return (getTime() >= getCGTimeMin() && getTime() <= getTimeMaxStat() + getTimeStep());
272  }
Mdouble getTimeMaxStat()
Mdouble getTimeStep() const
Allows the time step dt to be accessed.
Definition: DPMBase.cc:368
Mdouble getTime() const
Access function for the time.
Definition: DPMBase.cc:158
template<StatType T>
void StatisticsVector< T >::constructor ( )

this is the actual constructor, sets up all basic things

Referenced by StatisticsVector< T >::StatisticsVector().

template<StatType T>
void StatisticsVector< T >::constructor ( std::string  name)
template<StatType T>
void StatisticsVector< T >::evaluate_force_statistics ( int  wp = 0)
template<StatType T>
void StatisticsVector< T >::evaluate_particle_statistics ( std::vector< BaseParticle * >::iterator  P,
int  wp = 0 
)

Calculates statistics for a single Particle.

template<StatType T>
void StatisticsVector< T >::evaluate_wall_force_statistics ( Vec3D  P,
int  wp = 0 
)
template<StatType T>
Mdouble StatisticsVector< T >::evaluateIntegral ( Mdouble  n1,
Mdouble  n2,
Mdouble  t 
)
inline

Definition at line 908 of file StatisticsVector.h.

References StatisticsVector< T >::CGPolynomial.

909  {
910  return CGPolynomial.evaluateIntegral(n1, n2, t);
911  }
NORMALIZED_POLYNOMIAL< T > CGPolynomial
Stores the Polynomial, if the cg function is an axisymmetric function Polynomial in r...
template<StatType T>
Mdouble StatisticsVector< T >::evaluatePolynomial ( Mdouble  r)
inline

Definition at line 892 of file StatisticsVector.h.

References StatisticsVector< T >::CGPolynomial.

893  {
894  return CGPolynomial.evaluate(r);
895  }
NORMALIZED_POLYNOMIAL< T > CGPolynomial
Stores the Polynomial, if the cg function is an axisymmetric function Polynomial in r...
template<StatType T>
Mdouble StatisticsVector< T >::evaluatePolynomialGradient ( Mdouble  r)
inline

Definition at line 900 of file StatisticsVector.h.

References StatisticsVector< T >::CGPolynomial.

901  {
902  return CGPolynomial.evaluateGradient(r);
903  }
NORMALIZED_POLYNOMIAL< T > CGPolynomial
Stores the Polynomial, if the cg function is an axisymmetric function Polynomial in r...
template<StatType T>
void StatisticsVector< T >::finishStatistics ( )
virtual

Finish all statistics (i.e. write out final data)

Reimplemented from DPMBase.

template<StatType T>
void StatisticsVector< T >::gather_force_statistics_from_fstat_and_data ( )
template<StatType T>
void StatisticsVector< T >::gather_force_statistics_from_p3c ( int  version)
template<StatType T>
void StatisticsVector< T >::gather_force_statistics_from_p3w ( int  version,
std::vector< int > &  index 
)
template<StatType T>
void StatisticsVector< T >::gatherContactStatistics ( unsigned int  index1,
int  index2,
Vec3D  Contact,
Mdouble  delta,
Mdouble  ctheta,
Mdouble  fdotn,
Mdouble  fdott,
Vec3D  P1_P2_normal_,
Vec3D  P1_P2_tangential 
)
virtual

Calculates statistics for one collision (can be any kind of collision)

Reimplemented from DPMBase.

template<StatType T>
std::vector<StatisticsPoint<T> > StatisticsVector< T >::getCGPoints ( )
inline

Definition at line 672 of file StatisticsVector.h.

References StatisticsVector< T >::Points.

673  {
674  return Points;
675  }
std::vector< StatisticsPoint< T > > Points
A vector that stores the values of the statistical variables at a given position. ...
template<StatType T>
CG StatisticsVector< T >::getCGShape ( )
inline

Definition at line 288 of file StatisticsVector.h.

References StatisticsVector< T >::CG_type.

289  {
290  return CG_type;
291  }
CG CG_type
coarse graining type (Gaussian, Heaviside, Polynomial)
template<StatType T>
Mdouble StatisticsVector< T >::getCGTimeAveragingInterval ( )
inline

Definition at line 261 of file StatisticsVector.h.

References StatisticsVector< T >::tintStat.

262  {
263  return tintStat;
264  }
Mdouble tintStat
Statistical output will only be created if tmaxStat-tintStat< t< tmaxStat.
template<StatType T>
Mdouble StatisticsVector< T >::getCGTimeMin ( )
inline

Definition at line 242 of file StatisticsVector.h.

References StatisticsVector< T >::tminStat.

Referenced by StatisticsVector< T >::check_current_time_for_statistics().

243  {
244  return tminStat;
245  }
Mdouble tminStat
Statistical output will only be created if t>tminStat.
template<StatType T>
Mdouble StatisticsVector< T >::getCGWidth ( )
inline

Definition at line 326 of file StatisticsVector.h.

References StatisticsVector< T >::w2.

327  {
328  return std::sqrt(w2);
329  }
Mdouble w2
coarse graining width squared; for HeavisideSphere and Gaussian
template<StatType T>
Mdouble StatisticsVector< T >::getCGWidth_over_rmax ( )
inline

Definition at line 583 of file StatisticsVector.h.

References StatisticsVector< T >::w_over_rmax.

584  {
585  return w_over_rmax;
586  }
Mdouble w_over_rmax
if w is not set manually then w will be set by multiplying this value by the largest particle radius ...
template<StatType T>
bool StatisticsVector< T >::getCGWidthalls ( )
inline

Definition at line 550 of file StatisticsVector.h.

References StatisticsVector< T >::walls.

551  {
552  return walls;
553  }
bool walls
Turns off walls before evaluation.
template<StatType T>
Mdouble StatisticsVector< T >::getCGWidthSquared ( )
inline

Definition at line 334 of file StatisticsVector.h.

References StatisticsVector< T >::w2.

335  {
336  return w2;
337  }
Mdouble w2
coarse graining width squared; for HeavisideSphere and Gaussian
template<StatType T>
Mdouble StatisticsVector< T >::getCutoff ( )
inline

Definition at line 342 of file StatisticsVector.h.

References StatisticsVector< T >::cutoff.

343  {
344  return cutoff;
345  }
Mdouble cutoff
The distance from the origin at which the cg function vanishes; cutoff=w for HeavisideSphere or Polyn...
template<StatType T>
Mdouble StatisticsVector< T >::getCutoff2 ( )
inline

Definition at line 350 of file StatisticsVector.h.

References StatisticsVector< T >::cutoff, and mathsFunc::square().

351  {
352  return mathsFunc::square(cutoff);
353  }
Mdouble cutoff
The distance from the origin at which the cg function vanishes; cutoff=w for HeavisideSphere or Polyn...
T square(T val)
squares a number
Definition: ExtendedMath.h:91
template<StatType T>
bool StatisticsVector< T >::getDoDoublePoints ( )
inline

Definition at line 844 of file StatisticsVector.h.

References StatisticsVector< T >::doDoublePoints.

845  {
846  return doDoublePoints;
847  }
template<StatType T>
bool StatisticsVector< T >::getDoGradient ( )
inline

Definition at line 478 of file StatisticsVector.h.

References StatisticsVector< T >::doGradient.

479  {
480  return doGradient;
481  }
bool doGradient
Determines if gradient is outputted.
template<StatType T>
bool StatisticsVector< T >::getDoIgnoreFixedParticles ( )
inline

Definition at line 510 of file StatisticsVector.h.

References StatisticsVector< T >::ignoreFixedParticles.

511  {
512  return ignoreFixedParticles;
513  }
bool ignoreFixedParticles
Determines if fixed particles contribute to particle statistics (density, ...)
template<StatType T>
bool StatisticsVector< T >::getDoPeriodicWalls ( )
inline

Definition at line 566 of file StatisticsVector.h.

References StatisticsVector< T >::periodicWalls.

567  {
568  return periodicWalls;
569  }
bool periodicWalls
Turns off periodic walls before evaluation (needed for averaging, because we do not yet check if part...
template<StatType T>
bool StatisticsVector< T >::getDoTimeAverage ( )
inline

Definition at line 400 of file StatisticsVector.h.

References StatisticsVector< T >::doTimeAverage.

401  {
402  return doTimeAverage;
403  }
bool doTimeAverage
Determines if output is averaged over time.
template<StatType T>
bool StatisticsVector< T >::getDoVariance ( )
inline

Definition at line 461 of file StatisticsVector.h.

References StatisticsVector< T >::doVariance.

462  {
463  return doVariance;
464  }
bool doVariance
Determines if variance is outputted.
template<StatType T>
Mdouble StatisticsVector< T >::getMirrorAtDomainBoundary ( )
inline

Definition at line 444 of file StatisticsVector.h.

References StatisticsVector< T >::mirrorAtDomainBoundary.

445  {
446  return mirrorAtDomainBoundary;
447  }
Mdouble mirrorAtDomainBoundary
0: Statistics near the wall are equal to statistics away from the wall; 1: Statistics are mirrored at...
template<StatType T>
void StatisticsVector< T >::getN ( int &  nx_,
int &  ny_,
int &  nz_ 
)
inline

Definition at line 303 of file StatisticsVector.h.

References StatisticsVector< T >::nx, StatisticsVector< T >::ny, and StatisticsVector< T >::nz.

304  {
305  nx_ = nx;
306  ny_ = ny;
307  nz_ = nz;
308  }
int nx
Grid size nx,ny,nz (by default the points of evaluation are placed in an grid on the domain [xminStat...
template<StatType T>
int StatisticsVector< T >::getNTimeAverage ( )
inline

Definition at line 794 of file StatisticsVector.h.

References StatisticsVector< T >::nTimeAverage.

795  {
796  return nTimeAverage;
797  }
int nTimeAverage
A counter needed to average over time.
template<StatType T>
bool StatisticsVector< T >::getNTimeAverageReset ( )
inline

Definition at line 860 of file StatisticsVector.h.

References StatisticsVector< T >::nTimeAverageReset.

861  {
862  return nTimeAverageReset;
863  }
int nTimeAverageReset
Determines after how many timesteps the time average is reset.
template<StatType T>
int StatisticsVector< T >::getNX ( )
inline

Definition at line 194 of file StatisticsVector.h.

References StatisticsVector< T >::nx.

195  {
196  return nx;
197  }
int nx
Grid size nx,ny,nz (by default the points of evaluation are placed in an grid on the domain [xminStat...
template<StatType T>
int StatisticsVector< T >::getNY ( )
inline

Definition at line 202 of file StatisticsVector.h.

References StatisticsVector< T >::ny.

203  {
204  return ny;
205  }
template<StatType T>
int StatisticsVector< T >::getNZ ( )
inline

Definition at line 210 of file StatisticsVector.h.

References StatisticsVector< T >::nz.

211  {
212  return nz;
213  }
template<StatType T>
std::string StatisticsVector< T >::getPolynomialName ( )
inline

Definition at line 828 of file StatisticsVector.h.

References StatisticsVector< T >::CGPolynomial.

829  {
830  return CGPolynomial.getName();
831  }
NORMALIZED_POLYNOMIAL< T > CGPolynomial
Stores the Polynomial, if the cg function is an axisymmetric function Polynomial in r...
template<StatType T>
unsigned int StatisticsVector< T >::getStepSize ( ) const
inline

Definition at line 916 of file StatisticsVector.h.

References StatisticsVector< T >::stepSize_.

917  {
918  return stepSize_;
919  }
unsigned int stepSize_
template<StatType T>
int StatisticsVector< T >::getStressTypeForFixedParticles ( )
inline

Definition at line 417 of file StatisticsVector.h.

References StatisticsVector< T >::StressTypeForFixedParticles.

418  {
420  }
int StressTypeForFixedParticles
Stress type for fixed particles.
template<StatType T>
bool StatisticsVector< T >::getSuperExact ( )
inline

Definition at line 494 of file StatisticsVector.h.

References StatisticsVector< T >::superexact.

495  {
496  return superexact;
497  }
bool superexact
If true, cutoff radius for Gaussian is set to 5*w (from 3*w)
template<StatType T>
Mdouble StatisticsVector< T >::getTimeMaxStat ( )
inline

Definition at line 250 of file StatisticsVector.h.

References DPMBase::getTimeMax(), and StatisticsVector< T >::tmaxStat.

Referenced by StatisticsVector< T >::check_current_time_for_statistics().

251  {
252  if (std::isnan(tmaxStat))
253  return getTimeMax();
254  else
255  return tmaxStat;
256  }
Mdouble tmaxStat
Statistical output will only be created if t
Mdouble getTimeMax() const
Allows the user to access the total simulation time during the simulation. Cannot change it though...
Definition: DPMBase.cc:194
template<StatType T>
Vec3D StatisticsVector< T >::getVelocityProfile ( Vec3D  Position)
protected
template<StatType T>
int StatisticsVector< T >::getVerbosityLevel ( ) const
inline

Definition at line 534 of file StatisticsVector.h.

References StatisticsVector< T >::verbosity.

535  {
536  return verbosity;
537  }
int verbosity
Determines how much is outputted to the terminal.
template<StatType T>
Mdouble StatisticsVector< T >::getXMaxStat ( )
inline

Definition at line 713 of file StatisticsVector.h.

References DPMBase::getXMax(), and StatisticsVector< T >::xmaxStat.

Referenced by StatisticsVector< T >::set_hx().

714  {
715  if (std::isnan(xmaxStat))
716  return getXMax();
717  else
718  return xmaxStat;
719  }
Mdouble getXMax() const
If the length of the problem domain in x-direction is XMax - XMin, then getXMax() returns XMax...
Definition: DPMBase.cc:231
template<StatType T>
Mdouble StatisticsVector< T >::getXMinStat ( )
inline

Functions to acces and change the domain of statistics.

Definition at line 680 of file StatisticsVector.h.

References DPMBase::getXMin(), and StatisticsVector< T >::xminStat.

Referenced by StatisticsVector< T >::set_hx().

681  {
682  if (std::isnan(xminStat))
683  return getXMin();
684  else
685  return xminStat;
686  }
Mdouble getXMin() const
If the length of the problem domain in x-direction is XMax - XMin, then getXMin() returns XMin...
Definition: DPMBase.cc:224
Mdouble xminStat
By default the domain is set to the domain of the MD problem (indicated by setting the stat-domain va...
template<StatType T>
Mdouble StatisticsVector< T >::getYMaxStat ( )
inline

Definition at line 724 of file StatisticsVector.h.

References DPMBase::getYMax(), and StatisticsVector< T >::ymaxStat.

Referenced by StatisticsVector< T >::set_hy().

725  {
726  if (std::isnan(ymaxStat))
727  return getYMax();
728  else
729  return ymaxStat;
730  }
Mdouble getYMax() const
If the length of the problem domain in y-direction is YMax - YMin, then getYMax() returns XMax...
Definition: DPMBase.cc:245
template<StatType T>
Mdouble StatisticsVector< T >::getYMinStat ( )
inline

Definition at line 691 of file StatisticsVector.h.

References DPMBase::getYMin(), and StatisticsVector< T >::yminStat.

Referenced by StatisticsVector< T >::set_hy().

692  {
693  if (std::isnan(yminStat))
694  return getYMin();
695  else
696  return yminStat;
697  }
Mdouble getYMin() const
If the length of the problem domain in y-direction is YMax - YMin, then getYMin() returns YMin...
Definition: DPMBase.cc:238
template<StatType T>
Mdouble StatisticsVector< T >::getZMaxStat ( )
inline

Definition at line 735 of file StatisticsVector.h.

References DPMBase::getZMax(), and StatisticsVector< T >::zmaxStat.

Referenced by StatisticsVector< T >::set_hz().

736  {
737  if (std::isnan(zmaxStat))
738  return getZMax();
739  else
740  return zmaxStat;
741  }
Mdouble getZMax() const
If the length of the problem domain in z-direction is ZMax - ZMin, then getZMax() returns ZMax...
Definition: DPMBase.cc:259
template<StatType T>
Mdouble StatisticsVector< T >::getZMinStat ( )
inline

Definition at line 702 of file StatisticsVector.h.

References DPMBase::getZMin(), and StatisticsVector< T >::zminStat.

Referenced by StatisticsVector< T >::set_hz().

703  {
704  if (std::isnan(zminStat))
705  return getZMin();
706  else
707  return zminStat;
708  }
Mdouble getZMin() const
If the length of the problem domain in z-direction is ZMax - ZMin, then getZMin() returns ZMin...
Definition: DPMBase.cc:252
template<StatType T>
void StatisticsVector< T >::initialiseStatistics ( )
virtual

Initializes statistics, i.e. setting w2, setting the grid and writing the header lines in the .stat file.

Reimplemented from DPMBase.

template<StatType T>
void StatisticsVector< T >::jump_fstat ( )
template<StatType T>
void StatisticsVector< T >::jump_p3c ( )
template<StatType T>
bool StatisticsVector< T >::loadPositions ( const char *  filename)
protected
template<StatType T>
bool StatisticsVector< T >::loadVelocityProfile ( const char *  filename)
protected
template<StatType T>
void StatisticsVector< T >::outputStatistics ( )
virtual

Calculates statistics for Particles (i.e. not collisions)

Reimplemented from DPMBase.

template<StatType T>
std::string StatisticsVector< T >::print_CG ( )

Output coarse graining variables.

template<StatType T>
void StatisticsVector< T >::print_help ( )
template<StatType T>
std::string StatisticsVector< T >::printStat ( )

Outputs member variable values to a std::string.

template<StatType T>
void StatisticsVector< T >::processStatistics ( bool  usethese)
virtual

Processes all gathered statistics and resets them afterwards. (Processing means either calculating time averages or writing out statistics)

Reimplemented from DPMBase.

template<StatType T>
bool StatisticsVector< T >::read_next_from_p3p_file ( )
protected
template<StatType T>
bool StatisticsVector< T >::readNextDataFile ( unsigned int  format)
template<StatType T>
void StatisticsVector< T >::readStatArguments ( int  argc,
char *  argv[] 
)
template<StatType T>
virtual void StatisticsVector< T >::reset_statistics ( )
virtual

Set all statistical variables to zero.

template<StatType T>
bool StatisticsVector< T >::satisfiesInclusionCriteria ( BaseParticle P)
protected
template<StatType T>
void StatisticsVector< T >::set_h ( Mdouble  h)
inline

Definition at line 184 of file StatisticsVector.h.

References StatisticsVector< T >::set_hx(), StatisticsVector< T >::set_hy(), and StatisticsVector< T >::set_hz().

185  {
186  set_hx(h);
187  set_hy(h);
188  set_hz(h);
189  }
void set_hx(Mdouble hx)
void set_hy(Mdouble hy)
void set_hz(Mdouble hz)
template<StatType T>
void StatisticsVector< T >::set_hmax ( Mdouble  new_)
inline

Definition at line 884 of file StatisticsVector.h.

References StatisticsVector< T >::hmax.

885  {
886  hmax = new_;
887  }
Mdouble hmax
defines the maximum height of the particles for which statistics are extracted
template<StatType T>
void StatisticsVector< T >::set_hx ( Mdouble  hx)
inline

Definition at line 132 of file StatisticsVector.h.

References StatisticsVector< T >::getXMaxStat(), StatisticsVector< T >::getXMinStat(), and StatisticsVector< T >::setNX().

Referenced by StatisticsVector< T >::set_h().

133  {
134  setNX(static_cast<int>(std::ceil((getXMaxStat() - getXMinStat()) / hx)));
135  }
Mdouble getXMinStat()
Functions to acces and change the domain of statistics.
void setNX(int new_)
template<StatType T>
void StatisticsVector< T >::set_hy ( Mdouble  hy)
inline

Definition at line 148 of file StatisticsVector.h.

References StatisticsVector< T >::getYMaxStat(), StatisticsVector< T >::getYMinStat(), and StatisticsVector< T >::setNY().

Referenced by StatisticsVector< T >::set_h().

149  {
150  setNY(static_cast<int>(std::ceil((getYMaxStat() - getYMinStat()) / hy)));
151  }
void setNY(int new_)
template<StatType T>
void StatisticsVector< T >::set_hz ( Mdouble  hz)
inline

Definition at line 166 of file StatisticsVector.h.

References StatisticsVector< T >::getZMaxStat(), StatisticsVector< T >::getZMinStat(), and StatisticsVector< T >::setNZ().

Referenced by StatisticsVector< T >::set_h().

167  {
168  setNZ(static_cast<int>(std::ceil((getZMaxStat() - getZMinStat()) / hz)));
169  }
void setNZ(int new_)
template<StatType T>
void StatisticsVector< T >::set_infiniteStressForFixedParticles ( bool  new_)
inline

Definition at line 427 of file StatisticsVector.h.

References StatisticsVector< T >::StressTypeForFixedParticles.

428  {
429  StressTypeForFixedParticles = 2 + new_;
430  }
int StressTypeForFixedParticles
Stress type for fixed particles.
template<StatType T>
void StatisticsVector< T >::set_Polynomial ( std::vector< Mdouble new_coefficients,
unsigned int  new_dim 
)
inline

Definition at line 804 of file StatisticsVector.h.

References StatisticsVector< T >::CGPolynomial.

805  {
806  CGPolynomial.set_polynomial(new_coefficients, new_dim);
807  }
NORMALIZED_POLYNOMIAL< T > CGPolynomial
Stores the Polynomial, if the cg function is an axisymmetric function Polynomial in r...
template<StatType T>
void StatisticsVector< T >::set_Polynomial ( Mdouble new_coefficients,
unsigned int  num_coeff,
unsigned int  new_dim 
)
inline

Definition at line 812 of file StatisticsVector.h.

References StatisticsVector< T >::CGPolynomial.

813  {
814  CGPolynomial.set_polynomial(new_coefficients, num_coeff, new_dim);
815  }
NORMALIZED_POLYNOMIAL< T > CGPolynomial
Stores the Polynomial, if the cg function is an axisymmetric function Polynomial in r...
template<StatType T>
void StatisticsVector< T >::set_rmax ( Mdouble  new_)
inline

Definition at line 876 of file StatisticsVector.h.

References StatisticsVector< T >::rmax.

877  {
878  rmax = new_;
879  }
Mdouble rmax
defines the maximum radius of the particles for which statistics are extracted
template<StatType T>
void StatisticsVector< T >::set_rmin ( Mdouble  new_)
inline

Definition at line 868 of file StatisticsVector.h.

References StatisticsVector< T >::rmin.

869  {
870  rmin = new_;
871  }
Mdouble rmin
defines the minimum radius of the particles for which statistics are extracted
template<StatType T>
void StatisticsVector< T >::set_statType ( )
template<StatType T>
void StatisticsVector< T >::setCGShape ( const char *  new_)
template<StatType T>
void StatisticsVector< T >::setCGShape ( CG  new_)
template<StatType T>
void StatisticsVector< T >::setCGTimeAveragingInterval ( Mdouble  t)
inline

Definition at line 234 of file StatisticsVector.h.

References StatisticsVector< T >::tintStat.

235  {
236  tintStat = t;
237  }
Mdouble tintStat
Statistical output will only be created if tmaxStat-tintStat< t< tmaxStat.
template<StatType T>
void StatisticsVector< T >::setCGTimeMin ( Mdouble  t)
inline

Definition at line 218 of file StatisticsVector.h.

References StatisticsVector< T >::tminStat.

219  {
220  tminStat = t;
221  }
Mdouble tminStat
Statistical output will only be created if t>tminStat.
template<StatType T>
void StatisticsVector< T >::setCGWidth ( Mdouble  w)
inline

Set CG variables w2 and CG_invvolume.

Definition at line 312 of file StatisticsVector.h.

References StatisticsVector< T >::setCGWidth2(), and mathsFunc::square().

313  {
315  }
T square(T val)
squares a number
Definition: ExtendedMath.h:91
void setCGWidth2(Mdouble new_)
Set CG variables w2 and CG_invvolume.
template<StatType T>
void StatisticsVector< T >::setCGWidth2 ( Mdouble  new_)

Set CG variables w2 and CG_invvolume.

Referenced by StatisticsVector< T >::setCGWidth().

template<StatType T>
void StatisticsVector< T >::setCGWidth_over_rmax ( Mdouble  new_)
inline

Definition at line 575 of file StatisticsVector.h.

References StatisticsVector< T >::w_over_rmax.

576  {
577  w_over_rmax = new_;
578  }
Mdouble w_over_rmax
if w is not set manually then w will be set by multiplying this value by the largest particle radius ...
template<StatType T>
void StatisticsVector< T >::setCGWidthalls ( bool  new_)
inline

Definition at line 542 of file StatisticsVector.h.

References StatisticsVector< T >::walls.

543  {
544  walls = new_;
545  }
bool walls
Turns off walls before evaluation.
template<StatType T>
void StatisticsVector< T >::setDoDoublePoints ( bool  new_)
inline

Definition at line 836 of file StatisticsVector.h.

References StatisticsVector< T >::doDoublePoints.

837  {
838  doDoublePoints = new_;
839  }
template<StatType T>
void StatisticsVector< T >::setDoGradient ( bool  new_)
inline

Definition at line 470 of file StatisticsVector.h.

References StatisticsVector< T >::doGradient.

471  {
472  doGradient = new_;
473  }
bool doGradient
Determines if gradient is outputted.
template<StatType T>
void StatisticsVector< T >::setDoIgnoreFixedParticles ( bool  new_)
inline

Definition at line 502 of file StatisticsVector.h.

References StatisticsVector< T >::ignoreFixedParticles.

503  {
504  ignoreFixedParticles = new_;
505  }
bool ignoreFixedParticles
Determines if fixed particles contribute to particle statistics (density, ...)
template<StatType T>
void StatisticsVector< T >::setDoPeriodicWalls ( bool  new_)
inline

Definition at line 558 of file StatisticsVector.h.

References StatisticsVector< T >::periodicWalls.

Referenced by Statistics().

559  {
560  periodicWalls = new_;
561  }
bool periodicWalls
Turns off periodic walls before evaluation (needed for averaging, because we do not yet check if part...
template<StatType T>
void StatisticsVector< T >::setDoTimeAverage ( bool  new_)
inline

Definition at line 392 of file StatisticsVector.h.

References StatisticsVector< T >::doTimeAverage.

393  {
394  doTimeAverage = new_;
395  }
bool doTimeAverage
Determines if output is averaged over time.
template<StatType T>
void StatisticsVector< T >::setDoVariance ( bool  new_)
inline

Definition at line 453 of file StatisticsVector.h.

References StatisticsVector< T >::doVariance.

454  {
455  doVariance = new_;
456  }
bool doVariance
Determines if variance is outputted.
template<StatType T>
Mdouble StatisticsVector< T >::setInfinitelyLongDistance ( )
template<StatType T>
void StatisticsVector< T >::setMirrorAtDomainBoundary ( Mdouble  new_)
inline

Definition at line 436 of file StatisticsVector.h.

References StatisticsVector< T >::mirrorAtDomainBoundary.

437  {
438  mirrorAtDomainBoundary = new_;
439  }
Mdouble mirrorAtDomainBoundary
0: Statistics near the wall are equal to statistics away from the wall; 1: Statistics are mirrored at...
template<StatType T>
void StatisticsVector< T >::setN ( int  n)
inline

Definition at line 174 of file StatisticsVector.h.

References StatisticsVector< T >::setNX(), StatisticsVector< T >::setNY(), and StatisticsVector< T >::setNZ().

175  {
176  setNX(n);
177  setNY(n);
178  setNZ(n);
179  }
void setNX(int new_)
void setNZ(int new_)
void setNY(int new_)
template<StatType T>
void StatisticsVector< T >::setN ( int  nx_,
int  ny_,
int  nz_ 
)
inline

Definition at line 296 of file StatisticsVector.h.

References StatisticsVector< T >::nx, StatisticsVector< T >::ny, and StatisticsVector< T >::nz.

297  {
298  nx = nx_;
299  ny = ny_;
300  nz = nz_;
301  }
int nx
Grid size nx,ny,nz (by default the points of evaluation are placed in an grid on the domain [xminStat...
template<StatType T>
void StatisticsVector< T >::setNTimeAverageReset ( int  new_)
inline

Definition at line 852 of file StatisticsVector.h.

References StatisticsVector< T >::nTimeAverageReset.

853  {
854  nTimeAverageReset = new_;
855  }
int nTimeAverageReset
Determines after how many timesteps the time average is reset.
template<StatType T>
void StatisticsVector< T >::setNX ( int  new_)
inline

Definition at line 124 of file StatisticsVector.h.

References StatisticsVector< T >::nx.

Referenced by StatisticsVector< T >::set_hx(), and StatisticsVector< T >::setN().

125  {
126  nx = new_;
127  }
int nx
Grid size nx,ny,nz (by default the points of evaluation are placed in an grid on the domain [xminStat...
template<StatType T>
void StatisticsVector< T >::setNY ( int  new_)
inline

Definition at line 140 of file StatisticsVector.h.

References StatisticsVector< T >::ny.

Referenced by StatisticsVector< T >::set_hy(), and StatisticsVector< T >::setN().

141  {
142  ny = new_;
143  }
template<StatType T>
void StatisticsVector< T >::setNZ ( int  new_)
inline

Definition at line 156 of file StatisticsVector.h.

References DPMBase::getSystemDimensions(), and StatisticsVector< T >::nz.

Referenced by StatisticsVector< T >::set_hz(), and StatisticsVector< T >::setN().

157  {
158  nz = new_;
159  if (getSystemDimensions() < 3)
160  std::cerr << "Warning in set_nz: dimension less than 3" << std::endl;
161  }
unsigned int getSystemDimensions() const
Returns the dimension of the simulation. Note there is also a particle dimension. ...
Definition: DPMBase.cc:466
template<StatType T>
void StatisticsVector< T >::setPolynomialName ( const char *  new_name)
inline

Definition at line 820 of file StatisticsVector.h.

References StatisticsVector< T >::CGPolynomial.

821  {
822  CGPolynomial.setName(new_name);
823  }
NORMALIZED_POLYNOMIAL< T > CGPolynomial
Stores the Polynomial, if the cg function is an axisymmetric function Polynomial in r...
template<StatType T>
void StatisticsVector< T >::setPositions ( )

Set position of StatisticsPoint points and set variables to 0.

template<StatType T>
void StatisticsVector< T >::setStepSize ( unsigned int  stepSize)
inline

Definition at line 924 of file StatisticsVector.h.

References StatisticsVector< T >::stepSize_.

925  {
926  stepSize_ = stepSize;
927  }
unsigned int stepSize_
template<StatType T>
void StatisticsVector< T >::setStressTypeForFixedParticles ( int  new_)
inline

Definition at line 409 of file StatisticsVector.h.

References StatisticsVector< T >::StressTypeForFixedParticles.

410  {
412  }
int StressTypeForFixedParticles
Stress type for fixed particles.
template<StatType T>
void StatisticsVector< T >::setSuperExact ( bool  new_)
inline

Definition at line 486 of file StatisticsVector.h.

References StatisticsVector< T >::superexact.

487  {
488  superexact = new_;
489  }
bool superexact
If true, cutoff radius for Gaussian is set to 5*w (from 3*w)
template<StatType T>
void StatisticsVector< T >::setTimeMaxStat ( Mdouble  t)
inline

Definition at line 226 of file StatisticsVector.h.

References StatisticsVector< T >::tmaxStat.

227  {
228  tmaxStat = t;
229  }
Mdouble tmaxStat
Statistical output will only be created if t
template<StatType T>
void StatisticsVector< T >::setVerbosityLevel ( int  new_)
inline

Definition at line 526 of file StatisticsVector.h.

References StatisticsVector< T >::verbosity.

527  {
528  verbosity = new_;
529  }
int verbosity
Determines how much is outputted to the terminal.
template<StatType T>
void StatisticsVector< T >::setXMaxStat ( Mdouble  xmaxStat_)
inline

Definition at line 770 of file StatisticsVector.h.

References StatisticsVector< T >::xmaxStat.

771  {
772  xmaxStat = xmaxStat_;
773  }
template<StatType T>
void StatisticsVector< T >::setXMinStat ( Mdouble  xminStat_)
inline

Definition at line 746 of file StatisticsVector.h.

References StatisticsVector< T >::xminStat.

747  {
748  xminStat = xminStat_;
749  }
Mdouble xminStat
By default the domain is set to the domain of the MD problem (indicated by setting the stat-domain va...
template<StatType T>
void StatisticsVector< T >::setYMaxStat ( Mdouble  ymaxStat_)
inline

Definition at line 778 of file StatisticsVector.h.

References StatisticsVector< T >::ymaxStat.

779  {
780  ymaxStat = ymaxStat_;
781  }
template<StatType T>
void StatisticsVector< T >::setYMinStat ( Mdouble  yminStat_)
inline

Definition at line 754 of file StatisticsVector.h.

References StatisticsVector< T >::yminStat.

755  {
756  yminStat = yminStat_;
757  }
template<StatType T>
void StatisticsVector< T >::setZMaxStat ( Mdouble  zmaxStat_)
inline

Definition at line 786 of file StatisticsVector.h.

References StatisticsVector< T >::zmaxStat.

787  {
788  zmaxStat = zmaxStat_;
789  }
template<StatType T>
void StatisticsVector< T >::setZMinStat ( Mdouble  zminStat_)
inline

Definition at line 762 of file StatisticsVector.h.

References StatisticsVector< T >::zminStat.

763  {
764  zminStat = zminStat_;
765  }
template<StatType T>
void StatisticsVector< T >::statistics_from_fstat_and_data ( )

get StatisticsPoint

Referenced by Statistics().

template<StatType T>
void StatisticsVector< T >::statistics_from_p3 ( )
template<StatType T>
void StatisticsVector< T >::verbose ( )
inline

Definition at line 518 of file StatisticsVector.h.

References StatisticsVector< T >::verbosity.

519  {
520  verbosity = 2;
521  }
int verbosity
Determines how much is outputted to the terminal.
template<StatType T>
void StatisticsVector< T >::write_statistics ( )

Writes regular statistics.

template<StatType T>
void StatisticsVector< T >::write_time_average_statistics ( )

Writes out time averaged statistics.

template<StatType T>
void StatisticsVector< T >::writeOutputFiles ( )
virtual

Writes the simulation data onto all the files i.e. .data, .ene, .fstat ...

Reimplemented from DPMBase.

Member Data Documentation

template<StatType T>
CG StatisticsVector< T >::CG_type
protected

coarse graining type (Gaussian, Heaviside, Polynomial)

Definition at line 1025 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getCGShape().

template<StatType T>
Mdouble StatisticsVector< T >::cutoff
protected

The distance from the origin at which the cg function vanishes; cutoff=w for HeavisideSphere or Polynomial, 3*w for Gaussian.

Definition at line 1042 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getCutoff(), and StatisticsVector< T >::getCutoff2().

template<StatType T>
Mdouble StatisticsVector< T >::cutoff2
protected

Definition at line 1042 of file StatisticsVector.h.

template<StatType T>
bool StatisticsVector< T >::doDoublePoints
protected
template<StatType T>
bool StatisticsVector< T >::doGradient
protected

Determines if gradient is outputted.

Definition at line 1014 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getDoGradient(), and StatisticsVector< T >::setDoGradient().

template<StatType T>
bool StatisticsVector< T >::doTimeAverage
protected

Determines if output is averaged over time.

Definition at line 999 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getDoTimeAverage(), and StatisticsVector< T >::setDoTimeAverage().

template<StatType T>
bool StatisticsVector< T >::doVariance
protected

Determines if variance is outputted.

Definition at line 1009 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getDoVariance(), and StatisticsVector< T >::setDoVariance().

template<StatType T>
std::vector<StatisticsPoint<T> > StatisticsVector< T >::dx
protected

A vector that stores the gradient in x of all statistical variables at a given position.

Definition at line 960 of file StatisticsVector.h.

template<StatType T>
std::vector<StatisticsPoint<T> > StatisticsVector< T >::dxTimeAverage
protected

a vector used to sum up all statistical gradients in dx for time-averaging

Definition at line 984 of file StatisticsVector.h.

template<StatType T>
std::vector<StatisticsPoint<T> > StatisticsVector< T >::dy
protected

A vector that stores the gradient in y of all statistical variables at a given position.

Definition at line 964 of file StatisticsVector.h.

template<StatType T>
std::vector<StatisticsPoint<T> > StatisticsVector< T >::dyTimeAverage
protected

a vector used to sum up all statistical gradients in dy for time-averaging

Definition at line 989 of file StatisticsVector.h.

template<StatType T>
std::vector<StatisticsPoint<T> > StatisticsVector< T >::dz
protected

A vector that stores the gradient in z of all statistical variables at a given position.

Definition at line 968 of file StatisticsVector.h.

template<StatType T>
std::vector<StatisticsPoint<T> > StatisticsVector< T >::dzTimeAverage
protected

a vector used to sum up all statistical gradients in dz for time-averaging

Definition at line 994 of file StatisticsVector.h.

template<StatType T>
int StatisticsVector< T >::format
protected

format of the data input file

Definition at line 1120 of file StatisticsVector.h.

template<StatType T>
Mdouble StatisticsVector< T >::hmax
protected

defines the maximum height of the particles for which statistics are extracted

Definition at line 1085 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::set_hmax().

template<StatType T>
bool StatisticsVector< T >::ignoreFixedParticles
protected

Determines if fixed particles contribute to particle statistics (density, ...)

Definition at line 1101 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getDoIgnoreFixedParticles(), and StatisticsVector< T >::setDoIgnoreFixedParticles().

template<StatType T>
Mdouble StatisticsVector< T >::indSpecies
protected

defines the species for which statistics are extracted (-1 for all species)

Definition at line 1069 of file StatisticsVector.h.

template<StatType T>
bool StatisticsVector< T >::isMDCLR
protected

Definition at line 1128 of file StatisticsVector.h.

template<StatType T>
Mdouble StatisticsVector< T >::mirrorAtDomainBoundary
protected

0: Statistics near the wall are equal to statistics away from the wall; 1: Statistics are mirrored at the domain boundaries; up to a maximum depth specified by this number

Definition at line 1125 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getMirrorAtDomainBoundary(), and StatisticsVector< T >::setMirrorAtDomainBoundary().

template<StatType T>
int StatisticsVector< T >::nTimeAverage
protected

A counter needed to average over time.

Definition at line 1019 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getNTimeAverage().

template<StatType T>
int StatisticsVector< T >::nTimeAverageReset
protected

Determines after how many timesteps the time average is reset.

Definition at line 1004 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getNTimeAverageReset(), and StatisticsVector< T >::setNTimeAverageReset().

template<StatType T>
int StatisticsVector< T >::nx
protected

Grid size nx,ny,nz (by default the points of evaluation are placed in an grid on the domain [xminStat,xmaxStat]x[yminStat,ymaxStat]x[zminStat,zmaxStat].

Definition at line 940 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getN(), StatisticsVector< T >::getNX(), StatisticsVector< T >::setN(), and StatisticsVector< T >::setNX().

template<StatType T>
int StatisticsVector< T >::nxMirrored
protected

extension of grid size from mirrored points

Definition at line 950 of file StatisticsVector.h.

template<StatType T>
int StatisticsVector< T >::ny
protected
template<StatType T>
int StatisticsVector< T >::nyMirrored
protected

Definition at line 950 of file StatisticsVector.h.

template<StatType T>
int StatisticsVector< T >::nz
protected
template<StatType T>
int StatisticsVector< T >::nzMirrored
protected

Definition at line 950 of file StatisticsVector.h.

template<StatType T>
Vec3D StatisticsVector< T >::P1
protected

Position of first contact point.

Definition at line 1142 of file StatisticsVector.h.

template<StatType T>
Vec3D StatisticsVector< T >::P1_P2_CollisionalHeatFlux
protected

not yet working

Definition at line 1164 of file StatisticsVector.h.

template<StatType T>
Vec3D StatisticsVector< T >::P1_P2_Contact
protected

Definition at line 1154 of file StatisticsVector.h.

template<StatType T>
Matrix3D StatisticsVector< T >::P1_P2_ContactCoupleStress
protected

Definition at line 1152 of file StatisticsVector.h.

template<StatType T>
Mdouble StatisticsVector< T >::P1_P2_Dissipation
protected

not yet working

Definition at line 1166 of file StatisticsVector.h.

template<StatType T>
Mdouble StatisticsVector< T >::P1_P2_distance
protected

Length of contact line.

Definition at line 1148 of file StatisticsVector.h.

template<StatType T>
MatrixSymmetric3D StatisticsVector< T >::P1_P2_Fabric
protected

Fabric.

Definition at line 1162 of file StatisticsVector.h.

template<StatType T>
Vec3D StatisticsVector< T >::P1_P2_normal
protected

Direction of contact.

Definition at line 1146 of file StatisticsVector.h.

template<StatType T>
Matrix3D StatisticsVector< T >::P1_P2_NormalStress
protected

Contact stress from normal forces along the line of contact.

Definition at line 1150 of file StatisticsVector.h.

template<StatType T>
Vec3D StatisticsVector< T >::P1_P2_NormalTraction
protected

Traction from normal forces at contact of flow with fixed particles or walls.

Definition at line 1158 of file StatisticsVector.h.

template<StatType T>
Mdouble StatisticsVector< T >::P1_P2_Potential
protected

not yet working

Definition at line 1168 of file StatisticsVector.h.

template<StatType T>
Matrix3D StatisticsVector< T >::P1_P2_TangentialStress
protected

Contact stress from tangential forces along the line of contact.

Definition at line 1156 of file StatisticsVector.h.

template<StatType T>
Vec3D StatisticsVector< T >::P1_P2_TangentialTraction
protected

Traction from tangential forces at contact of flow with fixed particles or walls.

Definition at line 1160 of file StatisticsVector.h.

template<StatType T>
Vec3D StatisticsVector< T >::P2
protected

Position of second contact point.

Definition at line 1144 of file StatisticsVector.h.

template<StatType T>
std::fstream StatisticsVector< T >::p3c_file
protected

Definition at line 1197 of file StatisticsVector.h.

template<StatType T>
std::fstream StatisticsVector< T >::p3p_file
protected

Definition at line 1196 of file StatisticsVector.h.

template<StatType T>
std::fstream StatisticsVector< T >::p3w_file
protected

Definition at line 1198 of file StatisticsVector.h.

template<StatType T>
bool StatisticsVector< T >::periodicWalls
protected

Turns off periodic walls before evaluation (needed for averaging, because we do not yet check if particle is in domain)

Todo:
{Thomas: the case periodicWalls=true seems to mess up some statistics. Needs to be checked or removed}

Definition at line 1096 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getDoPeriodicWalls(), and StatisticsVector< T >::setDoPeriodicWalls().

template<StatType T>
std::vector<StatisticsPoint<T> > StatisticsVector< T >::Points
protected

A vector that stores the values of the statistical variables at a given position.

Definition at line 956 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getCGPoints().

template<StatType T>
std::vector<Vec3D> StatisticsVector< T >::positions_
protected

Definition at line 1212 of file StatisticsVector.h.

template<StatType T>
Mdouble StatisticsVector< T >::rmax
protected

defines the maximum radius of the particles for which statistics are extracted

Definition at line 1080 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::set_rmax().

template<StatType T>
Mdouble StatisticsVector< T >::rmin
protected

defines the minimum radius of the particles for which statistics are extracted

Todo:
Thomas: maybe this fixed condition should be replaced by a condition function, bool include_statistics_if()

Definition at line 1075 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::set_rmin().

template<StatType T>
StatType StatisticsVector< T >::statType
protected

Possible values X,Y,Z,XY,XZ,YZ,XYZ,RAZ,RA,RZ,AZ,R,A are used to determine if the statistics are averaged; f.e. StatType X is averaged over y and z.

Definition at line 936 of file StatisticsVector.h.

template<StatType T>
unsigned int StatisticsVector< T >::stepSize_
protected
template<StatType T>
int StatisticsVector< T >::StressTypeForFixedParticles
protected

Stress type for fixed particles.

0 no Stress from fixed particles
1 Stress from fixed particles distributed between Contact and flowing Particle COM (default)
2 Stress from fixed particles distributed between fixed and flowing Particle COM
3 Stress from fixed particles extends from flowing particle to infinity

Definition at line 1110 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getStressTypeForFixedParticles(), StatisticsVector< T >::set_infiniteStressForFixedParticles(), and StatisticsVector< T >::setStressTypeForFixedParticles().

template<StatType T>
bool StatisticsVector< T >::superexact
protected

If true, cutoff radius for Gaussian is set to 5*w (from 3*w)

Definition at line 1130 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getSuperExact(), and StatisticsVector< T >::setSuperExact().

template<StatType T>
std::vector<StatisticsPoint<T> > StatisticsVector< T >::timeAverage
protected

A vector used to sum up all statistical values in Points for time-averaging.

Definition at line 974 of file StatisticsVector.h.

template<StatType T>
std::vector<StatisticsPoint<T> > StatisticsVector< T >::timeVariance
protected

a vector used to sum up the variance in time of all statistical values

Definition at line 979 of file StatisticsVector.h.

template<StatType T>
Mdouble StatisticsVector< T >::tintStat
protected

Statistical output will only be created if tmaxStat-tintStat< t< tmaxStat.

Definition at line 1064 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getCGTimeAveragingInterval(), and StatisticsVector< T >::setCGTimeAveragingInterval().

template<StatType T>
Mdouble StatisticsVector< T >::tmaxStat
protected

Statistical output will only be created if t<tmaxStat.

Definition at line 1059 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getTimeMaxStat(), and StatisticsVector< T >::setTimeMaxStat().

template<StatType T>
Mdouble StatisticsVector< T >::tminStat
protected

Statistical output will only be created if t>tminStat.

Definition at line 1054 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getCGTimeMin(), and StatisticsVector< T >::setCGTimeMin().

template<StatType T>
std::vector<Vec3D> StatisticsVector< T >::VelocityProfile
protected

Definition at line 1184 of file StatisticsVector.h.

template<StatType T>
Vec3D StatisticsVector< T >::VelocityProfile_D
protected

Definition at line 1194 of file StatisticsVector.h.

template<StatType T>
Vec3D StatisticsVector< T >::VelocityProfile_Min
protected

Definition at line 1189 of file StatisticsVector.h.

template<StatType T>
int StatisticsVector< T >::verbosity
protected

Determines how much is outputted to the terminal.

0 no output
1 basic output (timesteps)
2 full output (number of forces and particles, md and stat parameters)

Definition at line 1118 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getVerbosityLevel(), StatisticsVector< T >::setVerbosityLevel(), and StatisticsVector< T >::verbose().

template<StatType T>
Mdouble StatisticsVector< T >::w2
protected

coarse graining width squared; for HeavisideSphere and Gaussian

Definition at line 1037 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getCGWidth(), and StatisticsVector< T >::getCGWidthSquared().

template<StatType T>
Mdouble StatisticsVector< T >::w_over_rmax
protected

if w is not set manually then w will be set by multiplying this value by the largest particle radius at t=0

Definition at line 1047 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getCGWidth_over_rmax(), and StatisticsVector< T >::setCGWidth_over_rmax().

template<StatType T>
bool StatisticsVector< T >::walls
protected

Turns off walls before evaluation.

Definition at line 1090 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getCGWidthalls(), and StatisticsVector< T >::setCGWidthalls().

template<StatType T>
Mdouble StatisticsVector< T >::xmaxStat
protected
template<StatType T>
Mdouble StatisticsVector< T >::xminStat
protected

By default the domain is set to the domain of the MD problem (indicated by setting the stat-domain values to nan), but can be resized.

Definition at line 946 of file StatisticsVector.h.

Referenced by StatisticsVector< T >::getXMinStat(), and StatisticsVector< T >::setXMinStat().

template<StatType T>
Mdouble StatisticsVector< T >::ymaxStat
protected
template<StatType T>
Mdouble StatisticsVector< T >::yminStat
protected
template<StatType T>
Mdouble StatisticsVector< T >::zmaxStat
protected
template<StatType T>
Mdouble StatisticsVector< T >::zminStat
protected

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