MercuryDPM
Alpha
|
This class is used to extract statistical data from MD simulations. More...
#include <StatisticsPoint.h>
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) |
void | setIndSpecies (unsigned int indSpecies) |
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... | |
bool | readRestartFile (bool restarted=true) |
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. Returns 0 if it is successful, 1 otherwise. More... | |
int | readRestartFile (std::string fileName) |
The same as readRestartFile(bool), but 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 data from a restart file, e.g. domain data and particle data. More... | |
virtual bool | readUserDefinedWall (std::string type, std::istream &is) |
virtual void | readOld (std::istream &is) |
Reads all data from a restart file, e.g. domain data and particle data; 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[]) |
Interprets the i^th command-line argument. More... | |
virtual bool | checkParticleForInteraction (const BaseParticle &P) |
Checks if the particle having any interaction with walls or other particles. More... | |
virtual bool | checkParticleForInteractionLocal (const BaseParticle &P) |
Checks if a particle P has any interaction with walls or other particles in the local domain. More... | |
bool | checkParticleForInteractionLocalPeriodic (const BaseParticle &P) |
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... | |
void | setWallsWriteVTK (FileType writeWallsVTK) |
Allows to set the flag for enabling or disabling particle rotation in the simulations. More... | |
void | setParticlesWriteVTK (bool writeParticlesVTK) |
Allows to set the flag for enabling or disabling particle rotation in the simulations. More... | |
FileType | getWallsWriteVTK () const |
Returns a flag indicating if particle rotation is enabled or disabled. More... | |
bool | getParticlesWriteVTK () const |
Returns a flag indicating if particle rotation is enabled or disabled. More... | |
bool | getDoCGAlways () const |
Vec3D | getMin () const |
Return the "bottom left" corner of the domain, a vector with xMin_, yMin_ and zMin_. More... | |
Vec3D | getMax () const |
Return the "upper right" corner of the domain, a vector with xMin_, yMin_ and zMin_. More... | |
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 | setMin (Vec3D min) |
Sets the values xMin, yMin, zMin of the problem domain, which is [xMin,xMax]x[yMin,yMax]x[zMin,zMax]. More... | |
void | setMax (Vec3D max) |
Sets the values xMax, yMax, zMax of the problem domain, which is [xMin,xMax]x[yMin,yMax]x[zMin,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... | |
int | getAddLarge () const |
returns the number of large particles that are to be added on restart. More... | |
int | getAddSmall () const |
returns the number of small particles that are to be added on restart. More... | |
void | setAddLarge (int new_addL) |
sets the number of large particles that are to be added on restart. More... | |
void | setAddSmall (int new_addS) |
sets the number of small particles that are to be added on restart. 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 |
Returns the additional arguments for xballs. More... | |
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... | |
Mdouble | getGravitationalEnergy () const |
Returns the global gravitational potential 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 File & | getDataFile () |
The non const version. Allows one to edit the File::dataFile. More... | |
MERCURY_DEPRECATED File & | getEneFile () |
The non const version. Allows to edit the File::eneFile. More... | |
MERCURY_DEPRECATED File & | getFStatFile () |
The non const version. Allows to edit the File::fStatFile. More... | |
MERCURY_DEPRECATED File & | getRestartFile () |
The non const version. Allows to edit the File::restartFile. More... | |
MERCURY_DEPRECATED File & | getStatFile () |
The non const version. Allows to edit the File::statFile. More... | |
MERCURY_DEPRECATED const File & | getDataFile () const |
The const version. Does not allow for any editing of the File::dataFile. More... | |
MERCURY_DEPRECATED const File & | getEneFile () const |
The const version. Does not allow for any editing of the File::eneFile. More... | |
MERCURY_DEPRECATED const File & | getFStatFile () const |
The const version. Does not allow for any editing of the File::fStatFile. More... | |
MERCURY_DEPRECATED const File & | getRestartFile () const |
The const version. Does not allow for any editing of the File::restartFile. More... | |
MERCURY_DEPRECATED const File & | getStatFile () 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... | |
Mdouble | domainSize () const |
void | writeVTK () const |
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 | 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< Vec3D > | VelocityProfile |
Vec3D | VelocityProfile_Min |
Vec3D | VelocityProfile_D |
std::fstream | p3p_file |
std::fstream | p3c_file |
std::fstream | p3w_file |
unsigned int | stepSize_ |
std::vector< Vec3D > | positions_ |
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... | |
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.
|
inline |
Basic constructor only calls constructor()
Definition at line 75 of file StatisticsVector.h.
References StatisticsVector< T >::constructor().
|
inline |
Definition at line 83 of file StatisticsVector.h.
References StatisticsVector< T >::constructor().
StatisticsVector< T >::StatisticsVector | ( | StatisticsVector< T > & | other | ) |
Copy constructor.
StatisticsVector< T >::StatisticsVector | ( | int | argc, |
char * | argv[] | ||
) |
Advanced constructor that accepts arguments from the command line.
|
protected |
StatisticsPoint<T> StatisticsVector< T >::average | ( | std::vector< StatisticsPoint< T > > & | P | ) |
Output average of statistical variables.
|
inline |
Definition at line 269 of file StatisticsVector.h.
References StatisticsVector< T >::getCGTimeMin(), DPMBase::getTime(), StatisticsVector< T >::getTimeMaxStat(), and DPMBase::getTimeStep().
void StatisticsVector< T >::constructor | ( | ) |
this is the actual constructor, sets up all basic things
Referenced by StatisticsVector< T >::StatisticsVector().
void StatisticsVector< T >::constructor | ( | std::string | name | ) |
void StatisticsVector< T >::evaluate_force_statistics | ( | int | wp = 0 | ) |
void StatisticsVector< T >::evaluate_particle_statistics | ( | std::vector< BaseParticle * >::iterator | P, |
int | wp = 0 |
||
) |
Calculates statistics for a single Particle.
void StatisticsVector< T >::evaluate_wall_force_statistics | ( | Vec3D | P, |
int | wp = 0 |
||
) |
|
inline |
Definition at line 908 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
|
inline |
Definition at line 892 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
|
inline |
Definition at line 900 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
|
virtual |
Finish all statistics (i.e. write out final data)
Reimplemented from DPMBase.
void StatisticsVector< T >::gather_force_statistics_from_fstat_and_data | ( | ) |
void StatisticsVector< T >::gather_force_statistics_from_p3c | ( | int | version | ) |
void StatisticsVector< T >::gather_force_statistics_from_p3w | ( | int | version, |
std::vector< int > & | index | ||
) |
|
virtual |
Calculates statistics for one collision (can be any kind of collision)
Reimplemented from DPMBase.
|
inline |
Definition at line 672 of file StatisticsVector.h.
References StatisticsVector< T >::Points.
|
inline |
Definition at line 288 of file StatisticsVector.h.
References StatisticsVector< T >::CG_type.
|
inline |
Definition at line 261 of file StatisticsVector.h.
References StatisticsVector< T >::tIntStat.
|
inline |
Definition at line 242 of file StatisticsVector.h.
References StatisticsVector< T >::tMinStat.
Referenced by StatisticsVector< T >::check_current_time_for_statistics().
|
inline |
Definition at line 326 of file StatisticsVector.h.
References StatisticsVector< T >::w2.
|
inline |
Definition at line 583 of file StatisticsVector.h.
References StatisticsVector< T >::w_over_rmax.
|
inline |
Definition at line 550 of file StatisticsVector.h.
References StatisticsVector< T >::walls.
|
inline |
Definition at line 334 of file StatisticsVector.h.
References StatisticsVector< T >::w2.
|
inline |
Definition at line 342 of file StatisticsVector.h.
References StatisticsVector< T >::cutoff.
|
inline |
Definition at line 350 of file StatisticsVector.h.
References StatisticsVector< T >::cutoff, and mathsFunc::square().
|
inline |
Definition at line 844 of file StatisticsVector.h.
References StatisticsVector< T >::doDoublePoints.
|
inline |
Definition at line 478 of file StatisticsVector.h.
References StatisticsVector< T >::doGradient.
|
inline |
Definition at line 510 of file StatisticsVector.h.
References StatisticsVector< T >::ignoreFixedParticles.
|
inline |
Definition at line 566 of file StatisticsVector.h.
References StatisticsVector< T >::periodicWalls.
|
inline |
Definition at line 400 of file StatisticsVector.h.
References StatisticsVector< T >::doTimeAverage.
|
inline |
Definition at line 461 of file StatisticsVector.h.
References StatisticsVector< T >::doVariance.
|
inline |
Definition at line 444 of file StatisticsVector.h.
References StatisticsVector< T >::mirrorAtDomainBoundary.
|
inline |
Definition at line 303 of file StatisticsVector.h.
References StatisticsVector< T >::nx, StatisticsVector< T >::ny, and StatisticsVector< T >::nz.
|
inline |
Definition at line 794 of file StatisticsVector.h.
References StatisticsVector< T >::nTimeAverage.
|
inline |
Definition at line 860 of file StatisticsVector.h.
References StatisticsVector< T >::nTimeAverageReset.
|
inline |
Definition at line 194 of file StatisticsVector.h.
References StatisticsVector< T >::nx.
|
inline |
Definition at line 202 of file StatisticsVector.h.
References StatisticsVector< T >::ny.
|
inline |
Definition at line 210 of file StatisticsVector.h.
References StatisticsVector< T >::nz.
|
inline |
Definition at line 828 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
|
inline |
|
inline |
Definition at line 417 of file StatisticsVector.h.
References StatisticsVector< T >::StressTypeForFixedParticles.
|
inline |
Definition at line 494 of file StatisticsVector.h.
References StatisticsVector< T >::superexact.
|
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().
|
protected |
|
inline |
Definition at line 534 of file StatisticsVector.h.
References StatisticsVector< T >::verbosity.
|
inline |
Definition at line 713 of file StatisticsVector.h.
References DPMBase::getXMax(), and StatisticsVector< T >::xMaxStat.
Referenced by StatisticsVector< T >::set_hx().
|
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().
|
inline |
Definition at line 724 of file StatisticsVector.h.
References DPMBase::getYMax(), and StatisticsVector< T >::yMaxStat.
Referenced by StatisticsVector< T >::set_hy().
|
inline |
Definition at line 691 of file StatisticsVector.h.
References DPMBase::getYMin(), and StatisticsVector< T >::yMinStat.
Referenced by StatisticsVector< T >::set_hy().
|
inline |
Definition at line 735 of file StatisticsVector.h.
References DPMBase::getZMax(), and StatisticsVector< T >::zMaxStat.
Referenced by StatisticsVector< T >::set_hz().
|
inline |
Definition at line 702 of file StatisticsVector.h.
References DPMBase::getZMin(), and StatisticsVector< T >::zMinStat.
Referenced by StatisticsVector< T >::set_hz().
|
virtual |
Initializes statistics, i.e. setting w2, setting the grid and writing the header lines in the .stat file.
Reimplemented from DPMBase.
void StatisticsVector< T >::jump_fstat | ( | ) |
void StatisticsVector< T >::jump_p3c | ( | ) |
|
protected |
|
protected |
|
virtual |
Calculates statistics for Particles (i.e. not collisions)
Reimplemented from DPMBase.
std::string StatisticsVector< T >::print_CG | ( | ) |
Output coarse graining variables.
void StatisticsVector< T >::print_help | ( | ) |
std::string StatisticsVector< T >::prIntStat | ( | ) |
Outputs member variable values to a std::string.
|
virtual |
Processes all gathered statistics and resets them afterwards. (Processing means either calculating time averages or writing out statistics)
Reimplemented from DPMBase.
|
protected |
bool StatisticsVector< T >::readNextDataFile | ( | unsigned int | format | ) |
void StatisticsVector< T >::readStatArguments | ( | int | argc, |
char * | argv[] | ||
) |
|
virtual |
Set all statistical variables to zero.
|
protected |
|
inline |
Definition at line 184 of file StatisticsVector.h.
References StatisticsVector< T >::set_hx(), StatisticsVector< T >::set_hy(), and StatisticsVector< T >::set_hz().
|
inline |
Definition at line 884 of file StatisticsVector.h.
References StatisticsVector< T >::hmax.
|
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().
|
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().
|
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().
|
inline |
Definition at line 427 of file StatisticsVector.h.
References StatisticsVector< T >::StressTypeForFixedParticles.
|
inline |
Definition at line 804 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
|
inline |
Definition at line 812 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
|
inline |
Definition at line 876 of file StatisticsVector.h.
References StatisticsVector< T >::rmax.
|
inline |
Definition at line 868 of file StatisticsVector.h.
References StatisticsVector< T >::rmin.
void StatisticsVector< T >::set_statType | ( | ) |
void StatisticsVector< T >::setCGShape | ( | const char * | new_ | ) |
void StatisticsVector< T >::setCGShape | ( | CG | new_ | ) |
|
inline |
Definition at line 234 of file StatisticsVector.h.
References StatisticsVector< T >::tIntStat.
|
inline |
Definition at line 218 of file StatisticsVector.h.
References StatisticsVector< T >::tMinStat.
|
inline |
Set CG variables w2 and CG_invvolume.
Definition at line 312 of file StatisticsVector.h.
References StatisticsVector< T >::setCGWidth2(), and mathsFunc::square().
void StatisticsVector< T >::setCGWidth2 | ( | Mdouble | new_ | ) |
Set CG variables w2 and CG_invvolume.
Referenced by StatisticsVector< T >::setCGWidth().
|
inline |
Definition at line 575 of file StatisticsVector.h.
References StatisticsVector< T >::w_over_rmax.
|
inline |
Definition at line 542 of file StatisticsVector.h.
References StatisticsVector< T >::walls.
|
inline |
Definition at line 836 of file StatisticsVector.h.
References StatisticsVector< T >::doDoublePoints.
|
inline |
Definition at line 470 of file StatisticsVector.h.
References StatisticsVector< T >::doGradient.
|
inline |
Definition at line 502 of file StatisticsVector.h.
References StatisticsVector< T >::ignoreFixedParticles.
|
inline |
Definition at line 558 of file StatisticsVector.h.
References StatisticsVector< T >::periodicWalls.
Referenced by Statistics().
|
inline |
Definition at line 392 of file StatisticsVector.h.
References StatisticsVector< T >::doTimeAverage.
|
inline |
Definition at line 453 of file StatisticsVector.h.
References StatisticsVector< T >::doVariance.
|
inline |
Definition at line 932 of file StatisticsVector.h.
References StatisticsVector< T >::indSpecies.
Mdouble StatisticsVector< T >::setInfinitelyLongDistance | ( | ) |
|
inline |
Definition at line 436 of file StatisticsVector.h.
References StatisticsVector< T >::mirrorAtDomainBoundary.
|
inline |
Definition at line 174 of file StatisticsVector.h.
References StatisticsVector< T >::setNX(), StatisticsVector< T >::setNY(), and StatisticsVector< T >::setNZ().
|
inline |
Definition at line 296 of file StatisticsVector.h.
References StatisticsVector< T >::nx, StatisticsVector< T >::ny, and StatisticsVector< T >::nz.
|
inline |
Definition at line 852 of file StatisticsVector.h.
References StatisticsVector< T >::nTimeAverageReset.
|
inline |
Definition at line 124 of file StatisticsVector.h.
References StatisticsVector< T >::nx.
Referenced by StatisticsVector< T >::set_hx(), and StatisticsVector< T >::setN().
|
inline |
Definition at line 140 of file StatisticsVector.h.
References StatisticsVector< T >::ny.
Referenced by StatisticsVector< T >::set_hy(), and StatisticsVector< T >::setN().
|
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().
|
inline |
Definition at line 820 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
void StatisticsVector< T >::setPositions | ( | ) |
Set position of StatisticsPoint points and set variables to 0.
|
inline |
|
inline |
Definition at line 409 of file StatisticsVector.h.
References StatisticsVector< T >::StressTypeForFixedParticles.
|
inline |
Definition at line 486 of file StatisticsVector.h.
References StatisticsVector< T >::superexact.
|
inline |
Definition at line 226 of file StatisticsVector.h.
References StatisticsVector< T >::tMaxStat.
|
inline |
Definition at line 526 of file StatisticsVector.h.
References StatisticsVector< T >::verbosity.
|
inline |
|
inline |
Definition at line 746 of file StatisticsVector.h.
References StatisticsVector< T >::xMinStat.
|
inline |
|
inline |
|
inline |
|
inline |
void StatisticsVector< T >::statistics_from_fstat_and_data | ( | ) |
get StatisticsPoint
Referenced by Statistics().
void StatisticsVector< T >::statistics_from_p3 | ( | ) |
|
inline |
Definition at line 518 of file StatisticsVector.h.
References StatisticsVector< T >::verbosity.
void StatisticsVector< T >::write_statistics | ( | ) |
Writes regular statistics.
void StatisticsVector< T >::write_time_average_statistics | ( | ) |
Writes out time averaged statistics.
|
virtual |
Writes the simulation data onto all the files i.e. .data, .ene, .fstat ...
Reimplemented from DPMBase.
|
protected |
coarse graining type (Gaussian, Heaviside, Polynomial)
Definition at line 1032 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getCGShape().
|
protected |
Stores the Polynomial, if the cg function is an axisymmetric function Polynomial in r.
Definition at line 1036 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::evaluateIntegral(), StatisticsVector< T >::evaluatePolynomial(), StatisticsVector< T >::evaluatePolynomialGradient(), StatisticsVector< T >::getPolynomialName(), StatisticsVector< T >::set_Polynomial(), and StatisticsVector< T >::setPolynomialName().
|
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 1049 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getCutoff(), and StatisticsVector< T >::getCutoff2().
|
protected |
Definition at line 1049 of file StatisticsVector.h.
|
protected |
Definition at line 1138 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getDoDoublePoints(), and StatisticsVector< T >::setDoDoublePoints().
|
protected |
Determines if gradient is outputted.
Definition at line 1021 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getDoGradient(), and StatisticsVector< T >::setDoGradient().
|
protected |
Determines if output is averaged over time.
Definition at line 1006 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getDoTimeAverage(), and StatisticsVector< T >::setDoTimeAverage().
|
protected |
Determines if variance is outputted.
Definition at line 1016 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getDoVariance(), and StatisticsVector< T >::setDoVariance().
|
protected |
A vector that stores the gradient in x of all statistical variables at a given position.
Definition at line 967 of file StatisticsVector.h.
|
protected |
a vector used to sum up all statistical gradients in dx for time-averaging
Definition at line 991 of file StatisticsVector.h.
|
protected |
A vector that stores the gradient in y of all statistical variables at a given position.
Definition at line 971 of file StatisticsVector.h.
|
protected |
a vector used to sum up all statistical gradients in dy for time-averaging
Definition at line 996 of file StatisticsVector.h.
|
protected |
A vector that stores the gradient in z of all statistical variables at a given position.
Definition at line 975 of file StatisticsVector.h.
|
protected |
a vector used to sum up all statistical gradients in dz for time-averaging
Definition at line 1001 of file StatisticsVector.h.
|
protected |
format of the data input file
Definition at line 1127 of file StatisticsVector.h.
|
protected |
defines the maximum height of the particles for which statistics are extracted
Definition at line 1092 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::set_hmax().
|
protected |
Determines if fixed particles contribute to particle statistics (density, ...)
Definition at line 1108 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getDoIgnoreFixedParticles(), and StatisticsVector< T >::setDoIgnoreFixedParticles().
|
protected |
defines the species for which statistics are extracted (-1 for all species)
Definition at line 1076 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::setIndSpecies().
|
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 1132 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getMirrorAtDomainBoundary(), and StatisticsVector< T >::setMirrorAtDomainBoundary().
|
protected |
A counter needed to average over time.
Definition at line 1026 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getNTimeAverage().
|
protected |
Determines after how many timesteps the time average is reset.
Definition at line 1011 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getNTimeAverageReset(), and StatisticsVector< T >::setNTimeAverageReset().
|
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 947 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getN(), StatisticsVector< T >::getNX(), StatisticsVector< T >::setN(), and StatisticsVector< T >::setNX().
|
protected |
extension of grid size from mirrored points
Definition at line 957 of file StatisticsVector.h.
|
protected |
see nx
Definition at line 948 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getN(), StatisticsVector< T >::getNY(), StatisticsVector< T >::setN(), and StatisticsVector< T >::setNY().
|
protected |
Definition at line 957 of file StatisticsVector.h.
|
protected |
see nx
Definition at line 949 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getN(), StatisticsVector< T >::getNZ(), StatisticsVector< T >::setN(), and StatisticsVector< T >::setNZ().
|
protected |
Definition at line 957 of file StatisticsVector.h.
|
protected |
Position of first contact point.
Definition at line 1147 of file StatisticsVector.h.
|
protected |
not yet working
Definition at line 1169 of file StatisticsVector.h.
|
protected |
Definition at line 1159 of file StatisticsVector.h.
|
protected |
Definition at line 1157 of file StatisticsVector.h.
|
protected |
not yet working
Definition at line 1171 of file StatisticsVector.h.
|
protected |
Length of contact line.
Definition at line 1153 of file StatisticsVector.h.
|
protected |
Fabric.
Definition at line 1167 of file StatisticsVector.h.
|
protected |
Direction of contact.
Definition at line 1151 of file StatisticsVector.h.
|
protected |
Contact stress from normal forces along the line of contact.
Definition at line 1155 of file StatisticsVector.h.
|
protected |
Traction from normal forces at contact of flow with fixed particles or walls.
Definition at line 1163 of file StatisticsVector.h.
|
protected |
not yet working
Definition at line 1173 of file StatisticsVector.h.
|
protected |
Contact stress from tangential forces along the line of contact.
Definition at line 1161 of file StatisticsVector.h.
|
protected |
Traction from tangential forces at contact of flow with fixed particles or walls.
Definition at line 1165 of file StatisticsVector.h.
|
protected |
Position of second contact point.
Definition at line 1149 of file StatisticsVector.h.
|
protected |
Definition at line 1202 of file StatisticsVector.h.
|
protected |
Definition at line 1201 of file StatisticsVector.h.
|
protected |
Definition at line 1203 of file StatisticsVector.h.
|
protected |
Turns off periodic walls before evaluation (needed for averaging, because we do not yet check if particle is in domain)
Definition at line 1103 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getDoPeriodicWalls(), and StatisticsVector< T >::setDoPeriodicWalls().
|
protected |
A vector that stores the values of the statistical variables at a given position.
Definition at line 963 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getCGPoints().
|
protected |
Definition at line 1217 of file StatisticsVector.h.
|
protected |
defines the maximum radius of the particles for which statistics are extracted
Definition at line 1087 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::set_rmax().
|
protected |
defines the minimum radius of the particles for which statistics are extracted
Definition at line 1082 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::set_rmin().
|
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 943 of file StatisticsVector.h.
|
protected |
Definition at line 1215 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getStepSize(), and StatisticsVector< T >::setStepSize().
|
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 1117 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getStressTypeForFixedParticles(), StatisticsVector< T >::set_infiniteStressForFixedParticles(), and StatisticsVector< T >::setStressTypeForFixedParticles().
|
protected |
If true, cutoff radius for Gaussian is set to 5*w (from 3*w)
Definition at line 1135 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getSuperExact(), and StatisticsVector< T >::setSuperExact().
|
protected |
A vector used to sum up all statistical values in Points for time-averaging.
Definition at line 981 of file StatisticsVector.h.
|
protected |
a vector used to sum up the variance in time of all statistical values
Definition at line 986 of file StatisticsVector.h.
|
protected |
Statistical output will only be created if tMaxStat-tIntStat< t< tMaxStat.
Definition at line 1071 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getCGTimeAveragingInterval(), and StatisticsVector< T >::setCGTimeAveragingInterval().
|
protected |
Statistical output will only be created if t<tMaxStat.
Definition at line 1066 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getTimeMaxStat(), and StatisticsVector< T >::setTimeMaxStat().
|
protected |
Statistical output will only be created if t>tMinStat.
Definition at line 1061 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getCGTimeMin(), and StatisticsVector< T >::setCGTimeMin().
|
protected |
Definition at line 1189 of file StatisticsVector.h.
|
protected |
Definition at line 1199 of file StatisticsVector.h.
|
protected |
Definition at line 1194 of file StatisticsVector.h.
|
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 1125 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getVerbosityLevel(), StatisticsVector< T >::setVerbosityLevel(), and StatisticsVector< T >::verbose().
|
protected |
coarse graining width squared; for HeavisideSphere and Gaussian
Definition at line 1044 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getCGWidth(), and StatisticsVector< T >::getCGWidthSquared().
|
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 1054 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getCGWidth_over_rmax(), and StatisticsVector< T >::setCGWidth_over_rmax().
|
protected |
Turns off walls before evaluation.
Definition at line 1097 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getCGWidthalls(), and StatisticsVector< T >::setCGWidthalls().
|
protected |
Definition at line 953 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getXMaxStat(), and StatisticsVector< T >::setXMaxStat().
|
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 953 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getXMinStat(), and StatisticsVector< T >::setXMinStat().
|
protected |
Definition at line 953 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getYMaxStat(), and StatisticsVector< T >::setYMaxStat().
|
protected |
Definition at line 953 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getYMinStat(), and StatisticsVector< T >::setYMinStat().
|
protected |
Definition at line 953 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getZMaxStat(), and StatisticsVector< T >::setZMaxStat().
|
protected |
Definition at line 953 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::getZMinStat(), and StatisticsVector< T >::setZMinStat().